From f07f0fb605129f5536480607bf42c0b4e26f39e6 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Wed, 11 Feb 2015 20:46:17 +0000 Subject: [PATCH 001/211] Hidden switch for unscaled output in polysomy --- polysomy.c | 21 ++++++++++++++++----- 1 file changed, 16 insertions(+), 5 deletions(-) diff --git a/polysomy.c b/polysomy.c index e5a94dca1..3c9743164 100644 --- a/polysomy.c +++ b/polysomy.c @@ -59,7 +59,7 @@ dist_t; typedef struct { - int ndist, nbins; + int ndist, nbins, ra_rr_scaling; double *xvals; dist_t *dist; char **argv, *output_dir; @@ -72,7 +72,7 @@ args_t; FILE *open_file(char **fname, const char *mode, const char *fmt, ...); -static void init_dist(dist_t *dist, int verbose) +static void init_dist(args_t *args, dist_t *dist, int verbose) { // isolate RR and AA peaks and rescale so that they are comparable to hets int i, irr, iaa, n = dist->nvals; @@ -123,6 +123,7 @@ static void init_dist(dist_t *dist, int verbose) // Y: cn=0 ra/rr=0.008316 aa/ra=7.250000 nra=12 // MT: cn=0 ra/rr=0.013699 aa/ra=0.666667 nra=3 + if ( !args->ra_rr_scaling ) max_ra = max_aa = max_rr; if ( !sra || (sra/srr<0.1 && saa/sra>1.0) ) { max_ra = max_aa; @@ -208,7 +209,7 @@ static void init_data(args_t *args) bcf_sr_destroy(files); for (idist=0; idistndist; idist++) - init_dist(&args->dist[idist],args->verbose); + init_dist(args, &args->dist[idist],args->verbose); args->dat_fp = open_file(&args->dat_fname,"w","%s/dist.dat", args->output_dir); fprintf(args->dat_fp, "# This file was produced by: bcftools polysomy(%s+htslib-%s), the command line was:\n", bcftools_version(),hts_version()); @@ -293,13 +294,18 @@ static void init_data(args_t *args) " plt.savefig(outdir+'/copy-number.png')\n" " plt.close()\n" "\n" + "class myParser(argparse.ArgumentParser):\n" + " def error(self, message):\n" + " self.print_help()\n" + " sys.stderr.write('error: %%s\\n' %% message)\n" + " sys.exit(2)\n" + "\n" "def main():\n" - " parser = argparse.ArgumentParser()\n" + " parser = myParser()\n" " parser.add_argument('-a', '--all', action='store_true', help='Create all plots')\n" " parser.add_argument('-c', '--copy-number', action='store_true', help='Create copy-number plot')\n" " parser.add_argument('-d', '--distrib', metavar='CHR', help='Plot BAF distribution of a single chromosome')\n" " args = parser.parse_args()\n" - " if args.distrib==None and not args.all and not args.copy_number: parser.print_help()\n" " dat = {}; fit = {}; cn = {}\n" " read_dat(dat,fit,cn)\n" " if args.distrib!=None:\n" @@ -309,6 +315,8 @@ static void init_data(args_t *args) " plot_copy_number(cn)\n" " elif args.copy_number:\n" " plot_copy_number(cn)\n" + " else:\n" + " for chr in dat: plot_dist(dat,fit,chr)\n" "\n" "if __name__ == '__main__':\n" " main()\n", @@ -611,9 +619,11 @@ int main_polysomy(int argc, char *argv[]) args->fit_th = 3.0; args->cn_penalty = 0.7; args->peak_symmetry = 0.7; + args->ra_rr_scaling = 1; static struct option loptions[] = { + {"ra-rr-scaling",0,0,1}, // hidden option {"verbose",0,0,'v'}, {"fit-th",1,0,'f'}, {"cn-penalty",1,0,'c'}, @@ -631,6 +641,7 @@ int main_polysomy(int argc, char *argv[]) { switch (c) { + case 1 : args->ra_rr_scaling = 0; break; case 'f': args->fit_th = strtod(optarg,&tmp); if ( *tmp ) error("Could not parse: -f %s\n", optarg); From 278cb3397e69cd922f2b2285240636802634818c Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Thu, 12 Mar 2015 13:30:10 +0000 Subject: [PATCH 002/211] polysomy: new options, large rewrites at mostly unchanged performance - rewritten for greater experimental flexibility - the AA peak can be included in the fit (the -i option) - the minimum fraction of aberrant cells as a command line parameter (-m) - control the minimum cn4 bump size (-b) --- Makefile | 2 +- peakfit.c | 595 +++++++++++++++++++++++++++++++++++++++++++++++++++++ peakfit.h | 49 +++++ polysomy.c | 512 ++++++++++++++++++++++----------------------- 4 files changed, 887 insertions(+), 271 deletions(-) create mode 100644 peakfit.c create mode 100644 peakfit.h diff --git a/Makefile b/Makefile index 3cf92a21e..92139048f 100644 --- a/Makefile +++ b/Makefile @@ -56,7 +56,7 @@ GSL_LIBS = # and LICENSE documents to understand license implications. ifdef USE_GPL EXTRA_CPPFLAGS += -DUSE_GPL - OBJS += polysomy.o + OBJS += polysomy.o peakfit.o GSL_LIBS = -lgsl -lcblas endif diff --git a/peakfit.c b/peakfit.c new file mode 100644 index 000000000..93f1acd60 --- /dev/null +++ b/peakfit.c @@ -0,0 +1,595 @@ +/* The MIT License + + Copyright (c) 2013-2014 Genome Research Ltd. + + Author: Petr Danecek + + Permission is hereby granted, free of charge, to any person obtaining a copy + of this software and associated documentation files (the "Software"), to deal + in the Software without restriction, including without limitation the rights + to use, copy, modify, merge, publish, distribute, sublicense, and/or sell + copies of the Software, and to permit persons to whom the Software is + furnished to do so, subject to the following conditions: + + The above copyright notice and this permission notice shall be included in + all copies or substantial portions of the Software. + + THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS OR + IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF MERCHANTABILITY, + FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. IN NO EVENT SHALL THE + AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY CLAIM, DAMAGES OR OTHER + LIABILITY, WHETHER IN AN ACTION OF CONTRACT, TORT OR OTHERWISE, ARISING FROM, + OUT OF OR IN CONNECTION WITH THE SOFTWARE OR THE USE OR OTHER DEALINGS IN + THE SOFTWARE. + + */ + +#include "peakfit.h" +#include +#include +#include +#include +#include +#include +#include + +#define NPARAMS 5 + +// gauss params: sqrt(scale), center, sigma +typedef struct _peak_t +{ + int fit_mask; + double params[NPARAMS], ori_params[NPARAMS]; // current and input parameters + struct { int scan; double min, max, best; } mc[NPARAMS]; // monte-carlo settings and best parameter + void (*calc_f) (int nvals, double *xvals, double *yvals, void *args); + void (*calc_df) (int nvals, double *xvals, double *yvals, double *dfvals, int idf, void *args); + void (*print_func) (struct _peak_t *pk, kstring_t *str); + void (*convert_get) (struct _peak_t *pk, double *params); + double (*convert_set) (struct _peak_t *pk, int iparam, double value); +} +peak_t; + +struct _peakfit_t +{ + int npeaks, mpeaks, nparams, mparams; + peak_t *peaks; + double *params; + int nvals, mvals; + double *xvals, *yvals, *vals; + kstring_t str; + int verbose, nmc_iter; +}; + + +/* + Gaussian peak with the center bound in the interval : + yi = scale^2 * exp(-(xi-z)^2/sigma^2) + + dy/dscale = 2*scale * EXP + dy/dcenter = -scale^2 * sin(center) * (e-d) * (xi - z) * EXP / sigma^2 + dy/dsigma = 2*scale^2 * (xi - z)^2 * EXP / sigma^3 + + where + z = 0.5*(cos(center)+1)*(e-d) + d + EXP = exp(-(xi-z)^2/sigma^2) +*/ +void bounded_gaussian_calc_f(int nvals, double *xvals, double *yvals, void *args) +{ + peak_t *pk = (peak_t*) args; + + double scale2 = pk->params[0] * pk->params[0]; + double center = pk->params[1]; + double sigma = pk->params[2]; + double d = pk->params[3]; + double e = pk->params[4]; + double z = 0.5*(cos(center)+1)*(e-d) + d; + + int i; + for (i=0; iparams[0]; + double center = pk->params[1]; + double sigma = pk->params[2]; + double d = pk->params[3]; + double e = pk->params[4]; + double z = 0.5*(cos(center)+1)*(e-d) + d; + + int i; + for (i=0; iparams[1]; + double d = pk->params[3]; + double e = pk->params[4]; + double z = 0.5*(cos(center)+1)*(e-d) + d; + ksprintf(str,"%f**2 * exp(-(x-%f)**2/%f**2)",fabs(pk->params[0]),z,fabs(pk->params[2])); +} +double bounded_gaussian_convert_set(peak_t *pk, int iparam, double value) +{ + if ( iparam!=1 ) return value; + double d = pk->ori_params[3]; + double e = pk->ori_params[4]; + if ( valuee ) value = e; + return acos(2*(value-d)/(e-d) - 1); +} +void bounded_gaussian_convert_get(peak_t *pk, double *params) +{ + params[0] = fabs(params[0]); + params[2] = fabs(params[2]); + double b = params[1]; + double d = params[3]; + double e = params[4]; + params[1] = 0.5*(cos(b)+1)*(e-d) + d; +} + +void peakfit_add_bounded_gaussian(peakfit_t *pkf, double a, double b, double c, double d, double e, int fit_mask) +{ + pkf->npeaks++; + hts_expand0(peak_t,pkf->npeaks,pkf->mpeaks,pkf->peaks); + + int i, nfit = 0; + for (i=0; inparams += nfit; + hts_expand0(double,pkf->nparams,pkf->mparams,pkf->params); + + peak_t *pk = &pkf->peaks[pkf->npeaks-1]; + memset(pk, 0, sizeof(peak_t)); + + pk->calc_f = bounded_gaussian_calc_f; + pk->calc_df = bounded_gaussian_calc_df; + pk->print_func = bounded_gaussian_sprint_func; + pk->convert_set = bounded_gaussian_convert_set; + pk->convert_get = bounded_gaussian_convert_get; + pk->fit_mask = fit_mask; + pk->ori_params[0] = a; + pk->ori_params[2] = c; + pk->ori_params[3] = d; + pk->ori_params[4] = e; + pk->ori_params[1] = pk->convert_set(pk, 1, b); +} + + +/* + Gaussian peak: + yi = scale^2 * exp(-(x-center)^2/sigma^2) + + dy/dscale = 2 * scale * EXP + dy/dcenter = 2 * scale^2 * (x-center) * EXP / sigma^2 + dy/dsigma = 2 * scale^2 * (x-center)^2 * EXP / sigma^3 + + where + EXP = exp(-(x-center)^2/sigma^2) +*/ +void gaussian_calc_f(int nvals, double *xvals, double *yvals, void *args) +{ + peak_t *pk = (peak_t*) args; + + double scale2 = pk->params[0] * pk->params[0]; + double center = pk->params[1]; + double sigma = pk->params[2]; + + int i; + for (i=0; iparams[0]; + double center = pk->params[1]; + double sigma = pk->params[2]; + + int i; + for (i=0; iparams[0]),pk->params[1],fabs(pk->params[2])); +} +void gaussian_convert_get(peak_t *pk, double *params) +{ + params[0] = fabs(params[0]); + params[2] = fabs(params[2]); +} + + +void peakfit_add_gaussian(peakfit_t *pkf, double a, double b, double c, int fit_mask) +{ + pkf->npeaks++; + hts_expand0(peak_t,pkf->npeaks,pkf->mpeaks,pkf->peaks); + + int i, nfit = 0; + for (i=0; inparams += nfit; + hts_expand0(double,pkf->nparams,pkf->mparams,pkf->params); + + peak_t *pk = &pkf->peaks[pkf->npeaks-1]; + memset(pk, 0, sizeof(peak_t)); + + pk->calc_f = gaussian_calc_f; + pk->calc_df = gaussian_calc_df; + pk->print_func = gaussian_sprint_func; + pk->convert_get = gaussian_convert_get; + pk->fit_mask = fit_mask; + pk->ori_params[0] = a; + pk->ori_params[1] = b; + pk->ori_params[2] = c; +} + + +/* + exp peak: + yi = scale^2 * exp((x-center)/sigma^2) + + dy/dscale = 2 * scale * EXP + dy/dcenter = -scale^2 * EXP / sigma^2 + dy/dsigma = -2 * scale^2 * (x-center) * EXP / sigma^3 + + where + EXP = exp((x-center)/sigma^2) +*/ +void exp_calc_f(int nvals, double *xvals, double *yvals, void *args) +{ + peak_t *pk = (peak_t*) args; + + double scale2 = pk->params[0] * pk->params[0]; + double center = pk->params[1]; + double sigma = pk->params[2]; + + int i; + for (i=0; iparams[0]; + double center = pk->params[1]; + double sigma = pk->params[2]; + + int i; + for (i=0; iparams[0]),pk->params[1],fabs(pk->params[2])); +} +void exp_convert_get(peak_t *pk, double *params) +{ + params[0] = fabs(params[0]); + params[1] = fabs(params[1]); + params[2] = fabs(params[2]); +} + +void peakfit_add_exp(peakfit_t *pkf, double a, double b, double c, int fit_mask) +{ + pkf->npeaks++; + hts_expand0(peak_t,pkf->npeaks,pkf->mpeaks,pkf->peaks); + + int i, nfit = 0; + for (i=0; inparams += nfit; + hts_expand0(double,pkf->nparams,pkf->mparams,pkf->params); + + peak_t *pk = &pkf->peaks[pkf->npeaks-1]; + memset(pk, 0, sizeof(peak_t)); + + pk->calc_f = exp_calc_f; + pk->calc_df = exp_calc_df; + pk->print_func = exp_sprint_func; + pk->convert_get = exp_convert_get; + pk->fit_mask = fit_mask; + pk->ori_params[0] = a; + pk->ori_params[1] = b; + pk->ori_params[2] = c; +} + + +void peakfit_set_params(peakfit_t *pkf, int ipk, double *params, int nparams) +{ + peak_t *pk = &pkf->peaks[ipk]; + int i; + if ( pk->convert_set ) + for (i=0; iparams[i] = pk->convert_set(pk, i, params[i]); + else + for (i=0; iparams[i] = params[i]; +} + +void peakfit_get_params(peakfit_t *pkf, int ipk, double *params, int nparams) +{ + peak_t *pk = &pkf->peaks[ipk]; + int i; + for (i=0; iparams[i]; + if ( pk->convert_get ) pk->convert_get(pk, params); +} + +peakfit_t *peakfit_init(void) +{ + return (peakfit_t*)calloc(1,sizeof(peakfit_t)); +} + +void peakfit_reset(peakfit_t *pkf) +{ + pkf->npeaks = pkf->nparams = 0; + memset(pkf->peaks,0,sizeof(peak_t)*pkf->mpeaks); +} + +void peakfit_destroy(peakfit_t *pkf) +{ + free(pkf->str.s); + free(pkf->vals); + free(pkf->params); + free(pkf->peaks); + free(pkf); +} + +int peakfit_calc_f(const gsl_vector *params, void *data, gsl_vector *yvals) +{ + peakfit_t *pkf = (peakfit_t *) data; + + int i,j; + for (i=0; invals; i++) + pkf->vals[i] = 0; + + int iparam = 0; + for (i=0; inpeaks; i++) + { + peak_t *pk = &pkf->peaks[i]; + for (j=0; jfit_mask & (1<params[j] = gsl_vector_get(params,iparam); + iparam++; + } + pk->calc_f(pkf->nvals, pkf->xvals, pkf->vals, pk); + } + + for (i=0; invals; i++) + gsl_vector_set(yvals, i, (pkf->vals[i] - pkf->yvals[i])/0.01); + + return GSL_SUCCESS; +} +int peakfit_calc_df(const gsl_vector *params, void *data, gsl_matrix *jacobian) +{ + peakfit_t *pkf = (peakfit_t *) data; + + int i,j,k,iparam = 0; + for (i=0; inpeaks; i++) + { + peak_t *pk = &pkf->peaks[i]; + int iparam_prev = iparam; + for (j=0; jfit_mask & (1<params[j] = gsl_vector_get(params,iparam); + iparam++; + } + iparam = iparam_prev; + for (j=0; jfit_mask & (1<nvals; k++) pkf->vals[k] = 0; + pk->calc_df(pkf->nvals, pkf->xvals, pkf->yvals, pkf->vals, j, pk); + for (k=0; knvals; k++) gsl_matrix_set(jacobian, k, iparam, pkf->vals[k]); + iparam++; + } + } + return GSL_SUCCESS; +} +int peakfit_calc_fdf(const gsl_vector *params, void *data, gsl_vector *yvals, gsl_matrix *jacobian) +{ + peakfit_calc_f(params, data, yvals); + peakfit_calc_df(params, data, jacobian); + return GSL_SUCCESS; +} + +double peakfit_evaluate(peakfit_t *pkf) +{ + int i; + for (i=0; invals; i++) + pkf->vals[i] = 0; + + for (i=0; inpeaks; i++) + pkf->peaks[i].calc_f(pkf->nvals, pkf->xvals, pkf->vals, &pkf->peaks[i]); + + double sum = 0; + for (i=0; invals; i++) + sum += fabs(pkf->vals[i] - pkf->yvals[i]); + + return sum; +} + +const char *peakfit_sprint_func(peakfit_t *pkf) +{ + pkf->str.l = 0; + int i; + for (i=0; inpeaks; i++) + { + if ( i>0 ) kputs(" + ", &pkf->str); + pkf->peaks[i].print_func(&pkf->peaks[i], &pkf->str); + } + return (const char*)pkf->str.s; +} + +void peakfit_verbose(peakfit_t *pkf, int level) +{ + pkf->verbose = level; +} + +void peakfit_set_mc(peakfit_t *pkf, double xmin, double xmax, int iparam, int niter) +{ + peak_t *pk = &pkf->peaks[ pkf->npeaks-1 ]; + pk->mc[iparam].scan = 1; + pk->mc[iparam].min = xmin; + pk->mc[iparam].max = xmax; + pkf->nmc_iter = niter; +} + +double peakfit_run(peakfit_t *pkf, int nvals, double *xvals, double *yvals) +{ + srand(0); // for reproducibility + + pkf->nvals = nvals; + pkf->xvals = xvals; + pkf->yvals = yvals; + hts_expand0(double,pkf->nvals,pkf->mvals,pkf->vals); + if ( !pkf->nparams ) return peakfit_evaluate(pkf); + + gsl_multifit_function_fdf mfunc; + mfunc.f = &peakfit_calc_f; + mfunc.df = &peakfit_calc_df; + mfunc.fdf = &peakfit_calc_fdf; + mfunc.n = nvals; + mfunc.p = pkf->nparams; + mfunc.params = pkf; + + const gsl_multifit_fdfsolver_type *solver_type; + gsl_multifit_fdfsolver *solver; + solver_type = gsl_multifit_fdfsolver_lmsder; + solver = gsl_multifit_fdfsolver_alloc(solver_type, nvals, mfunc.p); + gsl_vector *grad = gsl_vector_alloc(pkf->nparams); + + int imc_iter, i,j, iparam; + double best_fit = HUGE_VAL; + for (imc_iter=0; imc_iter<=pkf->nmc_iter; imc_iter++) // possibly multiple monte-carlo iterations + { + // set GSL parameters + iparam = 0; + for (i=0; inpeaks; i++) + { + peak_t *pk = &pkf->peaks[i]; + for (j=0; jparams[j] = pk->ori_params[j]; + if ( pk->mc[j].scan ) + { + pk->params[j] = rand()*(pk->mc[j].max - pk->mc[j].min)/RAND_MAX + pk->mc[j].min; + if ( pk->convert_set ) pk->params[j] = pk->convert_set(pk, j, pk->params[j]); + } + if ( !(pk->fit_mask & (1<params[iparam] = pk->params[j]; + iparam++; + } + } + + gsl_vector_view vview = gsl_vector_view_array(pkf->params, mfunc.p); + gsl_multifit_fdfsolver_set(solver, &mfunc, &vview.vector); + + // iterate until convergence (or lack of it) + int ret, test1 = 0, test2 = 0, niter = 0, niter_max = 500; + do + { + ret = gsl_multifit_fdfsolver_iterate(solver); + if ( pkf->verbose >1 ) + { + fprintf(stderr, "%d: ", niter); + for (i=0; inpeaks; i++) + { + peak_t *pk = &pkf->peaks[i]; + fprintf(stderr,"\t%f %f %f", pk->params[0],pk->params[1],pk->params[2]); + } + fprintf(stderr, "\t.. %s\n", gsl_strerror(ret)); + } + if ( ret ) break; + + gsl_multifit_gradient(solver->J, solver->f, grad); + test1 = gsl_multifit_test_gradient(grad, 1e-8); + test2 = gsl_multifit_test_delta(solver->dx, solver->x, 1e-8, 1e-8); + } + while ((test1==GSL_CONTINUE || test2==GSL_CONTINUE) && ++niterverbose >1 ) + { + fprintf(stderr,"test1=%s\n", gsl_strerror(test1)); + fprintf(stderr,"test2=%s\n", gsl_strerror(test2)); + } + + // recover parameters + iparam = 0; + for (i=0; inpeaks; i++) + { + peak_t *pk = &pkf->peaks[i]; + for (j=0; jfit_mask & (1<params[j] = gsl_vector_get(solver->x, iparam++); + } + } + + // evaluate fit, update best parameters + double fit = peakfit_evaluate(pkf); + if ( fitnpeaks; i++) + { + peak_t *pk = &pkf->peaks[i]; + for (j=0; jmc[j].best = pk->params[j]; + } + } + if ( fitnpeaks; i++) + { + peak_t *pk = &pkf->peaks[i]; + for (j=0; jparams[j] = pk->mc[j].best; + } + return best_fit; +} + + diff --git a/peakfit.h b/peakfit.h new file mode 100644 index 000000000..de497cd75 --- /dev/null +++ b/peakfit.h @@ -0,0 +1,49 @@ +/* The MIT License + + Copyright (c) 2013-2014 Genome Research Ltd. + + Author: Petr Danecek + + Permission is hereby granted, free of charge, to any person obtaining a copy + of this software and associated documentation files (the "Software"), to deal + in the Software without restriction, including without limitation the rights + to use, copy, modify, merge, publish, distribute, sublicense, and/or sell + copies of the Software, and to permit persons to whom the Software is + furnished to do so, subject to the following conditions: + + The above copyright notice and this permission notice shall be included in + all copies or substantial portions of the Software. + + THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS OR + IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF MERCHANTABILITY, + FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. IN NO EVENT SHALL THE + AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY CLAIM, DAMAGES OR OTHER + LIABILITY, WHETHER IN AN ACTION OF CONTRACT, TORT OR OTHERWISE, ARISING FROM, + OUT OF OR IN CONNECTION WITH THE SOFTWARE OR THE USE OR OTHER DEALINGS IN + THE SOFTWARE. + + */ + +#ifndef PEAKFIT_H +#define PEAKFIT_H + +typedef struct _peakfit_t peakfit_t; + +peakfit_t *peakfit_init(void); +void peakfit_reset(peakfit_t *pkf); +void peakfit_destroy(peakfit_t *pkf); + +void peakfit_add_gaussian(peakfit_t *pkf, double a, double b, double c, int fit_mask); +void peakfit_add_bounded_gaussian(peakfit_t *pkf, double a, double b, double c, double d, double e, int fit_mask); +void peakfit_add_exp(peakfit_t *pkf, double a, double b, double c, int fit_mask); +void peakfit_set_mc(peakfit_t *pkf, double xmin, double xmax, int iparam, int niter); +double peakfit_run(peakfit_t *pkf, int nvals, double *xvals, double *yvals); +double peakfit_evaluate(peakfit_t *pkf); + +void peakfit_verbose(peakfit_t *pkf, int level); +void peakfit_get_params(peakfit_t *pkf, int ipk, double *params, int nparams); +void peakfit_set_params(peakfit_t *pkf, int ipk, double *params, int nparams); +const char *peakfit_sprint_func(peakfit_t *pkf); + +#endif + diff --git a/polysomy.c b/polysomy.c index 3c9743164..2f06af07a 100644 --- a/polysomy.c +++ b/polysomy.c @@ -35,24 +35,15 @@ #include #include #include "bcftools.h" +#include "peakfit.h" typedef struct { - int nvals; // number of data points to fit against (excluding RR,AA peaks) - double *xvals; // xvalues, pointer to dist_t.xvals - double *yvals; // yvalues, pointer to dist_t.yvals - int ngauss; // number of gaussian functions -} -data_t; - -typedef struct -{ - data_t dat; int nvals; // all values, including RR,AA peaks double *xvals; // pointer to args_t.xvals double *yvals; int copy_number; // heuristics to skip futile CN1 fits when no het peak is detected - int irr, iaa; // chop off RR and AA peaks + int irr, ira, iaa; // chop off RR and AA peaks char *chr; } dist_t; @@ -63,8 +54,8 @@ typedef struct double *xvals; dist_t *dist; char **argv, *output_dir; - double fit_th, peak_symmetry, cn_penalty; - int argc, plot, verbose, regions_is_file, targets_is_file; + double fit_th, peak_symmetry, cn_penalty, bump_size, min_fraction; + int argc, plot, verbose, regions_is_file, targets_is_file, include_aa; char *dat_fname, *fname, *regions_list, *targets_list, *sample; FILE *dat_fp; } @@ -77,9 +68,9 @@ static void init_dist(args_t *args, dist_t *dist, int verbose) // isolate RR and AA peaks and rescale so that they are comparable to hets int i, irr, iaa, n = dist->nvals; - // smooth the distribution + // smooth the distribution, this is just to find the peaks double *tmp = (double*) malloc(sizeof(double)*n); - int win = 0.02*n < 1 ? 1 : 0.02*n; + int win = 0.04*n < 1 ? 1 : 0.04*n; double avg = 0; for (i=0; iyvals[i]; for (i=0; i=n/2; i--) if ( tmp[i] < tmp[iaa] ) iaa = i; irr += win*0.5; iaa += win*0.5; + if ( iaa>=n ) iaa = n-1; if ( irr>=iaa ) error("FIXME: oops, dist normalization failed for %s: %d vs %d\n", dist->chr,irr,iaa); // we may need to be smarter free(tmp); + // clean the data: the AA peak is occasionally not centered at 1.0 but is closer to the center, chop off + int imax_aa = iaa; + for (i=iaa; iyvals[imax_aa] < dist->yvals[i] ) imax_aa = i; + dist->nvals = imax_aa+1; + if ( iaa>=dist->nvals ) iaa = dist->nvals-1; + // find the maximum and scale the peaks (first draft: no attempt to join the segments smootly) double max_rr = 0, max_aa = 0, max_ra = 0, srr = 0, saa = 0, sra = 0; for (i=0; ira_rr_scaling ) max_ra = max_aa = max_rr; - if ( !sra || (sra/srr<0.1 && saa/sra>1.0) ) + if ( !sra || (sra/srr<0.1 && saa/sra>1.0) ) // too few hets, CN1 { max_ra = max_aa; dist->copy_number = 1; @@ -138,12 +137,14 @@ static void init_dist(args_t *args, dist_t *dist, int verbose) if ( max_ra ) for (i=irr; i<=iaa; i++) dist->yvals[i] /= max_ra; if ( max_aa ) for (i=iaa+1; iyvals[i] /= max_aa; - dist->dat.yvals = &dist->yvals[irr]; - dist->dat.xvals = &dist->xvals[irr]; - dist->dat.nvals = iaa - irr + 1; + dist->irr = irr; + dist->iaa = iaa; + dist->ira = n*0.5; if ( verbose ) - fprintf(stderr,"%s:\t cn=%2d \t ra/rr=%f \t aa/ra=%f \t nra=%d\n", dist->chr,dist->copy_number,sra/srr,saa/sra, (int)sra); + fprintf(stderr,"%s:\t irr,ira,iaa=%.2f,%.2f,%.2f \t cn=%2d \t ra/rr=%f \t aa/ra=%f \t nra=%d\n", + dist->chr, dist->xvals[irr],dist->xvals[dist->ira],dist->xvals[iaa], + dist->copy_number,sra/srr,saa/sra, (int)sra); } static void init_data(args_t *args) @@ -209,7 +210,17 @@ static void init_data(args_t *args) bcf_sr_destroy(files); for (idist=0; idistndist; idist++) + { + #if 0 + int j; + for (j=0; jnbins; j++) + { + double x = args->dist[idist].xvals[j]; + args->dist[idist].yvals[j] = exp(-(x-0.5)*(x-0.5)/1e-3); + } + #endif init_dist(args, &args->dist[idist],args->verbose); + } args->dat_fp = open_file(&args->dat_fname,"w","%s/dist.dat", args->output_dir); fprintf(args->dat_fp, "# This file was produced by: bcftools polysomy(%s+htslib-%s), the command line was:\n", bcftools_version(),hts_version()); @@ -218,7 +229,7 @@ static void init_data(args_t *args) fprintf(args->dat_fp, " %s",args->argv[i]); fprintf(args->dat_fp,"\n#\n"); fprintf(args->dat_fp,"# DIST\t[2]Chrom\t[3]BAF\t[4]Normalized Count\n"); - fprintf(args->dat_fp,"# FIT\t[2]Chrom\t[3]Mean of fitted Gaussian\t[4]Scale\t[5]Sigma[6]\tMean etc.\n"); + fprintf(args->dat_fp,"# FIT\t[2]Goodness of Fit\t[3]iFrom\t[4]iTo\t[5]The Fitted Function\n"); fprintf(args->dat_fp,"# CN\t[2]Chrom\t[3]Estimated Copy Number\t[4]Absolute fit deviation\n"); char *fname = NULL; @@ -230,7 +241,8 @@ static void init_data(args_t *args) "import matplotlib as mpl\n" "mpl.use('Agg')\n" "import matplotlib.pyplot as plt\n" - "import csv,math,sys,argparse\n" + "import csv,sys,argparse\n" + "from math import exp\n" "\n" "outdir = '%s'\n" "\n" @@ -247,27 +259,25 @@ static void init_data(args_t *args) " dat[chr].append(row)\n" " elif type=='FIT':\n" " if chr not in fit: fit[chr] = []\n" - " fit[chr] = row[2:]\n" + " fit[chr].append(row)\n" " elif type=='CN':\n" " cn[chr] = row[2]\n" "\n" - "def fitted_func(xvals,params):\n" - " n = len(params)/3\n" - " out = []\n" - " for x in xvals:\n" - " y = 0\n" - " for i in range(n):\n" - " mean = float(params[i*3+0])\n" - " scale = float(params[i*3+1])\n" - " sigma = float(params[i*3+2])\n" - " y += scale * math.exp(-(float(x)-mean)**2/sigma**2)\n" - " out.append(y)\n" - " return out\n" - "\n" "def plot_dist(dat,fit,chr):\n" " fig, ax = plt.subplots(1, 1, figsize=(7,5))\n" - " ax.plot([x[2] for x in dat[chr]],[x[3] for x in dat[chr]],'-',label='Distribution')\n" - " ax.plot([x[2] for x in dat[chr]],fitted_func([x[2] for x in dat[chr]], fit[chr]),'-',label='Best Fit')\n" + " ax.plot([x[2] for x in dat[chr]],[x[3] for x in dat[chr]],'k-',label='Distribution')\n" + " if chr in fit:\n" + " for i in range(len(fit[chr])):\n" + " pfit = fit[chr][i]\n" + " exec('def xfit(x): return '+pfit[5])\n" + " istart = int(pfit[3])\n" + " iend = int(pfit[4])+1\n" + " vals = dat[chr][istart:iend]\n" + " args = {}\n" + " if i==0: args = {'label':'Target to Fit'}\n" + " ax.plot([x[2] for x in vals],[x[3] for x in vals],'r-',**args)\n" + " if i==0: args = {'label':'Best Fit'}\n" + " ax.plot([x[2] for x in vals],[xfit(float(x[2])) for x in vals],'g-',**args)\n" " ax.set_title('BAF distribution, chr'+chr)\n" " ax.set_xlabel('BAF')\n" " ax.set_ylabel('Frequency')\n" @@ -341,253 +351,202 @@ static void destroy_data(args_t *args) fclose(args->dat_fp); } -static void save_dist(args_t *args, int idist, int ngauss, double *params) +static void save_dist(args_t *args, dist_t *dist) { int i; for (i=0; inbins; i++) - fprintf(args->dat_fp,"DIST\t%s\t%f\t%f\n",args->dist[idist].chr,args->dist[idist].xvals[i],args->dist[idist].yvals[i]); - fprintf(args->dat_fp,"FIT\t%s", args->dist[idist].chr); - for (i=0; idat_fp,"\t%f", params[i]); - fprintf(args->dat_fp,"\n"); + fprintf(args->dat_fp,"DIST\t%s\t%f\t%f\n",dist->chr,dist->xvals[i],dist->yvals[i]); } - -int func_f(const gsl_vector *params, void *data, gsl_vector *yvals) +static void fit_curves(args_t *args) { - data_t *dat = (data_t *) data; + peakfit_t *pkf = peakfit_init(); + peakfit_verbose(pkf,args->verbose); - int i, j; - for (i=0; invals; i++) + int i, nmc = 50; + for (i=0; indist; i++) { - double xi = dat->xvals[i]; - double yi = 0; - for (j=0; jngauss; j++) - { - double center = gsl_vector_get(params,j*3 + 0); - double scale = gsl_vector_get(params,j*3 + 1); - double sigma = gsl_vector_get(params,j*3 + 2); + dist_t *dist = &args->dist[i]; + save_dist(args, &args->dist[i]); - double zi = (xi - center) / sigma; - yi += scale*scale * exp(-zi*zi); + if ( dist->copy_number!=0 ) + { + fprintf(args->dat_fp,"CN\t%s\t%.2f\n", dist->chr,(float)dist->copy_number); + continue; } - gsl_vector_set(yvals, i, (yi - dat->yvals[i])/0.1); - } - return GSL_SUCCESS; -} -int func_df(const gsl_vector *params, void *data, gsl_matrix *jacobian) -{ - data_t *dat = (data_t *) data; - - int i, j; - for (i=0; invals; i++) - { - // Jacobian matrix J(i,j) = dfi / dxj, - // where fi = (Yi - yi), - // Yi = scale^2 * exp(-(center - xi)^2/sigma^2) - // - - double xi = dat->xvals[i]; - for (j=0; jngauss; j++) + if ( args->verbose ) + fprintf(stderr,"%s:\n", dist->chr); + + int nrr_aa = dist->iaa - dist->irr + 1; + int nrr_ra = dist->ira - dist->irr + 1; + int naa_max = dist->nvals - dist->iaa; + double xrr = dist->xvals[dist->irr], *xrr_vals = &dist->xvals[dist->irr], *yrr_vals = &dist->yvals[dist->irr]; + double xaa = dist->xvals[dist->iaa], *xaa_vals = &dist->xvals[dist->iaa], *yaa_vals = &dist->yvals[dist->iaa]; + double xra = dist->xvals[dist->ira]; + double xmax = dist->xvals[dist->nvals-1]; + + // cn2: cn2a=AA peak, cn2b=RA peak + double cn2a_fit = 0; + char *cn2a_func = 0; + double cn2_params1[3] = {1,1,1} ,cn2_params2[3]; + if ( args->include_aa ) { - double center = gsl_vector_get(params,j*3 + 0); - double scale = gsl_vector_get(params,j*3 + 1); - double sigma = gsl_vector_get(params,j*3 + 2); - - double zi = (xi - center) / sigma; - double ei = exp(-zi*zi); - - gsl_matrix_set(jacobian, i, j*3 + 0, 2*scale*scale*(xi-center)/(sigma*sigma)*ei); - gsl_matrix_set(jacobian, i, j*3 + 1, 2*scale*ei); - gsl_matrix_set(jacobian, i, j*3 + 2, 2*scale*scale*(xi-center)*(xi-center)/(sigma*sigma*sigma)*ei); + peakfit_reset(pkf); + peakfit_add_exp(pkf, 1.0,1.0,0.2, 5); + peakfit_set_mc(pkf, 0.01,0.3,2,nmc); + peakfit_set_mc(pkf, 0.05,1.0,0,nmc); + cn2a_fit = peakfit_run(pkf, naa_max, xaa_vals, yaa_vals); + cn2a_func = strdup(peakfit_sprint_func(pkf)); + peakfit_get_params(pkf,0,cn2_params1,3); } - } - return GSL_SUCCESS; -} - -int func_set(const gsl_vector *params, void *data, gsl_vector *yvals, gsl_matrix *jacobian) -{ - func_f(params, data, yvals); - func_df(params, data, jacobian); - return GSL_SUCCESS; -} -static double eval_fit(int nvals, double *xvals, double *yvals, int ngauss, double *params) -{ - double sum = 0; - int i, j; - for (i=0; imin_fraction+2); + peakfit_reset(pkf); + peakfit_add_bounded_gaussian(pkf, 1.0,1/3.,0.03, xrr,xra-min_dx3, 7); + peakfit_set_mc(pkf, xrr,xra-min_dx3, 1,nmc); + peakfit_add_bounded_gaussian(pkf, 1.0,2/3.,0.03, xra+min_dx3,xaa, 7); + peakfit_set_mc(pkf, xra+min_dx3,xaa, 1,nmc); + peakfit_run(pkf, nrr_aa, xrr_vals, yrr_vals); + peakfit_get_params(pkf,0,cn3_params1,5); + peakfit_get_params(pkf,1,cn3_params2,5); + double cn3_dx = (0.5-cn3_params1[1] + cn3_params2[1]-0.5)*0.5; + peakfit_reset(pkf); + peakfit_add_gaussian(pkf, cn3_params1[0],0.5-cn3_dx,cn3_params1[2], 5); + peakfit_add_gaussian(pkf, cn3_params2[0],0.5+cn3_dx,cn3_params1[3], 5); + double cn3b_fit = peakfit_run(pkf, nrr_aa, xrr_vals, yrr_vals); + char *cn3b_func = strdup(peakfit_sprint_func(pkf)); + double a1 = cn3_params1[0]*cn3_params1[0]; + double a2 = cn3_params2[0]*cn3_params2[0]; + double dy_cn3 = a1 > a2 ? a2/a1 : a1/a2; + double b1 = cn3_params1[1], b2 = cn3_params2[1]; + double cn3_frac1 = (1 - 2*b1) / b1; + double cn3_frac2 = (2*b2 - 1) / (1 - b2); + double cn3_frac = 0.5*(cn3_frac1 + cn3_frac2); + double cn3_fit = cn3a_fit + cn3b_fit; + + // cn4 (contaminations): cn4a=AA bump, cn4b=RA bump, params1=big peak, params2=small peak + // min_frac=1 is interpreted as 50-50 contamination + double min_dx4 = 0.25*args->min_fraction; + double cn4a_fit = 0; + char *cn4a_func = 0; + double cn4a_params1[3] = {1,1,1} ,cn4a_params2[3] = {1,1,1}, cn4b_params1[3], cn4b_params2[5]; + if ( args->include_aa ) { - double center = params[j*3 + 0]; - double scale = params[j*3 + 1]; - double sigma = params[j*3 + 2]; - - double zi = (xvals[i] - center) / sigma; - yval += scale * exp(-zi*zi); + peakfit_reset(pkf); + peakfit_add_exp(pkf, 0.5,1.0,0.2, 5); + peakfit_set_mc(pkf, 0.01,0.3,2,nmc); + peakfit_add_bounded_gaussian(pkf, 0.4,(xaa+xmax)*0.5,2e-2, xaa,xmax, 7); + peakfit_set_mc(pkf, xaa,xmax, 1,nmc); + cn4a_fit = peakfit_run(pkf, naa_max, xaa_vals,yaa_vals); + cn4a_func = strdup(peakfit_sprint_func(pkf)); + peakfit_get_params(pkf,0,cn4a_params1,3); + peakfit_get_params(pkf,1,cn4a_params2,5); } - sum += fabs(yval - yvals[i]); - } - return sum; -} - -static int gauss_fit(dist_t *dist, int ngauss, double *params) -{ - data_t *dat = &dist->dat; - dat->ngauss = ngauss; - - gsl_multifit_function_fdf mfunc; - mfunc.f = &func_f; - mfunc.df = &func_df; - mfunc.fdf = &func_set; - mfunc.n = dat->nvals; - mfunc.p = ngauss*3; // number of fitting parameters - mfunc.params = dat; - - const gsl_multifit_fdfsolver_type *solver_type; - gsl_multifit_fdfsolver *solver; - gsl_vector_view vview = gsl_vector_view_array(params, mfunc.p); - solver_type = gsl_multifit_fdfsolver_lmsder; - solver = gsl_multifit_fdfsolver_alloc(solver_type, dat->nvals, mfunc.p); - gsl_multifit_fdfsolver_set(solver, &mfunc, &vview.vector); - - int i, status; - size_t iter = 0; - do - { - status = gsl_multifit_fdfsolver_iterate(solver); - if ( status ) break; - status = gsl_multifit_test_delta(solver->dx, solver->x, 1e-4, 1e-4); - } - while (status == GSL_CONTINUE && iter++ < 500); - - for (i=0; ix, i); - - gsl_multifit_fdfsolver_free(solver); - return iter>500 ? -1 : 0; -} - -static double best_fit(args_t *args, dist_t *dist, int ngauss, double *params) -{ - if ( ngauss==1 ) - { - gauss_fit(dist,ngauss,params); - params[1] *= params[1]; - return eval_fit(dist->dat.nvals, dist->dat.xvals, dist->dat.yvals, ngauss,params); - } - - int i, j, n = 3; - int ipk = 3*(ngauss-1); - double delta = 0.5 * (params[ipk] - params[0]) / n; - double best_params[9], tmp_params[9], best_fit = HUGE_VAL; - for (i=0; idat.nvals, dist->dat.xvals, dist->dat.yvals, ngauss, tmp_params); - - if ( best_fit < fit ) continue; // worse than previous - best_fit = fit; - memcpy(best_params,tmp_params,sizeof(double)*ngauss*3); - } - memcpy(params,best_params,sizeof(double)*ngauss*3); - return best_fit; -} - -static void print_params(data_t *dat, int ngauss, double *params, float fit, float frac, char fail, char comment) -{ - int i, j; - printf("\t%c%c fit=%f frac=%.2f .. center,scale,sigma = ", comment,fail?fail:'o',fit,frac); - for (i=0; indist; i++) - { - dist_t *dist = &args->dist[i]; - if ( dist->copy_number!=0 ) + peakfit_reset(pkf); + peakfit_add_gaussian(pkf, 1.0,0.5,0.03, 5); + peakfit_add_bounded_gaussian(pkf, 0.6,0.3,0.03, xrr,xra-min_dx4, 7); + peakfit_set_mc(pkf, xrr,xra-min_dx4,1,nmc); + double cn4b_fit = peakfit_run(pkf, nrr_ra , xrr_vals, yrr_vals); + double cn4_fit = cn4a_fit + 2*cn4b_fit; + char *cn4b_func = strdup(peakfit_sprint_func(pkf)); + peakfit_get_params(pkf,0,cn4b_params1,3); + peakfit_get_params(pkf,1,cn4b_params2,5); + double cn4b_frac = 1 - 2*cn4b_params2[1]; + double cn4a_frac = !args->include_aa ? cn4b_frac : 2*(1 - cn4a_params2[1]); + double cn4_frac = (cn4a_frac + cn4b_frac)*0.5; + // cn4a_params1: big AA exp peak + // cn4a_params2: small AA exp^2 peak + // cn4b_params1: big RA exp^2 peak + // cn4b_params2: small RA exp^2 peak + double bump1a = cn4a_params1[0]*cn4a_params1[0]; + double bump2a = cn4a_params2[0]*cn4a_params2[0]; + double bump1b = cn4b_params1[0]*cn4b_params1[0]; + double bump2b = cn4b_params2[0]*cn4b_params2[0]; + double dy_cn4a = args->include_aa ? (bump1a < bump2a ? bump1a/bump2a : bump2a/bump1a) : 1; + double dy_cn4b = bump1b < bump2b ? bump1b/bump2b : bump2b/bump1b; + + char cn2_fail = '*', cn3_fail = '*', cn4_fail = '*'; + if ( cn2_fit > args->fit_th ) cn2_fail = 'f'; + + if ( cn3_fit > args->fit_th ) cn3_fail = 'f'; + else if ( dy_cn3 < args->peak_symmetry ) cn3_fail = 'y'; // size difference is too big + + if ( cn4_fit > args->fit_th ) cn4_fail = 'f'; + else if ( 10*dy_cn4a < args->bump_size || dy_cn4b < args->bump_size ) cn4_fail = 'y'; // bump size too small (10x: the AA peak is always smaller) + + double cn = -1, fit = cn2_fit; + if ( cn2_fail == '*' ) { cn = 2; fit = cn2_fit; } + if ( cn3_fail == '*' ) { - fprintf(args->dat_fp,"CN\t%s\t%.2f\n", dist->chr,(float)dist->copy_number); - save_dist(args, i, 0, NULL); - continue; + // use cn_penalty as a tiebreaker + if ( (cn<0 && cn3_fitcn_penalty * fit) ) + { + cn = 2 + cn3_frac; + fit = cn3_fit; + if ( cn2_fail=='*' ) cn2_fail = 'p'; + } + else cn3_fail = 'p'; + } + if ( cn4_fail == '*' ) + { + if ( (cn<0 && cn4_fitcn_penalty * fit) ) + { + cn = 3 + cn4b_frac; + fit = cn4_fit; + if ( cn2_fail=='*' ) cn2_fail = 'p'; + if ( cn3_fail=='*' ) cn3_fail = 'p'; + } + else cn4_fail = 'p'; } - - // Parameters (center,scale,sigma) for gaussian peaks. - double params_cn2[] = { 1/2.,0.5,0.05 }; - double params_cn3[] = { 1/3.,0.5,0.05, 2/3.,0.5,0.05 }; - double params_cn4[] = { 1/4.,0.5,0.05, 1/2.,0.5,0.05, 3/4.,0.5,0.05 }; - - double fit_cn2 = best_fit(args,&args->dist[i],1,params_cn2); - double fit_cn3 = best_fit(args,&args->dist[i],2,params_cn3); - double fit_cn4 = best_fit(args,&args->dist[i],3,params_cn4); - - double dx_cn3 = fabs(params_cn3[0] - params_cn3[3]); - double dx_cn4 = fabs(params_cn4[0] - params_cn4[6]); - double dy_cn3 = params_cn3[1] > params_cn3[4] ? params_cn3[4]/params_cn3[1] : params_cn3[1]/params_cn3[4]; - double dy_cn4a = params_cn4[1] > params_cn4[7] ? params_cn4[7]/params_cn4[1] : params_cn4[1]/params_cn4[7]; // side peaks - double ymax = params_cn4[1] > params_cn4[7] ? params_cn4[1] : params_cn4[7]; - double dy_cn4b = ymax > params_cn4[4] ? params_cn4[4]/ymax : ymax/params_cn4[4]; // middle peak - - // Three peaks (CN4) are always a better fit than two (CN3) or one (CN2). Therefore - // check that peaks are well separated and that the peak sizes are reasonable - char cn2_fail = 0, cn3_fail = 0, cn4_fail = 0; - if ( fit_cn2 > args->fit_th ) cn2_fail = 'f'; - - if ( fit_cn3 > args->fit_th ) cn3_fail = 'f'; - else if ( dx_cn3 < 0.05 ) cn3_fail = 'x'; // peak separation: at least ~10% of cells - else if ( dy_cn3 < args->peak_symmetry ) cn3_fail = 'y'; - - if ( fit_cn4 > args->fit_th ) cn4_fail = 'f'; - else if ( dx_cn4 < 0.1 ) cn4_fail = 'x'; // peak separation - else if ( dy_cn4a < args->peak_symmetry ) cn4_fail = 'y'; - else if ( dy_cn4b < args->peak_symmetry ) cn4_fail = 'Y'; - - // Estimate fraction of affected cells. For CN4 we estimate - // contamination (the fraction of foreign cells), which is more - // common than CN4; hence the value is from the interval [0,0.5]. - // CN3 .. f = 2*dx/(1-dx) - // CN4 .. f = dx - dx_cn3 = 2*dx_cn3 / (1-dx_cn3); - - double cn = -1, fit = fit_cn2; - if ( !cn2_fail ) { cn = 2; fit = fit_cn2; } - if ( !cn3_fail && fit_cn3 < args->cn_penalty * fit ) { cn = 3; fit = fit_cn3; } - if ( !cn4_fail && fit_cn4 < args->cn_penalty * fit ) { cn = 4; fit = fit_cn4; } - - if ( cn==-1 ) save_dist(args, i, 0, NULL); - else if ( cn==2 ) save_dist(args, i, 1, params_cn2); - else if ( cn==3 ) { save_dist(args, i, 2, params_cn3); cn = 2 + dx_cn3; } - else if ( cn==4 ) { save_dist(args, i, 3, params_cn4); cn = 3 + dx_cn4; } if ( args->verbose ) { - printf("%s: \n", args->dist[i].chr); - print_params(&args->dist[i].dat, 1, params_cn2, fit_cn2, 1.0, cn2_fail, cn==2 ? '*' : ' '); - print_params(&args->dist[i].dat, 2, params_cn3, fit_cn3, dx_cn3, cn3_fail, cn>2 && cn<=3 ? '*' : ' '); - print_params(&args->dist[i].dat, 3, params_cn4, fit_cn4, dx_cn4, cn4_fail, cn>3 ? '*' : ' '); - printf("\n"); + fprintf(stderr,"\tcn2 %c fit=%e\n", cn2_fail, cn2_fit); + fprintf(stderr,"\t .. %e\t%f %f %f\n", cn2b_fit, cn2_params2[0],cn2_params2[1],cn2_params2[2]); + fprintf(stderr,"\t .. %e\t%f %f %f\n", cn2a_fit, cn2_params1[0],cn2_params1[1],cn2_params1[2]); + fprintf(stderr,"\tcn3 %c fit=%e frac=%f symmetry=%f (%f %f)\n", cn3_fail, cn3_fit, cn3_frac, dy_cn3,a1,a2); + fprintf(stderr,"\t .. %e\t%f %f %f\t%f %f %f\n", cn3b_fit, cn3_params1[0],cn3_params1[1],cn3_params1[2], cn3_params2[0],cn3_params2[1],cn3_params2[2]); + fprintf(stderr,"\t .. %e\t%f %f %f\n", cn3a_fit, cn3_params3[0],cn3_params3[1],cn3_params3[2]); + fprintf(stderr,"\tcn4 %c fit=%e frac=%f (%f+%f)/2 bumps=%f %f\n", cn4_fail, cn4_fit, cn4_frac, cn4b_frac,cn4a_frac,dy_cn4b,dy_cn4a); + fprintf(stderr,"\t .. %e\t%f %f %f\t%f %f %f\n", cn4b_fit, cn4b_params1[0],cn4b_params1[1],cn4b_params1[2], cn4b_params2[0],cn4b_params2[1],cn4b_params2[2]); + fprintf(stderr,"\t .. %e\t%f %f %f\t%f %f %f\n", cn4a_fit, cn4a_params1[0],cn4a_params1[1],cn4a_params1[2], cn4a_params2[0],cn4a_params2[1],cn4a_params2[2]); + } + + if ( cn2_fail == '*' ) + { + if ( cn2a_func ) fprintf(args->dat_fp,"FIT\t%s\t%e\t%d\t%d\t%s\n", dist->chr,cn2a_fit,dist->iaa,dist->nvals-1,cn2a_func); + fprintf(args->dat_fp,"FIT\t%s\t%e\t%d\t%d\t%s\n", dist->chr,cn2b_fit,dist->irr,dist->iaa,cn2b_func); + } + if ( cn3_fail == '*' ) + { + fprintf(args->dat_fp,"FIT\t%s\t%e\t%d\t%d\t%s\n", dist->chr,cn3b_fit,dist->irr,dist->iaa,cn3b_func); + if ( cn3a_func ) fprintf(args->dat_fp,"FIT\t%s\t%e\t%d\t%d\t%s\n", dist->chr,cn3a_fit,dist->iaa,dist->nvals-1,cn3a_func); + } + if ( cn4_fail == '*' ) + { + fprintf(args->dat_fp,"FIT\t%s\t%e\t%d\t%d\t%s\n", dist->chr,cn4b_fit,dist->irr,dist->ira,cn4b_func); + if ( cn4a_func ) fprintf(args->dat_fp,"FIT\t%s\t%e\t%d\t%d\t%s\n", dist->chr,cn4a_fit,dist->iaa,dist->nvals-1,cn4a_func); } fprintf(args->dat_fp,"CN\t%s\t%.2f\t%f\n", dist->chr, cn, fit); + + free(cn2a_func); + free(cn2b_func); + free(cn3b_func); + free(cn4a_func); + free(cn4b_func); } + + peakfit_destroy(pkf); } static void usage(args_t *args) @@ -604,9 +563,12 @@ static void usage(args_t *args) fprintf(stderr, " -T, --targets-file similar to -R but streams rather than index-jumps\n"); fprintf(stderr, " -v, --verbose \n"); fprintf(stderr, "Algorithm options:\n"); - fprintf(stderr, " -c, --cn-penalty penalty for increasing CN (smaller more strict) [0.7]\n"); - fprintf(stderr, " -f, --fit-th goodness of fit threshold (smaller more strict) [3.0]\n"); - fprintf(stderr, " -p, --peak-symmetry peak symmetry threshold (bigger more strict) [0.7]\n"); + fprintf(stderr, " -b, --bump-size minimum bump difference (bigger more strict) [0.2]\n"); + fprintf(stderr, " -c, --cn-penalty penalty for increasing CN (smaller more strict) [0.25]\n"); + fprintf(stderr, " -f, --fit-th goodness of fit threshold (smaller more strict) [3.3]\n"); + fprintf(stderr, " -i, --include-aa include the AA peak also in CN2 and CN3 evaluation\n"); + fprintf(stderr, " -m, --min-fraction minimum distinguishable fraction of aberrant cells [0.1]\n"); + fprintf(stderr, " -p, --peak-symmetry CN3 peak symmetry threshold (bigger more strict) [0.7]\n"); fprintf(stderr, "\n"); exit(1); } @@ -616,14 +578,18 @@ int main_polysomy(int argc, char *argv[]) args_t *args = (args_t*) calloc(1,sizeof(args_t)); args->argc = argc; args->argv = argv; args->nbins = 150; - args->fit_th = 3.0; - args->cn_penalty = 0.7; + args->fit_th = 3.3; + args->cn_penalty = 0.25; args->peak_symmetry = 0.7; + args->bump_size = 0.2; args->ra_rr_scaling = 1; + args->min_fraction = 0.1; static struct option loptions[] = { {"ra-rr-scaling",0,0,1}, // hidden option + {"include-aa",0,0,'i'}, + {"min-fraction",1,0,'m'}, {"verbose",0,0,'v'}, {"fit-th",1,0,'f'}, {"cn-penalty",1,0,'c'}, @@ -637,11 +603,17 @@ int main_polysomy(int argc, char *argv[]) {0,0,0,0} }; char c, *tmp; - while ((c = getopt_long(argc, argv, "h?o:vt:T:r:R:s:f:p:c:",loptions,NULL)) >= 0) + while ((c = getopt_long(argc, argv, "h?o:vt:T:r:R:s:f:p:c:im:",loptions,NULL)) >= 0) { switch (c) { case 1 : args->ra_rr_scaling = 0; break; + case 'i': args->include_aa = 1; break; + case 'm': + args->min_fraction = strtod(optarg,&tmp); + if ( *tmp ) error("Could not parse: -n %s\n", optarg); + if ( args->min_fraction<0 || args->min_fraction>1 ) error("Range error: -n %s\n", optarg); + break; case 'f': args->fit_th = strtod(optarg,&tmp); if ( *tmp ) error("Could not parse: -f %s\n", optarg); @@ -660,7 +632,7 @@ int main_polysomy(int argc, char *argv[]) case 'r': args->regions_list = optarg; break; case 'R': args->regions_list = optarg; args->regions_is_file = 1; break; case 'o': args->output_dir = optarg; break; - case 'v': args->verbose = 1; break; + case 'v': args->verbose++; break; default: usage(args); break; } } From 62764c0a12ac6f38355091c036a2f9cd1670eccb Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Mon, 16 Mar 2015 14:44:47 +0000 Subject: [PATCH 003/211] Tuning the parameters and fitting procedure, all RA peaks included for CN4 --- polysomy.c | 218 ++++++++++++++++++++++++++++++----------------------- 1 file changed, 122 insertions(+), 96 deletions(-) diff --git a/polysomy.c b/polysomy.c index 2f06af07a..ed8f3f897 100644 --- a/polysomy.c +++ b/polysomy.c @@ -385,61 +385,68 @@ static void fit_curves(args_t *args) double xra = dist->xvals[dist->ira]; double xmax = dist->xvals[dist->nvals-1]; - // cn2: cn2a=AA peak, cn2b=RA peak - double cn2a_fit = 0; - char *cn2a_func = 0; - double cn2_params1[3] = {1,1,1} ,cn2_params2[3]; + + // CN2 + double cn2aa_fit = 0, cn2ra_fit, cn2_fit; + char *cn2aa_func = 0, *cn2ra_func; + double cn2aa_params[3] = {1,1,1} ,cn2ra_params[3]; if ( args->include_aa ) { peakfit_reset(pkf); peakfit_add_exp(pkf, 1.0,1.0,0.2, 5); peakfit_set_mc(pkf, 0.01,0.3,2,nmc); peakfit_set_mc(pkf, 0.05,1.0,0,nmc); - cn2a_fit = peakfit_run(pkf, naa_max, xaa_vals, yaa_vals); - cn2a_func = strdup(peakfit_sprint_func(pkf)); - peakfit_get_params(pkf,0,cn2_params1,3); + cn2aa_fit = peakfit_run(pkf, naa_max, xaa_vals, yaa_vals); + cn2aa_func = strdup(peakfit_sprint_func(pkf)); + peakfit_get_params(pkf,0,cn2aa_params,3); } peakfit_reset(pkf); - peakfit_add_gaussian(pkf, 1.0,0.5,0.03, 5); - double cn2b_fit = peakfit_run(pkf, nrr_aa,xrr_vals,yrr_vals); - char *cn2b_func = strdup(peakfit_sprint_func(pkf)); - peakfit_get_params(pkf,0,cn2_params2,3); - double cn2_fit = cn2a_fit + cn2b_fit; - - // cn3: cn3a=AA peak, cn3b=RA peaks - double cn3a_fit = cn2a_fit; - char *cn3a_func = cn2a_func; - double cn3_params1[5], cn3_params2[5], *cn3_params3 = cn2_params1; - double min_dx3 = 0.5 - 1./(args->min_fraction+2); + peakfit_add_bounded_gaussian(pkf, 1.0,0.5,0.03, 0.45,0.55, 7); + peakfit_set_mc(pkf, 0.01,0.3,2,nmc); + peakfit_set_mc(pkf, 0.05,1.0,0,nmc); + cn2ra_fit = peakfit_run(pkf, nrr_aa,xrr_vals,yrr_vals); + cn2ra_func = strdup(peakfit_sprint_func(pkf)); + cn2_fit = cn2ra_fit + cn2aa_fit; + peakfit_get_params(pkf,0,cn2ra_params,3); + + + // CN3: fit two peaks, then enforce the symmetry and fit again + double cn3rra_params[5], cn3raa_params[5], *cn3aa_params = cn2aa_params; + double cn3aa_fit = cn2aa_fit, cn3ra_fit; + char *cn3aa_func = cn2aa_func, *cn3ra_func; + double min_dx3 = 0.5 - 1./(args->min_fraction+2); peakfit_reset(pkf); peakfit_add_bounded_gaussian(pkf, 1.0,1/3.,0.03, xrr,xra-min_dx3, 7); peakfit_set_mc(pkf, xrr,xra-min_dx3, 1,nmc); peakfit_add_bounded_gaussian(pkf, 1.0,2/3.,0.03, xra+min_dx3,xaa, 7); peakfit_set_mc(pkf, xra+min_dx3,xaa, 1,nmc); peakfit_run(pkf, nrr_aa, xrr_vals, yrr_vals); - peakfit_get_params(pkf,0,cn3_params1,5); - peakfit_get_params(pkf,1,cn3_params2,5); - double cn3_dx = (0.5-cn3_params1[1] + cn3_params2[1]-0.5)*0.5; + // force symmetry around x=0.5 + peakfit_get_params(pkf,0,cn3rra_params,5); + peakfit_get_params(pkf,1,cn3raa_params,5); + double cn3_dx = (0.5-cn3rra_params[1] + cn3raa_params[1]-0.5)*0.5; peakfit_reset(pkf); - peakfit_add_gaussian(pkf, cn3_params1[0],0.5-cn3_dx,cn3_params1[2], 5); - peakfit_add_gaussian(pkf, cn3_params2[0],0.5+cn3_dx,cn3_params1[3], 5); - double cn3b_fit = peakfit_run(pkf, nrr_aa, xrr_vals, yrr_vals); - char *cn3b_func = strdup(peakfit_sprint_func(pkf)); - double a1 = cn3_params1[0]*cn3_params1[0]; - double a2 = cn3_params2[0]*cn3_params2[0]; - double dy_cn3 = a1 > a2 ? a2/a1 : a1/a2; - double b1 = cn3_params1[1], b2 = cn3_params2[1]; - double cn3_frac1 = (1 - 2*b1) / b1; - double cn3_frac2 = (2*b2 - 1) / (1 - b2); - double cn3_frac = 0.5*(cn3_frac1 + cn3_frac2); - double cn3_fit = cn3a_fit + cn3b_fit; - - // cn4 (contaminations): cn4a=AA bump, cn4b=RA bump, params1=big peak, params2=small peak - // min_frac=1 is interpreted as 50-50 contamination - double min_dx4 = 0.25*args->min_fraction; - double cn4a_fit = 0; - char *cn4a_func = 0; - double cn4a_params1[3] = {1,1,1} ,cn4a_params2[3] = {1,1,1}, cn4b_params1[3], cn4b_params2[5]; + peakfit_add_gaussian(pkf, cn3rra_params[0],0.5-cn3_dx,cn3rra_params[2], 5); + peakfit_add_gaussian(pkf, cn3raa_params[0],0.5+cn3_dx,cn3raa_params[2], 5); + cn3ra_fit = peakfit_run(pkf, nrr_aa, xrr_vals, yrr_vals); + cn3ra_func = strdup(peakfit_sprint_func(pkf)); + // compare peak sizes + peakfit_get_params(pkf,0,cn3rra_params,3); + peakfit_get_params(pkf,1,cn3raa_params,3); + double cn3rra_size = cn3rra_params[0]*cn3rra_params[0]; + double cn3raa_size = cn3raa_params[0]*cn3raa_params[0]; + double cn3_dy = cn3rra_size > cn3raa_size ? cn3raa_size/cn3rra_size : cn3rra_size/cn3raa_size; + double cn3_frac = (1 - 2*cn3rra_params[1]) / cn3rra_params[1]; + double cn3_fit = cn3ra_fit + cn3aa_fit; + + + // CN4 (contaminations) + // - similarly to CN3, fit three peaks, then enforce the symmetry and fit again + // - min_frac=1 (resp. 0.5) is interpreted as 50:50% (rep. 75:25%) contamination + double cn4AAaa_params[3] = {1,1,1} ,cn4AAra_params[3] = {1,1,1}, cn4RAra_params[3], cn4RArr_params[5], cn4RAaa_params[5]; + double cn4aa_fit = 0, cn4ra_fit; + char *cn4aa_func = 0, *cn4ra_func; + double min_dx4 = 0.25*args->min_fraction; if ( args->include_aa ) { peakfit_reset(pkf); @@ -447,50 +454,60 @@ static void fit_curves(args_t *args) peakfit_set_mc(pkf, 0.01,0.3,2,nmc); peakfit_add_bounded_gaussian(pkf, 0.4,(xaa+xmax)*0.5,2e-2, xaa,xmax, 7); peakfit_set_mc(pkf, xaa,xmax, 1,nmc); - cn4a_fit = peakfit_run(pkf, naa_max, xaa_vals,yaa_vals); - cn4a_func = strdup(peakfit_sprint_func(pkf)); - peakfit_get_params(pkf,0,cn4a_params1,3); - peakfit_get_params(pkf,1,cn4a_params2,5); + cn4aa_fit = peakfit_run(pkf, naa_max, xaa_vals,yaa_vals); + cn4aa_func = strdup(peakfit_sprint_func(pkf)); + peakfit_get_params(pkf,0,cn4AAaa_params,3); + peakfit_get_params(pkf,1,cn4AAra_params,5); } peakfit_reset(pkf); peakfit_add_gaussian(pkf, 1.0,0.5,0.03, 5); peakfit_add_bounded_gaussian(pkf, 0.6,0.3,0.03, xrr,xra-min_dx4, 7); - peakfit_set_mc(pkf, xrr,xra-min_dx4,1,nmc); - double cn4b_fit = peakfit_run(pkf, nrr_ra , xrr_vals, yrr_vals); - double cn4_fit = cn4a_fit + 2*cn4b_fit; - char *cn4b_func = strdup(peakfit_sprint_func(pkf)); - peakfit_get_params(pkf,0,cn4b_params1,3); - peakfit_get_params(pkf,1,cn4b_params2,5); - double cn4b_frac = 1 - 2*cn4b_params2[1]; - double cn4a_frac = !args->include_aa ? cn4b_frac : 2*(1 - cn4a_params2[1]); - double cn4_frac = (cn4a_frac + cn4b_frac)*0.5; - // cn4a_params1: big AA exp peak - // cn4a_params2: small AA exp^2 peak - // cn4b_params1: big RA exp^2 peak - // cn4b_params2: small RA exp^2 peak - double bump1a = cn4a_params1[0]*cn4a_params1[0]; - double bump2a = cn4a_params2[0]*cn4a_params2[0]; - double bump1b = cn4b_params1[0]*cn4b_params1[0]; - double bump2b = cn4b_params2[0]*cn4b_params2[0]; - double dy_cn4a = args->include_aa ? (bump1a < bump2a ? bump1a/bump2a : bump2a/bump1a) : 1; - double dy_cn4b = bump1b < bump2b ? bump1b/bump2b : bump2b/bump1b; - + peakfit_set_mc(pkf, xrr,xra-min_dx4,2,nmc); + peakfit_run(pkf, nrr_ra , xrr_vals, yrr_vals); + // suggest symmetry around x=0.5 + peakfit_get_params(pkf,0,cn4RAra_params,3); + peakfit_get_params(pkf,1,cn4RArr_params,5); + double cn4_dx = 0.5-cn4RArr_params[1]; + peakfit_reset(pkf); + peakfit_add_gaussian(pkf, cn4RAra_params[0],0.5,cn4RAra_params[2], 5); + peakfit_add_gaussian(pkf, cn4RArr_params[0],0.5-cn4_dx,cn4RArr_params[2], 7); + peakfit_add_gaussian(pkf, cn4RArr_params[0],0.5+cn4_dx,cn4RArr_params[2], 7); + peakfit_set_mc(pkf, 0.1,cn4RAra_params[0],0,nmc); + peakfit_set_mc(pkf, 0.01,0.1,2,nmc); + cn4ra_fit = peakfit_run(pkf, nrr_aa , xrr_vals, yrr_vals); + cn4ra_func = strdup(peakfit_sprint_func(pkf)); + peakfit_get_params(pkf,0,cn4RAra_params,3); + peakfit_get_params(pkf,1,cn4RArr_params,3); + peakfit_get_params(pkf,2,cn4RAaa_params,3); + double cn4RAra_size = cn4RAra_params[0]==0 ? HUGE_VAL : cn4RAra_params[0]*cn4RAra_params[0]; + double cn4RArr_size = cn4RArr_params[0]*cn4RArr_params[0]; + double cn4RAaa_size = cn4RAaa_params[0]*cn4RAaa_params[0]; + double cn4_dy = cn4RArr_size < cn4RAaa_size ? cn4RArr_size/cn4RAaa_size : cn4RAaa_size/cn4RArr_size; + double cn4_ymin = cn4RArr_size < cn4RAaa_size ? cn4RArr_size/cn4RAra_size : cn4RAaa_size/cn4RAra_size; + cn4_dx = (cn4RAaa_params[1]-0.5) - (0.5-cn4RArr_params[1]); + double cn4_frac = cn4RAaa_params[1] - cn4RArr_params[1]; + double cn4_fit = cn4ra_fit + cn4aa_fit; + + + // Choose the best match char cn2_fail = '*', cn3_fail = '*', cn4_fail = '*'; if ( cn2_fit > args->fit_th ) cn2_fail = 'f'; if ( cn3_fit > args->fit_th ) cn3_fail = 'f'; - else if ( dy_cn3 < args->peak_symmetry ) cn3_fail = 'y'; // size difference is too big + else if ( cn3_dy < args->peak_symmetry ) cn3_fail = 'y'; // size difference is too big if ( cn4_fit > args->fit_th ) cn4_fail = 'f'; - else if ( 10*dy_cn4a < args->bump_size || dy_cn4b < args->bump_size ) cn4_fail = 'y'; // bump size too small (10x: the AA peak is always smaller) + else if ( cn4_ymin < args->bump_size ) cn4_fail = 'y'; // side peak is too small + else if ( cn4_dy < args->peak_symmetry ) cn4_fail = 'Y'; // size difference is too big + else if ( cn4_dx > 0.1 ) cn4_fail = 'x'; // side peaks placed assymetrically double cn = -1, fit = cn2_fit; if ( cn2_fail == '*' ) { cn = 2; fit = cn2_fit; } if ( cn3_fail == '*' ) { // use cn_penalty as a tiebreaker - if ( (cn<0 && cn3_fitcn_penalty * fit) ) - { + if ( cn<0 || cn3_fit < args->cn_penalty * fit ) + { cn = 2 + cn3_frac; fit = cn3_fit; if ( cn2_fail=='*' ) cn2_fail = 'p'; @@ -499,9 +516,9 @@ static void fit_curves(args_t *args) } if ( cn4_fail == '*' ) { - if ( (cn<0 && cn4_fitcn_penalty * fit) ) - { - cn = 3 + cn4b_frac; + if ( cn<0 || cn4_fit < args->cn_penalty * fit ) + { + cn = 3 + cn4_frac; fit = cn4_fit; if ( cn2_fail=='*' ) cn2_fail = 'p'; if ( cn3_fail=='*' ) cn3_fail = 'p'; @@ -512,38 +529,47 @@ static void fit_curves(args_t *args) if ( args->verbose ) { fprintf(stderr,"\tcn2 %c fit=%e\n", cn2_fail, cn2_fit); - fprintf(stderr,"\t .. %e\t%f %f %f\n", cn2b_fit, cn2_params2[0],cn2_params2[1],cn2_params2[2]); - fprintf(stderr,"\t .. %e\t%f %f %f\n", cn2a_fit, cn2_params1[0],cn2_params1[1],cn2_params1[2]); - fprintf(stderr,"\tcn3 %c fit=%e frac=%f symmetry=%f (%f %f)\n", cn3_fail, cn3_fit, cn3_frac, dy_cn3,a1,a2); - fprintf(stderr,"\t .. %e\t%f %f %f\t%f %f %f\n", cn3b_fit, cn3_params1[0],cn3_params1[1],cn3_params1[2], cn3_params2[0],cn3_params2[1],cn3_params2[2]); - fprintf(stderr,"\t .. %e\t%f %f %f\n", cn3a_fit, cn3_params3[0],cn3_params3[1],cn3_params3[2]); - fprintf(stderr,"\tcn4 %c fit=%e frac=%f (%f+%f)/2 bumps=%f %f\n", cn4_fail, cn4_fit, cn4_frac, cn4b_frac,cn4a_frac,dy_cn4b,dy_cn4a); - fprintf(stderr,"\t .. %e\t%f %f %f\t%f %f %f\n", cn4b_fit, cn4b_params1[0],cn4b_params1[1],cn4b_params1[2], cn4b_params2[0],cn4b_params2[1],cn4b_params2[2]); - fprintf(stderr,"\t .. %e\t%f %f %f\t%f %f %f\n", cn4a_fit, cn4a_params1[0],cn4a_params1[1],cn4a_params1[2], cn4a_params2[0],cn4a_params2[1],cn4a_params2[2]); + fprintf(stderr,"\t .. %e\n", cn2ra_fit); + fprintf(stderr,"\t RA: %f %f %f\n", cn2ra_params[0],cn2ra_params[1],cn2ra_params[2]); + fprintf(stderr,"\t .. %e\n", cn2aa_fit); + fprintf(stderr,"\t AA: %f %f %f\n", cn2aa_params[0],cn2aa_params[1],cn2aa_params[2]); + fprintf(stderr,"\tcn3 %c fit=%e frac=%f symmetry=%f\n", cn3_fail, cn3_fit, cn3_frac, cn3_dy); + fprintf(stderr,"\t .. %e\n", cn3ra_fit); + fprintf(stderr,"\t RRA: %f %f %f\n", cn3rra_params[0],cn3rra_params[1],cn3rra_params[2]); + fprintf(stderr,"\t RAA: %f %f %f\n", cn3raa_params[0],cn3raa_params[1],cn3raa_params[2]); + fprintf(stderr,"\t .. %e\n", cn3aa_fit); + fprintf(stderr,"\t AAA: %f %f %f\n", cn3aa_params[0],cn3aa_params[1],cn3aa_params[2]); + fprintf(stderr,"\tcn4 %c fit=%e frac=%f symmetry=%f ymin=%f\n", cn4_fail, cn4_fit, cn4_frac, cn4_dy, cn4_ymin); + fprintf(stderr,"\t .. %e\n", cn4ra_fit); + fprintf(stderr,"\t RArr: %f %f %f\n", cn4RArr_params[0],cn4RArr_params[1],cn4RArr_params[2]); + fprintf(stderr,"\t RAra: %f %f %f\n", cn4RAra_params[0],cn4RAra_params[1],cn4RAra_params[2]); + fprintf(stderr,"\t RAaa: %f %f %f\n", cn4RAaa_params[0],cn4RAaa_params[1],cn4RAaa_params[2]); + fprintf(stderr,"\t .. %e\n", cn4aa_fit); + fprintf(stderr,"\t AAaa: %f %f %f\n", cn4AAaa_params[0],cn4AAaa_params[1],cn4AAaa_params[2]); } if ( cn2_fail == '*' ) { - if ( cn2a_func ) fprintf(args->dat_fp,"FIT\t%s\t%e\t%d\t%d\t%s\n", dist->chr,cn2a_fit,dist->iaa,dist->nvals-1,cn2a_func); - fprintf(args->dat_fp,"FIT\t%s\t%e\t%d\t%d\t%s\n", dist->chr,cn2b_fit,dist->irr,dist->iaa,cn2b_func); + fprintf(args->dat_fp,"FIT\t%s\t%e\t%d\t%d\t%s\n", dist->chr,cn2ra_fit,dist->irr,dist->iaa,cn2ra_func); + if ( cn2aa_func ) fprintf(args->dat_fp,"FIT\t%s\t%e\t%d\t%d\t%s\n", dist->chr,cn2aa_fit,dist->iaa,dist->nvals-1,cn2aa_func); } if ( cn3_fail == '*' ) { - fprintf(args->dat_fp,"FIT\t%s\t%e\t%d\t%d\t%s\n", dist->chr,cn3b_fit,dist->irr,dist->iaa,cn3b_func); - if ( cn3a_func ) fprintf(args->dat_fp,"FIT\t%s\t%e\t%d\t%d\t%s\n", dist->chr,cn3a_fit,dist->iaa,dist->nvals-1,cn3a_func); + fprintf(args->dat_fp,"FIT\t%s\t%e\t%d\t%d\t%s\n", dist->chr,cn3ra_fit,dist->irr,dist->iaa,cn3ra_func); + if ( cn3aa_func ) fprintf(args->dat_fp,"FIT\t%s\t%e\t%d\t%d\t%s\n", dist->chr,cn3aa_fit,dist->iaa,dist->nvals-1,cn3aa_func); } if ( cn4_fail == '*' ) { - fprintf(args->dat_fp,"FIT\t%s\t%e\t%d\t%d\t%s\n", dist->chr,cn4b_fit,dist->irr,dist->ira,cn4b_func); - if ( cn4a_func ) fprintf(args->dat_fp,"FIT\t%s\t%e\t%d\t%d\t%s\n", dist->chr,cn4a_fit,dist->iaa,dist->nvals-1,cn4a_func); + fprintf(args->dat_fp,"FIT\t%s\t%e\t%d\t%d\t%s\n", dist->chr,cn4ra_fit,dist->irr,dist->iaa,cn4ra_func); + if ( cn4aa_func ) fprintf(args->dat_fp,"FIT\t%s\t%e\t%d\t%d\t%s\n", dist->chr,cn4aa_fit,dist->iaa,dist->nvals-1,cn4aa_func); } fprintf(args->dat_fp,"CN\t%s\t%.2f\t%f\n", dist->chr, cn, fit); - free(cn2a_func); - free(cn2b_func); - free(cn3b_func); - free(cn4a_func); - free(cn4b_func); + free(cn2aa_func); + free(cn2ra_func); + free(cn3ra_func); + free(cn4ra_func); + free(cn4aa_func); } peakfit_destroy(pkf); @@ -563,12 +589,12 @@ static void usage(args_t *args) fprintf(stderr, " -T, --targets-file similar to -R but streams rather than index-jumps\n"); fprintf(stderr, " -v, --verbose \n"); fprintf(stderr, "Algorithm options:\n"); - fprintf(stderr, " -b, --bump-size minimum bump difference (bigger more strict) [0.2]\n"); - fprintf(stderr, " -c, --cn-penalty penalty for increasing CN (smaller more strict) [0.25]\n"); + fprintf(stderr, " -b, --bump-size minimum bump size (bigger more strict) [0.1]\n"); + fprintf(stderr, " -c, --cn-penalty penalty for increasing CN (smaller more strict) [0.3]\n"); fprintf(stderr, " -f, --fit-th goodness of fit threshold (smaller more strict) [3.3]\n"); fprintf(stderr, " -i, --include-aa include the AA peak also in CN2 and CN3 evaluation\n"); fprintf(stderr, " -m, --min-fraction minimum distinguishable fraction of aberrant cells [0.1]\n"); - fprintf(stderr, " -p, --peak-symmetry CN3 peak symmetry threshold (bigger more strict) [0.7]\n"); + fprintf(stderr, " -p, --peak-symmetry peak symmetry threshold (bigger more strict) [0.6]\n"); fprintf(stderr, "\n"); exit(1); } @@ -579,9 +605,9 @@ int main_polysomy(int argc, char *argv[]) args->argc = argc; args->argv = argv; args->nbins = 150; args->fit_th = 3.3; - args->cn_penalty = 0.25; - args->peak_symmetry = 0.7; - args->bump_size = 0.2; + args->cn_penalty = 0.3; + args->peak_symmetry = 0.6; + args->bump_size = 0.1; args->ra_rr_scaling = 1; args->min_fraction = 0.1; From 983bea456fd48801eee528303546eec087efb975 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Tue, 17 Mar 2015 16:06:49 +0000 Subject: [PATCH 004/211] polysomy: CN4 side peaks symmetry check now relative rather than absolute; hidden --force-cn option for debugging --- polysomy.c | 18 +++++++++++------- 1 file changed, 11 insertions(+), 7 deletions(-) diff --git a/polysomy.c b/polysomy.c index ed8f3f897..5c808acdd 100644 --- a/polysomy.c +++ b/polysomy.c @@ -55,7 +55,7 @@ typedef struct dist_t *dist; char **argv, *output_dir; double fit_th, peak_symmetry, cn_penalty, bump_size, min_fraction; - int argc, plot, verbose, regions_is_file, targets_is_file, include_aa; + int argc, plot, verbose, regions_is_file, targets_is_file, include_aa, force_cn; char *dat_fname, *fname, *regions_list, *targets_list, *sample; FILE *dat_fp; } @@ -482,7 +482,9 @@ static void fit_curves(args_t *args) double cn4RAra_size = cn4RAra_params[0]==0 ? HUGE_VAL : cn4RAra_params[0]*cn4RAra_params[0]; double cn4RArr_size = cn4RArr_params[0]*cn4RArr_params[0]; double cn4RAaa_size = cn4RAaa_params[0]*cn4RAaa_params[0]; - double cn4_dy = cn4RArr_size < cn4RAaa_size ? cn4RArr_size/cn4RAaa_size : cn4RAaa_size/cn4RArr_size; + double cn4RArr_dy = cn4RArr_size < cn4RAra_size ? cn4RArr_size/cn4RAra_size : cn4RAra_size/cn4RArr_size; + double cn4RAaa_dy = cn4RAaa_size < cn4RAra_size ? cn4RAaa_size/cn4RAra_size : cn4RAra_size/cn4RAaa_size; + double cn4_dy = cn4RArr_dy < cn4RAaa_dy ? cn4RArr_dy/cn4RAaa_dy : cn4RAaa_dy/cn4RArr_dy; double cn4_ymin = cn4RArr_size < cn4RAaa_size ? cn4RArr_size/cn4RAra_size : cn4RAaa_size/cn4RAra_size; cn4_dx = (cn4RAaa_params[1]-0.5) - (0.5-cn4RArr_params[1]); double cn4_frac = cn4RAaa_params[1] - cn4RArr_params[1]; @@ -548,17 +550,17 @@ static void fit_curves(args_t *args) fprintf(stderr,"\t AAaa: %f %f %f\n", cn4AAaa_params[0],cn4AAaa_params[1],cn4AAaa_params[2]); } - if ( cn2_fail == '*' ) + if ( args->force_cn==2 || cn2_fail == '*' ) { fprintf(args->dat_fp,"FIT\t%s\t%e\t%d\t%d\t%s\n", dist->chr,cn2ra_fit,dist->irr,dist->iaa,cn2ra_func); if ( cn2aa_func ) fprintf(args->dat_fp,"FIT\t%s\t%e\t%d\t%d\t%s\n", dist->chr,cn2aa_fit,dist->iaa,dist->nvals-1,cn2aa_func); } - if ( cn3_fail == '*' ) + if ( args->force_cn==3 || cn3_fail == '*' ) { fprintf(args->dat_fp,"FIT\t%s\t%e\t%d\t%d\t%s\n", dist->chr,cn3ra_fit,dist->irr,dist->iaa,cn3ra_func); if ( cn3aa_func ) fprintf(args->dat_fp,"FIT\t%s\t%e\t%d\t%d\t%s\n", dist->chr,cn3aa_fit,dist->iaa,dist->nvals-1,cn3aa_func); } - if ( cn4_fail == '*' ) + if ( args->force_cn==4 || cn4_fail == '*' ) { fprintf(args->dat_fp,"FIT\t%s\t%e\t%d\t%d\t%s\n", dist->chr,cn4ra_fit,dist->irr,dist->iaa,cn4ra_func); if ( cn4aa_func ) fprintf(args->dat_fp,"FIT\t%s\t%e\t%d\t%d\t%s\n", dist->chr,cn4aa_fit,dist->iaa,dist->nvals-1,cn4aa_func); @@ -594,7 +596,7 @@ static void usage(args_t *args) fprintf(stderr, " -f, --fit-th goodness of fit threshold (smaller more strict) [3.3]\n"); fprintf(stderr, " -i, --include-aa include the AA peak also in CN2 and CN3 evaluation\n"); fprintf(stderr, " -m, --min-fraction minimum distinguishable fraction of aberrant cells [0.1]\n"); - fprintf(stderr, " -p, --peak-symmetry peak symmetry threshold (bigger more strict) [0.6]\n"); + fprintf(stderr, " -p, --peak-symmetry peak symmetry threshold (bigger more strict) [0.5]\n"); fprintf(stderr, "\n"); exit(1); } @@ -606,7 +608,7 @@ int main_polysomy(int argc, char *argv[]) args->nbins = 150; args->fit_th = 3.3; args->cn_penalty = 0.3; - args->peak_symmetry = 0.6; + args->peak_symmetry = 0.5; args->bump_size = 0.1; args->ra_rr_scaling = 1; args->min_fraction = 0.1; @@ -614,6 +616,7 @@ int main_polysomy(int argc, char *argv[]) static struct option loptions[] = { {"ra-rr-scaling",0,0,1}, // hidden option + {"force-cn",1,0,2}, // hidden option {"include-aa",0,0,'i'}, {"min-fraction",1,0,'m'}, {"verbose",0,0,'v'}, @@ -634,6 +637,7 @@ int main_polysomy(int argc, char *argv[]) switch (c) { case 1 : args->ra_rr_scaling = 0; break; + case 2 : args->force_cn = atoi(optarg); break; case 'i': args->include_aa = 1; break; case 'm': args->min_fraction = strtod(optarg,&tmp); From 57edcaba051b7d736fa815ba2bc2e10e56c574ce Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Mon, 29 Jun 2015 15:13:01 +0100 Subject: [PATCH 005/211] minor wording and whitespace changes to polysomy.c --- polysomy.c | 40 +++++++++++++++++++++------------------- 1 file changed, 21 insertions(+), 19 deletions(-) diff --git a/polysomy.c b/polysomy.c index 5c808acdd..3962cf8a1 100644 --- a/polysomy.c +++ b/polysomy.c @@ -1,19 +1,19 @@ /* The MIT License - Copyright (c) 2013-2014 Genome Research Ltd. + Copyright (c) 2013-2015 Genome Research Ltd. Author: Petr Danecek - + Permission is hereby granted, free of charge, to any person obtaining a copy of this software and associated documentation files (the "Software"), to deal in the Software without restriction, including without limitation the rights to use, copy, modify, merge, publish, distribute, sublicense, and/or sell copies of the Software, and to permit persons to whom the Software is furnished to do so, subject to the following conditions: - + The above copyright notice and this permission notice shall be included in all copies or substantial portions of the Software. - + THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS OR IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF MERCHANTABILITY, FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. IN NO EVENT SHALL THE @@ -41,7 +41,7 @@ typedef struct { int nvals; // all values, including RR,AA peaks double *xvals; // pointer to args_t.xvals - double *yvals; + double *yvals; int copy_number; // heuristics to skip futile CN1 fits when no het peak is detected int irr, ira, iaa; // chop off RR and AA peaks char *chr; @@ -520,8 +520,8 @@ static void fit_curves(args_t *args) { if ( cn<0 || cn4_fit < args->cn_penalty * fit ) { - cn = 3 + cn4_frac; - fit = cn4_fit; + cn = 3 + cn4_frac; + fit = cn4_fit; if ( cn2_fail=='*' ) cn2_fail = 'p'; if ( cn3_fail=='*' ) cn3_fail = 'p'; } @@ -582,6 +582,7 @@ static void usage(args_t *args) fprintf(stderr, "\n"); fprintf(stderr, "About: Detect number of chromosomal copies from Illumina's B-allele frequency (BAF)\n"); fprintf(stderr, "Usage: bcftools polysomy [OPTIONS] \n"); + fprintf(stderr, "\n"); fprintf(stderr, "General options:\n"); fprintf(stderr, " -o, --output-dir \n"); fprintf(stderr, " -r, --regions restrict to comma-separated list of regions\n"); @@ -590,13 +591,14 @@ static void usage(args_t *args) fprintf(stderr, " -t, --targets similar to -r but streams rather than index-jumps\n"); fprintf(stderr, " -T, --targets-file similar to -R but streams rather than index-jumps\n"); fprintf(stderr, " -v, --verbose \n"); + fprintf(stderr, "\n"); fprintf(stderr, "Algorithm options:\n"); - fprintf(stderr, " -b, --bump-size minimum bump size (bigger more strict) [0.1]\n"); - fprintf(stderr, " -c, --cn-penalty penalty for increasing CN (smaller more strict) [0.3]\n"); - fprintf(stderr, " -f, --fit-th goodness of fit threshold (smaller more strict) [3.3]\n"); - fprintf(stderr, " -i, --include-aa include the AA peak also in CN2 and CN3 evaluation\n"); + fprintf(stderr, " -b, --bump-size minimum bump size (larger is stricter) [0.1]\n"); + fprintf(stderr, " -c, --cn-penalty penalty for increasing CN (smaller is stricter) [0.3]\n"); + fprintf(stderr, " -f, --fit-th goodness of fit threshold (smaller is stricter) [3.3]\n"); + fprintf(stderr, " -i, --include-aa include the AA peak in CN2 and CN3 evaluation\n"); fprintf(stderr, " -m, --min-fraction minimum distinguishable fraction of aberrant cells [0.1]\n"); - fprintf(stderr, " -p, --peak-symmetry peak symmetry threshold (bigger more strict) [0.5]\n"); + fprintf(stderr, " -p, --peak-symmetry peak symmetry threshold (larger is stricter) [0.5]\n"); fprintf(stderr, "\n"); exit(1); } @@ -613,7 +615,7 @@ int main_polysomy(int argc, char *argv[]) args->ra_rr_scaling = 1; args->min_fraction = 0.1; - static struct option loptions[] = + static struct option loptions[] = { {"ra-rr-scaling",0,0,1}, // hidden option {"force-cn",1,0,2}, // hidden option @@ -632,27 +634,27 @@ int main_polysomy(int argc, char *argv[]) {0,0,0,0} }; char c, *tmp; - while ((c = getopt_long(argc, argv, "h?o:vt:T:r:R:s:f:p:c:im:",loptions,NULL)) >= 0) + while ((c = getopt_long(argc, argv, "h?o:vt:T:r:R:s:f:p:c:im:",loptions,NULL)) >= 0) { - switch (c) + switch (c) { case 1 : args->ra_rr_scaling = 0; break; case 2 : args->force_cn = atoi(optarg); break; case 'i': args->include_aa = 1; break; - case 'm': + case 'm': args->min_fraction = strtod(optarg,&tmp); if ( *tmp ) error("Could not parse: -n %s\n", optarg); if ( args->min_fraction<0 || args->min_fraction>1 ) error("Range error: -n %s\n", optarg); break; - case 'f': + case 'f': args->fit_th = strtod(optarg,&tmp); if ( *tmp ) error("Could not parse: -f %s\n", optarg); break; - case 'p': + case 'p': args->peak_symmetry = strtod(optarg,&tmp); if ( *tmp ) error("Could not parse: -p %s\n", optarg); break; - case 'c': + case 'c': args->cn_penalty = strtod(optarg,&tmp); if ( *tmp ) error("Could not parse: -c %s\n", optarg); break; From 9480a5458250c72d380d9302e9f99a4c5b6fc1bb Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Mon, 29 Jun 2015 15:13:41 +0100 Subject: [PATCH 006/211] show polysomy command in help message This was hidden as it was/is experimental, but with the licensing additions, users are explicitly requesting the command by compiling with USE_GPL=1, so we might as well display in the help message. Closes #280 --- main.c | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/main.c b/main.c index 98d8ee1b6..0130e39b2 100644 --- a/main.c +++ b/main.c @@ -151,7 +151,7 @@ static cmd_t cmds[] = #if USE_GPL { .func = main_polysomy, .alias = "polysomy", - .help = "-detect number of chromosomal copies", + .help = "detect number of chromosomal copies", }, #endif { .func = main_vcfroh, From 68b06b708753496c1c886b2778c214d6f196bd97 Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Mon, 6 Jul 2015 10:28:47 +0100 Subject: [PATCH 007/211] update copyright dates for peakfit --- peakfit.c | 2 +- peakfit.h | 2 +- 2 files changed, 2 insertions(+), 2 deletions(-) diff --git a/peakfit.c b/peakfit.c index 93f1acd60..89bdcb0c4 100644 --- a/peakfit.c +++ b/peakfit.c @@ -1,6 +1,6 @@ /* The MIT License - Copyright (c) 2013-2014 Genome Research Ltd. + Copyright (c) 2013-2015 Genome Research Ltd. Author: Petr Danecek diff --git a/peakfit.h b/peakfit.h index de497cd75..8a9e4fab2 100644 --- a/peakfit.h +++ b/peakfit.h @@ -1,6 +1,6 @@ /* The MIT License - Copyright (c) 2013-2014 Genome Research Ltd. + Copyright (c) 2013-2015 Genome Research Ltd. Author: Petr Danecek From baa24a8fa1fc4739e4b5a10a220ad971a2fbeeed Mon Sep 17 00:00:00 2001 From: "Warren W. Kretzschmar" Date: Tue, 28 Apr 2015 10:24:49 +0100 Subject: [PATCH 008/211] Implements "bcftools view -G removes all format header lines" Resolves #248 --- test/test.pl | 1 + test/view.9.out | 4 ---- test/view.dropgenotypes.out | 12 ++++++++++++ vcfview.c | 4 +++- 4 files changed, 16 insertions(+), 5 deletions(-) create mode 100644 test/view.dropgenotypes.out diff --git a/test/test.pl b/test/test.pl index 621b8ec6a..71d80418c 100755 --- a/test/test.pl +++ b/test/test.pl @@ -107,6 +107,7 @@ test_vcf_view($opts,in=>'view',out=>'view.10.out',args=>q[-ne 'INDEL=1 || PV4[0]<0.006'],reg=>''); test_vcf_view($opts,in=>'view',out=>'view.exclude.out',args=>'-s ^NA00003',reg=>''); test_vcf_view($opts,in=>'view.omitgenotypes',out=>'view.omitgenotypes.out',args=>'',reg=>''); +test_vcf_view($opts,in=>'view.omitgenotypes',out=>'view.dropgenotypes.out',args=>'-G',reg=>''); test_vcf_view($opts,in=>'view.vectors',out=>'view.vectors.A.out',args=>'-asA',reg=>''); test_vcf_view($opts,in=>'view.vectors',out=>'view.vectors.B.out',args=>'-asB',reg=>''); test_vcf_view($opts,in=>'view.filter',out=>'view.filter.1.out',args=>q[-H -i'FMT/FGS[0]="AAAAAA"'],reg=>''); # test expressions diff --git a/test/view.9.out b/test/view.9.out index b5b13bdb6..35292102c 100644 --- a/test/view.9.out +++ b/test/view.9.out @@ -20,10 +20,6 @@ ##INFO= ##INFO= ##INFO= -##FORMAT= -##FORMAT= -##FORMAT= -##FORMAT= ##FILTER= ##FILTER= ##FILTER= diff --git a/test/view.dropgenotypes.out b/test/view.dropgenotypes.out new file mode 100644 index 000000000..8e983f62b --- /dev/null +++ b/test/view.dropgenotypes.out @@ -0,0 +1,12 @@ +##fileformat=VCFv4.2 +##FILTER= +##reference=file:///seq/references/1000GenomesPilot-NCBI36.fasta +##contig= +##INFO= +##INFO= +#CHROM POS ID REF ALT QUAL FILTER INFO +20 14370 rs6054257 G A 29 PASS NS=3;DP=14 +20 17330 . T A 3 PASS NS=3;DP=11 +20 1110696 rs6040355 A G,T 67 PASS NS=2;DP=10 +20 1230237 . T . 47 PASS NS=3;DP=13 +20 1234567 microsat1 GTC G,GTCT 50 PASS NS=3;DP=9 diff --git a/vcfview.c b/vcfview.c index d89882430..ed888c7c1 100644 --- a/vcfview.c +++ b/vcfview.c @@ -220,8 +220,10 @@ static void init_data(args_t *args) if ( !args->out ) error("%s: %s\n", args->fn_out,strerror(errno)); // headers: hdr=full header, hsub=subset header, hnull=sites only header - if (args->sites_only) + if (args->sites_only){ args->hnull = bcf_hdr_subset(args->hdr, 0, 0, 0); + bcf_hdr_remove(args->hnull, BCF_HL_FMT, NULL); + } if (args->n_samples > 0) { args->hsub = bcf_hdr_subset(args->hdr, args->n_samples, args->samples, args->imap); From 8fdd4985d45969d188161b260fe4c1b94a322e18 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Thu, 26 Mar 2015 16:53:25 +0100 Subject: [PATCH 009/211] The HMM structure becomes opaque for future flexibility --- HMM.c | 36 +++++++++++++++++++++++++++++++----- HMM.h | 47 ++++++++++++++++++++++------------------------- vcfcnv.c | 23 +++++++++++++---------- vcfroh.c | 49 ++++++++++++++++++++++++++++--------------------- 4 files changed, 94 insertions(+), 61 deletions(-) diff --git a/HMM.c b/HMM.c index 2d2a4021f..f20f91797 100644 --- a/HMM.c +++ b/HMM.c @@ -31,6 +31,32 @@ #include #include "HMM.h" +struct _hmm_t +{ + int nstates; // number of states + + double *vprob, *vprob_tmp; // viterbi probs [nstates] + uint8_t *vpath; // viterbi path [nstates*nvpath] + double *bwd, *bwd_tmp; // bwd probs [nstates] + double *fwd; // fwd probs [nstates*(nfwd+1)] + int nvpath, nfwd; + + int ntprob_arr; // number of pre-calculated tprob matrices + double *curr_tprob, *tmp; // Temporary arrays; curr_tprob is short lived, valid only for + // one site (that is, one step of Viterbi algorithm) + double *tprob_arr; // Array of transition matrices, precalculated to ntprob_arr + // positions. The first matrix is the initial tprob matrix + // set by hmm_init() or hmm_set_tprob() + set_tprob_f set_tprob; // Optional user function to set / modify transition probabilities + // at each site (one step of Viterbi algorithm) + void *set_tprob_data; +}; + +uint8_t *hmm_get_viterbi_path(hmm_t *hmm) { return hmm->vpath; } +double *hmm_get_tprob(hmm_t *hmm) { return hmm->tprob_arr; } +int hmm_get_nstates(hmm_t *hmm) { return hmm->nstates; } +double *hmm_get_fwd_bwd_prob(hmm_t *hmm) { return hmm->fwd; } + static inline void multiply_matrix(int n, double *a, double *b, double *dst, double *tmp) { double *out = dst; @@ -130,7 +156,7 @@ void hmm_run_viterbi(hmm_t *hmm, int n, double *eprobs, uint32_t *sites) int pos_diff = sites[i] == prev_pos ? 0 : sites[i] - prev_pos - 1; _set_tprob(hmm, pos_diff); - if ( hmm->set_tprob ) hmm->set_tprob(hmm, prev_pos, sites[i], hmm->set_tprob_data); + if ( hmm->set_tprob ) hmm->set_tprob(hmm, prev_pos, sites[i], hmm->set_tprob_data, hmm->curr_tprob); prev_pos = sites[i]; double vnorm = 0; @@ -196,7 +222,7 @@ void hmm_run_fwd_bwd(hmm_t *hmm, int n, double *eprobs, uint32_t *sites) int pos_diff = sites[i] == prev_pos ? 0 : sites[i] - prev_pos - 1; _set_tprob(hmm, pos_diff); - if ( hmm->set_tprob ) hmm->set_tprob(hmm, prev_pos, sites[i], hmm->set_tprob_data); + if ( hmm->set_tprob ) hmm->set_tprob(hmm, prev_pos, sites[i], hmm->set_tprob_data, hmm->curr_tprob); prev_pos = sites[i]; double norm = 0; @@ -222,7 +248,7 @@ void hmm_run_fwd_bwd(hmm_t *hmm, int n, double *eprobs, uint32_t *sites) int pos_diff = sites[n-i-1] == prev_pos ? 0 : prev_pos - sites[n-i-1] - 1; _set_tprob(hmm, pos_diff); - if ( hmm->set_tprob ) hmm->set_tprob(hmm, sites[n-i-1], prev_pos, hmm->set_tprob_data); + if ( hmm->set_tprob ) hmm->set_tprob(hmm, sites[n-i-1], prev_pos, hmm->set_tprob_data, hmm->curr_tprob); prev_pos = sites[n-i-1]; double bwd_norm = 0; @@ -281,7 +307,7 @@ void hmm_run_baum_welch(hmm_t *hmm, int n, double *eprobs, uint32_t *sites) int pos_diff = sites[i] == prev_pos ? 0 : sites[i] - prev_pos - 1; _set_tprob(hmm, pos_diff); - if ( hmm->set_tprob ) hmm->set_tprob(hmm, prev_pos, sites[i], hmm->set_tprob_data); + if ( hmm->set_tprob ) hmm->set_tprob(hmm, prev_pos, sites[i], hmm->set_tprob_data, hmm->curr_tprob); prev_pos = sites[i]; double norm = 0; @@ -307,7 +333,7 @@ void hmm_run_baum_welch(hmm_t *hmm, int n, double *eprobs, uint32_t *sites) int pos_diff = sites[n-i-1] == prev_pos ? 0 : prev_pos - sites[n-i-1] - 1; _set_tprob(hmm, pos_diff); - if ( hmm->set_tprob ) hmm->set_tprob(hmm, sites[n-i-1], prev_pos, hmm->set_tprob_data); + if ( hmm->set_tprob ) hmm->set_tprob(hmm, sites[n-i-1], prev_pos, hmm->set_tprob_data, hmm->curr_tprob); prev_pos = sites[n-i-1]; double bwd_norm = 0; diff --git a/HMM.h b/HMM.h index 2fb141242..5d21e64da 100644 --- a/HMM.h +++ b/HMM.h @@ -31,28 +31,7 @@ typedef struct _hmm_t hmm_t; -typedef void (*set_tprob_f) (hmm_t *hmm, uint32_t prev_pos, uint32_t pos, void *data); - -struct _hmm_t -{ - int nstates; // number of states - - double *vprob, *vprob_tmp; // viterbi probs [nstates] - uint8_t *vpath; // viterbi path [nstates*nvpath] - double *bwd, *bwd_tmp; // bwd probs [nstates] - double *fwd; // fwd probs [nstates*(nfwd+1)] - int nvpath, nfwd; - - int ntprob_arr; // number of pre-calculated tprob matrices - double *curr_tprob, *tmp; // Temporary arrays; curr_tprob is short lived, valid only for - // one site (that is, one step of Viterbi algorithm) - double *tprob_arr; // Array of transition matrices, precalculated to ntprob_arr - // positions. The first matrix is the initial tprob matrix - // set by hmm_init() or hmm_set_tprob() - set_tprob_f set_tprob; // Optional user function to set / modify transition probabilities - // at each site (one step of Viterbi algorithm) - void *set_tprob_data; -}; +typedef void (*set_tprob_f) (hmm_t *hmm, uint32_t prev_pos, uint32_t pos, void *data, double *tprob); /** * hmm_init() - initialize HMM @@ -65,6 +44,14 @@ struct _hmm_t hmm_t *hmm_init(int nstates, double *tprob, int ntprob); void hmm_set_tprob(hmm_t *hmm, double *tprob, int ntprob); +/** + * hmm_get_tprob() - return the array of transition matrices, precalculated + * to ntprob positions. The first matrix is the initial tprob matrix + * set by hmm_init() or hmm_set_tprob() + */ +double *hmm_get_tprob(hmm_t *hmm); +int hmm_get_nstates(hmm_t *hmm); + /** * hmm_set_tprob_func() - custom setter of transition probabilities */ @@ -82,17 +69,26 @@ void hmm_set_tprob_func(hmm_t *hmm, set_tprob_f set_tprob, void *data); */ void hmm_run_viterbi(hmm_t *hmm, int nsites, double *eprob, uint32_t *sites); +/** + * hmm_get_viterbi_path() - the viterbi path: state at ith site is the + * (nstates*isite)-th element + */ +uint8_t *hmm_get_viterbi_path(hmm_t *hmm); + /** * hmm_run_fwd_bwd() - run the forward-backward algorithm * @nsites: number of sites * @eprob: emission probabilities for each site and state (nsites x nstates) * @sites: list of positions - * - * When done, hmm->fwd[] contains the calculated fwd*bwd probabilities. The - * probability of i-th state at j-th site can be accessed as fwd[j*nstates+i]. */ void hmm_run_fwd_bwd(hmm_t *hmm, int nsites, double *eprob, uint32_t *sites); +/** + * hmm_get_fwd_bwd_prob() - the probability of i-th state at j-th site can + * be accessed as fwd_bwd[j*nstates+i]. + */ +double *hmm_get_fwd_bwd_prob(hmm_t *hmm); + /** * hmm_run_baum_welch() - run one iteration of Baum-Welch algorithm * @nsites: number of sites @@ -104,6 +100,7 @@ void hmm_run_fwd_bwd(hmm_t *hmm, int nsites, double *eprob, uint32_t *sites); * are not updated. */ void hmm_run_baum_welch(hmm_t *hmm, int nsites, double *eprob, uint32_t *sites); + void hmm_destroy(hmm_t *hmm); #endif diff --git a/vcfcnv.c b/vcfcnv.c index 7011795c3..5c82a3433 100644 --- a/vcfcnv.c +++ b/vcfcnv.c @@ -541,21 +541,23 @@ static void cnv_flush_viterbi(args_t *args) hmm_set_tprob(args->hmm, args->tprob, 10000); while ( args->baum_welch_th!=0 ) { - double ori_ii = avg_ii_prob(hmm->nstates,hmm->tprob_arr); + int nstates = hmm_get_nstates(hmm); + double ori_ii = avg_ii_prob(nstates,hmm_get_tprob(hmm)); hmm_run_baum_welch(hmm, args->nsites, args->eprob, args->sites); - double new_ii = avg_ii_prob(hmm->nstates,hmm->tprob_arr); + double new_ii = avg_ii_prob(nstates,hmm_get_tprob(hmm)); fprintf(stderr,"%e\t%e\t%e\n", ori_ii,new_ii,new_ii-ori_ii); - double *tprob = init_tprob_matrix(hmm->nstates, 1-new_ii, args->same_prob); + double *tprob = init_tprob_matrix(nstates, 1-new_ii, args->same_prob); hmm_set_tprob(args->hmm, tprob, 10000); + double *tprob_arr = hmm_get_tprob(hmm); free(tprob); if ( fabs(new_ii - ori_ii) < args->baum_welch_th ) { int i,j; - for (i=0; instates; i++) + for (i=0; instates; j++) + for (j=0; jtprob_arr,hmm->nstates,j,i)); + printf(" %.15f", MAT(tprob_arr,nstates,j,i)); } printf("\n"); } @@ -567,12 +569,13 @@ static void cnv_flush_viterbi(args_t *args) // Output the results - double qual = 0; - int i,j, isite, start_cn = hmm->vpath[0], start_pos = args->sites[0], istart_pos = 0; + uint8_t *vpath = hmm_get_viterbi_path(hmm); + double qual = 0, *fwd = hmm_get_fwd_bwd_prob(hmm); + int i,j, isite, start_cn = vpath[0], start_pos = args->sites[0], istart_pos = 0; for (isite=0; isitensites; isite++) { - int state = hmm->vpath[args->nstates*isite]; - double *pval = hmm->fwd + isite*args->nstates; + int state = vpath[args->nstates*isite]; + double *pval = fwd + isite*args->nstates; qual += pval[start_cn]; diff --git a/vcfroh.c b/vcfroh.c index 6ab2fc024..bb7653705 100644 --- a/vcfroh.c +++ b/vcfroh.c @@ -78,8 +78,8 @@ typedef struct _args_t } args_t; -void set_tprob_genmap(hmm_t *hmm, uint32_t prev_pos, uint32_t pos, void *data); -void set_tprob_recrate(hmm_t *hmm, uint32_t prev_pos, uint32_t pos, void *data); +void set_tprob_genmap(hmm_t *hmm, uint32_t prev_pos, uint32_t pos, void *data, double *tprob); +void set_tprob_recrate(hmm_t *hmm, uint32_t prev_pos, uint32_t pos, void *data, double *tprob); void *smalloc(size_t size) { @@ -268,24 +268,24 @@ static double get_genmap_rate(args_t *args, int start, int end) return rate; } -void set_tprob_genmap(hmm_t *hmm, uint32_t prev_pos, uint32_t pos, void *data) +void set_tprob_genmap(hmm_t *hmm, uint32_t prev_pos, uint32_t pos, void *data, double *tprob) { args_t *args = (args_t*) data; double ci = get_genmap_rate(args, pos - prev_pos, pos); - MAT(hmm->curr_tprob,2,STATE_HW,STATE_HW) *= 1-ci; - MAT(hmm->curr_tprob,2,STATE_HW,STATE_AZ) *= ci; - MAT(hmm->curr_tprob,2,STATE_AZ,STATE_HW) *= ci; - MAT(hmm->curr_tprob,2,STATE_AZ,STATE_AZ) *= 1-ci; + MAT(tprob,2,STATE_HW,STATE_HW) *= 1-ci; + MAT(tprob,2,STATE_HW,STATE_AZ) *= ci; + MAT(tprob,2,STATE_AZ,STATE_HW) *= ci; + MAT(tprob,2,STATE_AZ,STATE_AZ) *= 1-ci; } -void set_tprob_recrate(hmm_t *hmm, uint32_t prev_pos, uint32_t pos, void *data) +void set_tprob_recrate(hmm_t *hmm, uint32_t prev_pos, uint32_t pos, void *data, double *tprob) { args_t *args = (args_t*) data; double ci = (pos - prev_pos) * args->rec_rate; - MAT(hmm->curr_tprob,2,STATE_HW,STATE_HW) *= 1-ci; - MAT(hmm->curr_tprob,2,STATE_HW,STATE_AZ) *= ci; - MAT(hmm->curr_tprob,2,STATE_AZ,STATE_HW) *= ci; - MAT(hmm->curr_tprob,2,STATE_AZ,STATE_AZ) *= 1-ci; + MAT(tprob,2,STATE_HW,STATE_HW) *= 1-ci; + MAT(tprob,2,STATE_HW,STATE_AZ) *= ci; + MAT(tprob,2,STATE_AZ,STATE_HW) *= ci; + MAT(tprob,2,STATE_AZ,STATE_AZ) *= 1-ci; } @@ -328,9 +328,10 @@ static void flush_viterbi(args_t *args) hmm_run_viterbi(args->hmm, args->nsites, args->eprob, args->sites); const char *chr = bcf_hdr_id2name(args->hdr,args->prev_rid); + uint8_t *vpath = hmm_get_viterbi_path(args->hmm); for (i=0; insites; i++) { - printf("%s\t%d\t%d\t..\n", chr,args->sites[i]+1,args->hmm->vpath[i*2]==STATE_AZ ? 1 : 0); + printf("%s\t%d\t%d\t..\n", chr,args->sites[i]+1,vpath[i*2]==STATE_AZ ? 1 : 0); } return; } @@ -341,8 +342,9 @@ static void flush_viterbi(args_t *args) int niter = 0; do { - t2az_prev = MAT(args->hmm->tprob_arr,2,1,0); //args->t2AZ; - t2hw_prev = MAT(args->hmm->tprob_arr,2,0,1); //args->t2HW; + double *tprob_arr = hmm_get_tprob(args->hmm); + t2az_prev = MAT(tprob_arr,2,1,0); //args->t2AZ; + t2hw_prev = MAT(tprob_arr,2,0,1); //args->t2HW; double tcounts[] = { 0,0,0,0 }; for (i=0; inrids; i++) { @@ -353,15 +355,17 @@ static void flush_viterbi(args_t *args) hmm_run_viterbi(args->hmm, nsites, args->eprob+ioff*2, args->sites+ioff); // what transitions were observed: add to the total counts + uint8_t *vpath = hmm_get_viterbi_path(args->hmm); for (j=1; jhmm->vpath[2*(j-1)]; - int curr_state = args->hmm->vpath[2*j]; + int prev_state = vpath[2*(j-1)]; + int curr_state = vpath[2*j]; MAT(tcounts,2,curr_state,prev_state) += 1; } } + // update the transition matrix tprob for (i=0; i<2; i++) { @@ -375,15 +379,17 @@ static void flush_viterbi(args_t *args) else hmm_set_tprob(args->hmm, tcounts, 10000); - deltaz = fabs(MAT(args->hmm->tprob_arr,2,1,0)-t2az_prev); - delthw = fabs(MAT(args->hmm->tprob_arr,2,0,1)-t2hw_prev); + tprob_arr = hmm_get_tprob(args->hmm); + deltaz = fabs(MAT(tprob_arr,2,1,0)-t2az_prev); + delthw = fabs(MAT(tprob_arr,2,0,1)-t2hw_prev); niter++; fprintf(stderr,"%d: %f %f\n", niter,deltaz,delthw); } while ( deltaz > 0.0 || delthw > 0.0 ); fprintf(stderr, "Viterbi training converged in %d iterations to", niter); - for (i=0; i<2; i++) for (j=0; j<2; j++) fprintf(stderr, " %f", MAT(args->hmm->tprob_arr,2,i,j)); + double *tprob_arr = hmm_get_tprob(args->hmm); + for (i=0; i<2; i++) for (j=0; j<2; j++) fprintf(stderr, " %f", MAT(tprob_arr,2,i,j)); fprintf(stderr, "\n"); // output the results @@ -392,11 +398,12 @@ static void flush_viterbi(args_t *args) int ioff = args->rid_offs[i]; int nsites = (i+1==args->nrids ? args->nsites : args->rid_offs[i+1]) - ioff; hmm_run_viterbi(args->hmm, nsites, args->eprob+ioff*2, args->sites+ioff); + uint8_t *vpath = hmm_get_viterbi_path(args->hmm); const char *chr = bcf_hdr_id2name(args->hdr,args->rids[i]); for (j=0; jsites[ioff+j]+1,args->hmm->vpath[j*2]==STATE_AZ ? 1 : 0); + printf("%s\t%d\t%d\t..\n", chr,args->sites[ioff+j]+1,vpath[j*2]==STATE_AZ ? 1 : 0); } } } From f506244ff159856ba03f327a34b5830b0b8d4401 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Mon, 29 Jun 2015 14:42:14 +0100 Subject: [PATCH 010/211] RoH bugfix: Transition probabilities must scale to 1 --- HMM.c | 2 +- HMM.h | 2 +- vcfcnv.c | 2 +- vcfroh.c | 22 ++++++++++------------ 4 files changed, 13 insertions(+), 15 deletions(-) diff --git a/HMM.c b/HMM.c index f20f91797..78501ca55 100644 --- a/HMM.c +++ b/HMM.c @@ -1,6 +1,6 @@ /* The MIT License - Copyright (c) 2014 Genome Research Ltd. + Copyright (c) 2014-2015 Genome Research Ltd. Author: Petr Danecek diff --git a/HMM.h b/HMM.h index 5d21e64da..3f5e0f10a 100644 --- a/HMM.h +++ b/HMM.h @@ -1,6 +1,6 @@ /* The MIT License - Copyright (c) 2014 Genome Research Ltd. + Copyright (c) 2014-2015 Genome Research Ltd. Author: Petr Danecek diff --git a/vcfcnv.c b/vcfcnv.c index 5c82a3433..d3d777b26 100644 --- a/vcfcnv.c +++ b/vcfcnv.c @@ -1,6 +1,6 @@ /* The MIT License - Copyright (c) 2014 Genome Research Ltd. + Copyright (c) 2014-2015 Genome Research Ltd. Author: Petr Danecek diff --git a/vcfroh.c b/vcfroh.c index bb7653705..69a1727c8 100644 --- a/vcfroh.c +++ b/vcfroh.c @@ -1,6 +1,6 @@ /* vcfroh.c -- HMM model for detecting runs of autozygosity. - Copyright (C) 2013-2014 Genome Research Ltd. + Copyright (C) 2013-2015 Genome Research Ltd. Author: Petr Danecek @@ -272,20 +272,20 @@ void set_tprob_genmap(hmm_t *hmm, uint32_t prev_pos, uint32_t pos, void *data, d { args_t *args = (args_t*) data; double ci = get_genmap_rate(args, pos - prev_pos, pos); - MAT(tprob,2,STATE_HW,STATE_HW) *= 1-ci; MAT(tprob,2,STATE_HW,STATE_AZ) *= ci; MAT(tprob,2,STATE_AZ,STATE_HW) *= ci; - MAT(tprob,2,STATE_AZ,STATE_AZ) *= 1-ci; + MAT(tprob,2,STATE_AZ,STATE_AZ) = 1 - MAT(tprob,2,STATE_HW,STATE_AZ); + MAT(tprob,2,STATE_HW,STATE_HW) = 1 - MAT(tprob,2,STATE_AZ,STATE_HW); } void set_tprob_recrate(hmm_t *hmm, uint32_t prev_pos, uint32_t pos, void *data, double *tprob) { args_t *args = (args_t*) data; double ci = (pos - prev_pos) * args->rec_rate; - MAT(tprob,2,STATE_HW,STATE_HW) *= 1-ci; MAT(tprob,2,STATE_HW,STATE_AZ) *= ci; MAT(tprob,2,STATE_AZ,STATE_HW) *= ci; - MAT(tprob,2,STATE_AZ,STATE_AZ) *= 1-ci; + MAT(tprob,2,STATE_AZ,STATE_AZ) = 1 - MAT(tprob,2,STATE_HW,STATE_AZ); + MAT(tprob,2,STATE_HW,STATE_HW) = 1 - MAT(tprob,2,STATE_AZ,STATE_HW); } @@ -301,19 +301,17 @@ void set_tprob_recrate(hmm_t *hmm, uint32_t prev_pos, uint32_t pos, void *data, * Transition probabilities: * tAZ = P(AZ|HW) .. parameter * tHW = P(HW|AZ) .. parameter - * P(AZ|AZ) = 1 - P(HW|AZ) = 1 - tHW - * P(HW|HW) = 1 - P(AZ|HW) = 1 - tAZ * * ci = P_i(C) .. probability of cross-over at site i, from genetic map * * AZi = P_i(AZ) .. probability of site i being AZ/non-AZ, scaled so that AZi+HWi = 1 * HWi = P_i(HW) * - * P_i(AZ|AZ) = P(AZ|AZ) * (1-ci) * AZ{i-1} = (1-tHW) * (1-ci) * AZ{i-1} * P_i(AZ|HW) = P(AZ|HW) * ci * HW{i-1} = tAZ * ci * (1 - AZ{i-1}) - * - * P_i(HW|HW) = P(HW|HW) * (1-ci) * HW{i-1} = (1-tAZ) * (1-ci) * (1 - AZ{i-1}) * P_i(HW|AZ) = P(HW|AZ) * ci * AZ{i-1} = tHW * ci * AZ{i-1} + * P_i(AZ|AZ) = 1 - P_i(HW|AZ) + * P_i(HW|HW) = 1 - P_i(AZ|HW) + * */ static void flush_viterbi(args_t *args) @@ -668,8 +666,8 @@ static void usage(args_t *args) fprintf(stderr, " -T, --targets-file similar to -R but streams rather than index-jumps\n"); fprintf(stderr, "\n"); fprintf(stderr, "HMM Options:\n"); - fprintf(stderr, " -a, --hw-to-az P(AZ|HW) transition probability from AZ (autozygous) to HW (Hardy-Weinberg) state [1e-8]\n"); - fprintf(stderr, " -H, --az-to-hw P(HW|AZ) transition probability from HW to AZ state [1e-7]\n"); + fprintf(stderr, " -a, --hw-to-az P(AZ|HW) transition probability from HW (Hardy-Weinberg) to AZ (autozygous) state [1e-1]\n"); + fprintf(stderr, " -H, --az-to-hw P(HW|AZ) transition probability from AZ to HW state [1e-1]\n"); fprintf(stderr, " -V, --viterbi-training perform Viterbi training to estimate transition probabilities\n"); fprintf(stderr, "\n"); exit(1); From 3ba5f38ced4e3938348fa231a2f3d794ee43bc5a Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Tue, 30 Jun 2015 16:41:02 +0100 Subject: [PATCH 011/211] New bcftools roh --AF-dflt option; changed -a,-H defaults; fixed a bug in -e - --- bcftools.h | 8 ++++++++ doc/bcftools.txt | 10 ++++++---- vcfcnv.c | 7 ------- vcfroh.c | 46 ++++++++++++++++++++++++++++++---------------- 4 files changed, 44 insertions(+), 27 deletions(-) diff --git a/bcftools.h b/bcftools.h index 7d3936ad7..6f22272b9 100644 --- a/bcftools.h +++ b/bcftools.h @@ -27,6 +27,7 @@ THE SOFTWARE. */ #include #include +#include #define FT_GZ 1 #define FT_VCF 2 @@ -60,4 +61,11 @@ static inline char gt2iupac(char a, char b) return iupac[(int)a][(int)b]; } +static inline double phred_score(double prob) +{ + if ( prob==0 ) return 99; + prob = -4.3429*log(prob); + return prob>99 ? 99 : prob; +} + #endif diff --git a/doc/bcftools.txt b/doc/bcftools.txt index 6c2cde83e..1dca046f8 100644 --- a/doc/bcftools.txt +++ b/doc/bcftools.txt @@ -1332,20 +1332,22 @@ Emission probabilities: Transition probabilities: tAZ = P(AZ|HW) .. from HW to AZ, the -a parameter tHW = P(HW|AZ) .. from AZ to HW, the -H parameter - P(AZ|AZ) = 1 - P(HW|AZ) = 1 - tHW - P(HW|HW) = 1 - P(AZ|HW) = 1 - tAZ ci = P_i(C) .. probability of cross-over at site i, from genetic map AZi = P_i(AZ) .. probability of site i being AZ/non-AZ, scaled so that AZi+HWi = 1 HWi = P_i(HW) - P_{i+1}(AZ) = oAZ * max[(1-tHW) * (1-ci) * AZ{i-1} , tAZ * ci * (1-AZ{i-1})] - P_{i+1}(HW) = oHW * max[(1-tAZ) * (1-ci) * (1-AZ{i-1}) , tHW * ci * AZ{i-1}] + P_{i+1}(AZ) = oAZ * max[(1 - tAZ * ci) * AZ{i-1} , tAZ * ci * (1-AZ{i-1})] + P_{i+1}(HW) = oHW * max[(1 - tHW * ci) * (1-AZ{i-1}) , tHW * ci * AZ{i-1}] -------------------------------------- ==== General Options: +*--AF-dflt* 'FLOAT':: + in case allele frequency is not known, use the 'FLOAT'. By default, sites where + allele frequency cannot be determined, or is 0, are skipped. + *--AF-tag* 'TAG':: use the specified INFO tag 'TAG' as an allele frequency estimate instead of the defaul AC and AN tags. Sites which do not have 'TAG' diff --git a/vcfcnv.c b/vcfcnv.c index d3d777b26..08b980c6b 100644 --- a/vcfcnv.c +++ b/vcfcnv.c @@ -518,13 +518,6 @@ static inline char copy_number_state(args_t *args, int istate, int ismpl) return code[idx]; } -static double phred_score(double prob) -{ - if ( prob==0 ) return 99; - prob = -4.3429*log(prob); - return prob>99 ? 99 : prob; -} - static double avg_ii_prob(int n, double *mat) { int i; diff --git a/vcfroh.c b/vcfroh.c index 69a1727c8..fa64b798e 100644 --- a/vcfroh.c +++ b/vcfroh.c @@ -49,7 +49,7 @@ typedef struct _args_t bcf_srs_t *files; bcf_hdr_t *hdr; double t2AZ, t2HW; // P(AZ|HW) and P(HW|AZ) parameters - double unseen_PL; + double unseen_PL, dflt_AF; char *genmap_fname; genmap_t *genmap; @@ -122,20 +122,21 @@ static void init_data(args_t *args) } free(smpls); } - else + else if ( !args->estimate_AF ) kputs(args->sample, &str); - int ret = bcf_hdr_set_samples(args->hdr, str.s, 0); - if ( ret<0 ) error("Error parsing the list of samples: %s\n", str.s); - else if ( ret>0 ) error("The %d-th sample not found in the VCF\n", ret); + if ( str.l ) + { + int ret = bcf_hdr_set_samples(args->hdr, str.s, 0); + if ( ret<0 ) error("Error parsing the list of samples: %s\n", str.s); + else if ( ret>0 ) error("The %d-th sample not found in the VCF\n", ret); + } if ( args->af_tag ) if ( !bcf_hdr_idinfo_exists(args->hdr,BCF_HL_INFO,bcf_hdr_id2int(args->hdr,BCF_DT_ID,args->af_tag)) ) error("No such INFO tag in the VCF: %s\n", args->af_tag); - if ( !bcf_sr_set_samples(args->files, str.s, 0) ) - error("Error: could not set the samples %s\n", str.s); - args->nsmpl = args->files->n_smpl; + args->nsmpl = bcf_hdr_nsamples(args->hdr); args->ismpl = bcf_hdr_id2int(args->hdr, BCF_DT_SAMPLE, args->sample); free(str.s); @@ -324,12 +325,16 @@ static void flush_viterbi(args_t *args) { // single viterbi pass, one chromsome hmm_run_viterbi(args->hmm, args->nsites, args->eprob, args->sites); + hmm_run_fwd_bwd(args->hmm, args->nsites, args->eprob, args->sites); + double *fwd = hmm_get_fwd_bwd_prob(args->hmm); const char *chr = bcf_hdr_id2name(args->hdr,args->prev_rid); uint8_t *vpath = hmm_get_viterbi_path(args->hmm); for (i=0; insites; i++) { - printf("%s\t%d\t%d\t..\n", chr,args->sites[i]+1,vpath[i*2]==STATE_AZ ? 1 : 0); + int state = vpath[i*2]==STATE_AZ ? 1 : 0; + double *pval = fwd + i*2; + printf("%s\t%d\t%d\t%.1f\n", chr,args->sites[i]+1, state, phred_score(1.0-pval[state])); } return; } @@ -363,13 +368,12 @@ static void flush_viterbi(args_t *args) } } - // update the transition matrix tprob for (i=0; i<2; i++) { int n = 0; for (j=0; j<2; j++) n += MAT(tcounts,2,i,j); - error("fixme: state %d not observed\n", i+1); + if ( !n) error("fixme: state %d not observed\n", i+1); for (j=0; j<2; j++) MAT(tcounts,2,i,j) /= n; } if ( args->genmap_fname || args->rec_rate > 0 ) @@ -515,7 +519,11 @@ int parse_line(args_t *args, bcf1_t *line, double *alt_freq, double *pdg) } if ( ret<0 ) return ret; - + if ( *alt_freq==0.0 ) + { + if ( args->dflt_AF==0 ) return -1; // we skip sites with AF=0 + *alt_freq = args->dflt_AF; + } // Set P(D|G) if ( args->fake_PLs ) @@ -652,6 +660,7 @@ static void usage(args_t *args) fprintf(stderr, "Usage: bcftools roh [options] \n"); fprintf(stderr, "\n"); fprintf(stderr, "General Options:\n"); + fprintf(stderr, " --AF-dflt if AF is not known, use this allele frequency [skip]\n"); fprintf(stderr, " --AF-tag use TAG for allele frequency\n"); fprintf(stderr, " --AF-file read allele frequencies from file (CHR\\tPOS\\tREF,ALT\\tAF)\n"); fprintf(stderr, " -e, --estimate-AF calculate AC,AN counts on the fly, using either all samples (\"-\") or samples listed in \n"); @@ -666,8 +675,8 @@ static void usage(args_t *args) fprintf(stderr, " -T, --targets-file similar to -R but streams rather than index-jumps\n"); fprintf(stderr, "\n"); fprintf(stderr, "HMM Options:\n"); - fprintf(stderr, " -a, --hw-to-az P(AZ|HW) transition probability from HW (Hardy-Weinberg) to AZ (autozygous) state [1e-1]\n"); - fprintf(stderr, " -H, --az-to-hw P(HW|AZ) transition probability from AZ to HW state [1e-1]\n"); + fprintf(stderr, " -a, --hw-to-az P(AZ|HW) transition probability from HW (Hardy-Weinberg) to AZ (autozygous) state [6.7e-8]\n"); + fprintf(stderr, " -H, --az-to-hw P(HW|AZ) transition probability from AZ to HW state [5e-9]\n"); fprintf(stderr, " -V, --viterbi-training perform Viterbi training to estimate transition probabilities\n"); fprintf(stderr, "\n"); exit(1); @@ -679,8 +688,8 @@ int main_vcfroh(int argc, char *argv[]) args_t *args = (args_t*) calloc(1,sizeof(args_t)); args->argc = argc; args->argv = argv; args->files = bcf_sr_init(); - args->t2AZ = 1e-1; - args->t2HW = 1e-1; + args->t2AZ = 6.7e-8; + args->t2HW = 5e-9; args->rec_rate = 0; int regions_is_file = 0, targets_is_file = 0; @@ -688,6 +697,7 @@ int main_vcfroh(int argc, char *argv[]) { {"AF-tag",1,0,0}, {"AF-file",1,0,1}, + {"AF-dflt",1,0,2}, {"estimate-AF",1,0,'e'}, {"GTs-only",1,0,'G'}, {"sample",1,0,'s'}, @@ -710,6 +720,10 @@ int main_vcfroh(int argc, char *argv[]) switch (c) { case 0: args->af_tag = optarg; naf_opts++; break; case 1: args->af_fname = optarg; naf_opts++; break; + case 2: + args->dflt_AF = strtod(optarg,&tmp); + if ( *tmp ) error("Could not parse: --AF-dflt %s\n", optarg); + break; case 'e': args->estimate_AF = optarg; naf_opts++; break; case 'I': args->snps_only = 1; break; case 'G': From aea4cf9bc605f2172769754fd7bd11e19487afa3 Mon Sep 17 00:00:00 2001 From: John Marshall Date: Mon, 6 Jul 2015 11:25:45 +0100 Subject: [PATCH 012/211] Fix polysomy dependencies [minor] --- Makefile | 3 ++- 1 file changed, 2 insertions(+), 1 deletion(-) diff --git a/Makefile b/Makefile index 92139048f..bb75b8503 100644 --- a/Makefile +++ b/Makefile @@ -159,7 +159,8 @@ kmin.o: kmin.c kmin.h mcall.o: mcall.c $(HTSDIR)/htslib/kfunc.h $(call_h) prob1.o: prob1.c $(prob1_h) vcmp.o: vcmp.c $(htslib_hts_h) vcmp.h -polysomy.o: polysomy.c $(htslib_hts_h) +polysomy.o: polysomy.c $(htslib_vcf_h) $(htslib_synced_bcf_reader_h) $(bcftools_h) peakfit.h +peakfit.o: peakfit.c peakfit.h $(htslib_hts_h) $(HTSDIR)/htslib/kstring.h consensus.o: consensus.c $(htslib_hts_h) $(HTSDIR)/htslib/kseq.h rbuf.h $(bcftools_h) $(HTSDIR)/htslib/regidx.h version.o: version.h version.c From da26c063287397535e82e3b3a6ef3328eedf0c49 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Mon, 29 Jun 2015 07:27:03 +0100 Subject: [PATCH 013/211] plot-vcfstats: Fix edge case in tstv_by_qual plot, see #229 --- plot-vcfstats | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/plot-vcfstats b/plot-vcfstats index 38d93355c..2ed9ec7f5 100755 --- a/plot-vcfstats +++ b/plot-vcfstats @@ -1281,7 +1281,7 @@ sub plot_tstv_by_QUAL \\tfor row in reader: \\t\\tif row[0][0] != '#': dat.append([float(x) for x in row]) - if plot_tstv_by_qual: + if plot_tstv_by_qual and len(dat)>2: \\tfig = plt.figure(figsize=($$opts{img_width},$$opts{img_height})) \\tax1 = fig.add_subplot(111) \\tax1.plot([row[1] for row in dat], [row[2] for row in dat], '^-', ms=3, mec='$$opts{id2col}[$id]', color='$$opts{id2col}[$id]') From 4eec7d5f82e677a0d4f4d75e20c1184fb9adb5f6 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Mon, 16 Mar 2015 13:30:16 +0000 Subject: [PATCH 014/211] concat: new --compact-PS switch --- vcfconcat.c | 43 +++++++++++++++++++++++++++++++++---------- 1 file changed, 33 insertions(+), 10 deletions(-) diff --git a/vcfconcat.c b/vcfconcat.c index aa46b1032..ec46fc5fa 100644 --- a/vcfconcat.c +++ b/vcfconcat.c @@ -50,6 +50,7 @@ typedef struct _args_t char **argv, *output_fname, *file_list, **fnames, *regions_list; int argc, nfnames, allow_overlaps, phased_concat, remove_dups, regions_is_file; + int compact_PS, phase_set_changed; } args_t; @@ -246,7 +247,11 @@ static void phased_flush(args_t *args) bcf_translate(args->out_hdr, args->files->readers[0].header, arec); if ( args->nswap ) phase_update(args, args->out_hdr, arec); - bcf_update_format_int32(args->out_hdr,arec,"PS",args->phase_set,nsmpl); + if ( !args->compact_PS || args->phase_set_changed ) + { + bcf_update_format_int32(args->out_hdr,arec,"PS",args->phase_set,nsmpl); + args->phase_set_changed = 0; + } bcf_write(args->out_fh, args->out_hdr, arec); if ( arec->pos < args->prev_pos_check ) error("FIXME, disorder: %s:%d vs %d [1]\n", bcf_seqname(args->files->readers[0].header,arec),arec->pos+1,args->prev_pos_check+1); @@ -283,11 +288,20 @@ static void phased_flush(args_t *args) bcf_update_format_int32(args->out_hdr,brec,"PQ",args->phase_qual,nsmpl); PQ_printed = 1; for (j=0; jphase_qual[j] < args->min_PQ ) args->phase_set[j] = brec->pos+1; + if ( args->phase_qual[j] < args->min_PQ ) + { + args->phase_set[j] = brec->pos+1; + args->phase_set_changed = 1; + } + else if ( args->compact_PS ) args->phase_set[j] = bcf_int32_missing; } if ( args->nswap ) phase_update(args, args->out_hdr, brec); - bcf_update_format_int32(args->out_hdr,brec,"PS",args->phase_set,nsmpl); + if ( !args->compact_PS || args->phase_set_changed ) + { + bcf_update_format_int32(args->out_hdr,brec,"PS",args->phase_set,nsmpl); + args->phase_set_changed = 0; + } bcf_write(args->out_fh, args->out_hdr, brec); if ( brec->pos < args->prev_pos_check ) error("FIXME, disorder: %s:%d vs %d [2]\n", bcf_seqname(args->files->readers[1].header,brec),brec->pos+1,args->prev_pos_check+1); @@ -311,6 +325,7 @@ static void phased_push(args_t *args, bcf1_t *arec, bcf1_t *brec) for (i=0; iphase_set[i] = arec->pos+1; + args->phase_set_changed = 1; if ( args->seen_seq[chr_id] ) error("The chromosome block %s is not contiguous\n", bcf_seqname(args->files->readers[0].header,arec)); args->seen_seq[chr_id] = 1; @@ -323,7 +338,11 @@ static void phased_push(args_t *args, bcf1_t *arec, bcf1_t *brec) bcf_translate(args->out_hdr, args->files->readers[0].header, arec); if ( args->nswap ) phase_update(args, args->out_hdr, arec); - bcf_update_format_int32(args->out_hdr,arec,"PS",args->phase_set,nsmpl); + if ( !args->compact_PS || args->phase_set_changed ) + { + bcf_update_format_int32(args->out_hdr,arec,"PS",args->phase_set,nsmpl); + args->phase_set_changed = 0; + } bcf_write(args->out_fh, args->out_hdr, arec); if ( arec->pos < args->prev_pos_check ) @@ -511,7 +530,7 @@ static void usage(args_t *args) { fprintf(stderr, "\n"); fprintf(stderr, "About: Concatenate or combine VCF/BCF files. All source files must have the same sample\n"); - fprintf(stderr, " columns appearing in the same order. Can be used, for example, to\n"); + fprintf(stderr, " columns appearing in the same order. The program can be used, for example, to\n"); fprintf(stderr, " concatenate chromosome VCFs into one VCF, or combine a SNP VCF and an indel\n"); fprintf(stderr, " VCF into one. The input files must be sorted by chr and position. The files\n"); fprintf(stderr, " must be given in the correct order to produce sorted VCF on output unless\n"); @@ -520,14 +539,15 @@ static void usage(args_t *args) fprintf(stderr, "\n"); fprintf(stderr, "Options:\n"); fprintf(stderr, " -a, --allow-overlaps First coordinate of the next file can precede last record of the current file.\n"); - fprintf(stderr, " -D, --remove-duplicates Output only once records present in multiple files.\n"); + fprintf(stderr, " -c, --compact-PS Do not output PS tag at each site, only at the start of a new phase set block.\n"); + fprintf(stderr, " -D, --remove-duplicates Output records present in multiple files only once.\n"); fprintf(stderr, " -f, --file-list Read the list of files from a file.\n"); fprintf(stderr, " -l, --ligate Ligate phased VCFs by matching phase at overlapping haplotypes\n"); - fprintf(stderr, " -q, --min-PQ Break phase set if phasing quality is lower than [30]\n"); fprintf(stderr, " -o, --output Write output to a file [standard output]\n"); fprintf(stderr, " -O, --output-type b: compressed BCF, u: uncompressed BCF, z: compressed VCF, v: uncompressed VCF [v]\n"); - fprintf(stderr, " -r, --regions restrict to comma-separated list of regions\n"); - fprintf(stderr, " -R, --regions-file restrict to regions listed in a file\n"); + fprintf(stderr, " -q, --min-PQ Break phase set if phasing quality is lower than [30]\n"); + fprintf(stderr, " -r, --regions Restrict to comma-separated list of regions\n"); + fprintf(stderr, " -R, --regions-file Restrict to regions listed in a file\n"); fprintf(stderr, "\n"); exit(1); } @@ -543,6 +563,7 @@ int main_vcfconcat(int argc, char *argv[]) static struct option loptions[] = { + {"compact-PS",0,0,'c'}, {"regions",1,0,'r'}, {"regions-file",1,0,'R'}, {"remove-duplicates",0,0,'D'}, @@ -555,9 +576,10 @@ int main_vcfconcat(int argc, char *argv[]) {0,0,0,0} }; char *tmp; - while ((c = getopt_long(argc, argv, "h:?o:O:f:alq:Dr:R:",loptions,NULL)) >= 0) + while ((c = getopt_long(argc, argv, "h:?o:O:f:alq:Dr:R:c",loptions,NULL)) >= 0) { switch (c) { + case 'c': args->compact_PS = 1; break; case 'r': args->regions_list = optarg; break; case 'R': args->regions_list = optarg; args->regions_is_file = 1; break; case 'D': args->remove_dups = 1; break; @@ -591,6 +613,7 @@ int main_vcfconcat(int argc, char *argv[]) optind++; } if ( args->allow_overlaps && args->phased_concat ) args->allow_overlaps = 0; + if ( args->compact_PS && !args->phased_concat ) error("The -c option is intended only with -l\n"); if ( args->file_list ) { if ( args->nfnames ) error("Cannot combine -l with file names on command line.\n"); From 4abc0f289f1f650d5d620cd4c7d4288edaaf8e75 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Wed, 29 Apr 2015 11:43:08 +0100 Subject: [PATCH 015/211] concat -d option to remove duplicates based on one of the collapse srings: --- vcfconcat.c | 23 ++++++++++++++++++----- 1 file changed, 18 insertions(+), 5 deletions(-) diff --git a/vcfconcat.c b/vcfconcat.c index ec46fc5fa..c6db1d7d9 100644 --- a/vcfconcat.c +++ b/vcfconcat.c @@ -48,8 +48,8 @@ typedef struct _args_t int nbuf, mbuf, prev_chr, min_PQ, prev_pos_check; int32_t *GTa, *GTb, mGTa, mGTb, *phase_qual, *phase_set; - char **argv, *output_fname, *file_list, **fnames, *regions_list; - int argc, nfnames, allow_overlaps, phased_concat, remove_dups, regions_is_file; + char **argv, *output_fname, *file_list, **fnames, *remove_dups, *regions_list; + int argc, nfnames, allow_overlaps, phased_concat, regions_is_file; int compact_PS, phase_set_changed; } args_t; @@ -126,6 +126,16 @@ static void init_data(args_t *args) if ( bcf_sr_set_regions(args->files, args->regions_list, args->regions_is_file)<0 ) error("Failed to read the regions: %s\n", args->regions_list); } + if ( args->remove_dups ) + { + if ( !strcmp(args->remove_dups,"snps") ) args->files->collapse |= COLLAPSE_SNPS; + else if ( !strcmp(args->remove_dups,"indels") ) args->files->collapse |= COLLAPSE_INDELS; + else if ( !strcmp(args->remove_dups,"both") ) args->files->collapse |= COLLAPSE_SNPS | COLLAPSE_INDELS; + else if ( !strcmp(args->remove_dups,"any") ) args->files->collapse |= COLLAPSE_ANY; + else if ( !strcmp(args->remove_dups,"all") ) args->files->collapse |= COLLAPSE_ANY; + else if ( !strcmp(args->remove_dups,"none") ) args->files->collapse = COLLAPSE_NONE; + else error("The -D string \"%s\" not recognised.\n", args->remove_dups); + } for (i=0; infnames; i++) if ( !bcf_sr_add_reader(args->files,args->fnames[i]) ) error("Failed to open %s: %s\n", args->fnames[i],bcf_sr_strerror(args->files->errnum)); } @@ -540,7 +550,8 @@ static void usage(args_t *args) fprintf(stderr, "Options:\n"); fprintf(stderr, " -a, --allow-overlaps First coordinate of the next file can precede last record of the current file.\n"); fprintf(stderr, " -c, --compact-PS Do not output PS tag at each site, only at the start of a new phase set block.\n"); - fprintf(stderr, " -D, --remove-duplicates Output records present in multiple files only once.\n"); + fprintf(stderr, " -d, --rm-dups Output duplicate records present in multiple files only once: \n"); + fprintf(stderr, " -D, --remove-duplicates Alias for -d none\n"); fprintf(stderr, " -f, --file-list Read the list of files from a file.\n"); fprintf(stderr, " -l, --ligate Ligate phased VCFs by matching phase at overlapping haplotypes\n"); fprintf(stderr, " -o, --output Write output to a file [standard output]\n"); @@ -567,6 +578,7 @@ int main_vcfconcat(int argc, char *argv[]) {"regions",1,0,'r'}, {"regions-file",1,0,'R'}, {"remove-duplicates",0,0,'D'}, + {"rm-dups",1,0,'d'}, {"allow-overlaps",0,0,'a'}, {"ligate",0,0,'l'}, {"output",1,0,'o'}, @@ -576,13 +588,14 @@ int main_vcfconcat(int argc, char *argv[]) {0,0,0,0} }; char *tmp; - while ((c = getopt_long(argc, argv, "h:?o:O:f:alq:Dr:R:c",loptions,NULL)) >= 0) + while ((c = getopt_long(argc, argv, "h:?o:O:f:alq:Dd:r:R:c",loptions,NULL)) >= 0) { switch (c) { case 'c': args->compact_PS = 1; break; case 'r': args->regions_list = optarg; break; case 'R': args->regions_list = optarg; args->regions_is_file = 1; break; - case 'D': args->remove_dups = 1; break; + case 'd': args->remove_dups = optarg; break; + case 'D': args->remove_dups = "none"; break; case 'q': args->min_PQ = strtol(optarg,&tmp,10); if ( *tmp ) error("Could not parse argument: --min-PQ %s\n", optarg); From 566df3cccb86b5677dbb75c8acc9f69e34469746 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Wed, 29 Apr 2015 13:22:50 +0100 Subject: [PATCH 016/211] concat -l: Print warning and proceed if GT not present --- vcfconcat.c | 24 +++++++++++++++++++++--- 1 file changed, 21 insertions(+), 3 deletions(-) diff --git a/vcfconcat.c b/vcfconcat.c index c6db1d7d9..d480279e7 100644 --- a/vcfconcat.c +++ b/vcfconcat.c @@ -1,6 +1,6 @@ /* vcfconcat.c -- Concatenate or combine VCF/BCF files. - Copyright (C) 2013-2014 Genome Research Ltd. + Copyright (C) 2013-2015 Genome Research Ltd. Author: Petr Danecek @@ -201,6 +201,7 @@ int vcf_write_line(htsFile *fp, kstring_t *line); static void phase_update(args_t *args, bcf_hdr_t *hdr, bcf1_t *rec) { int i, nGTs = bcf_get_genotypes(hdr, rec, &args->GTa, &args->mGTa); + if ( nGTs <= 0 ) return; // GT field is not present for (i=0; iswap_phase[i] ) continue; @@ -220,6 +221,7 @@ static void phased_flush(args_t *args) bcf_hdr_t *bhdr = args->files->readers[1].header; int i, j, nsmpl = bcf_hdr_nsamples(args->out_hdr); + static int gt_absent_warned = 0; for (i=0; inbuf; i+=2) { @@ -227,10 +229,26 @@ static void phased_flush(args_t *args) bcf1_t *brec = args->buf[i+1]; int nGTs = bcf_get_genotypes(ahdr, arec, &args->GTa, &args->mGTa); - if ( nGTs < 0 ) error("GT is not present at %s:%d\n", bcf_seqname(ahdr,arec), arec->pos+1); + if ( nGTs < 0 ) + { + if ( !gt_absent_warned ) + { + fprintf(stderr,"GT is not present at %s:%d. (This warning is printed only once.)\n", bcf_seqname(ahdr,arec), arec->pos+1); + gt_absent_warned = 1; + } + continue; + } if ( nGTs != 2*nsmpl ) continue; // not diploid nGTs = bcf_get_genotypes(bhdr, brec, &args->GTb, &args->mGTb); - if ( nGTs < 0 ) error("GT is not present at %s:%d\n", bcf_seqname(bhdr,brec), brec->pos+1); + if ( nGTs < 0 ) + { + if ( !gt_absent_warned ) + { + fprintf(stderr,"GT is not present at %s:%d. (This warning is printed only once.)\n", bcf_seqname(bhdr,brec), brec->pos+1); + gt_absent_warned = 1; + } + continue; + } if ( nGTs != 2*nsmpl ) continue; // not diploid for (j=0; j Date: Mon, 6 Jul 2015 16:47:20 +0100 Subject: [PATCH 017/211] bcf_hdr_combine replaced by bcf_hdr_merge bcf_hdr_combine deprecated and replaced by bcf_hdr_merge in htslib (2bb9370f5a24938d8a2dc56f404e584661bf413f). Fixes #208 --- vcfconcat.c | 19 +++++++------------ vcfmerge.c | 7 +++---- 2 files changed, 10 insertions(+), 16 deletions(-) diff --git a/vcfconcat.c b/vcfconcat.c index d480279e7..f5370f1ba 100644 --- a/vcfconcat.c +++ b/vcfconcat.c @@ -73,20 +73,15 @@ static void init_data(args_t *args) { htsFile *fp = hts_open(args->fnames[i], "r"); if ( !fp ) error("Failed to open: %s\n", args->fnames[i]); bcf_hdr_t *hdr = bcf_hdr_read(fp); if ( !hdr ) error("Failed to parse header: %s\n", args->fnames[i]); - if ( !args->out_hdr ) - args->out_hdr = bcf_hdr_dup(hdr); - else - { - bcf_hdr_combine(args->out_hdr, hdr); + args->out_hdr = bcf_hdr_merge(args->out_hdr,hdr); + if ( bcf_hdr_nsamples(hdr) != bcf_hdr_nsamples(args->out_hdr) ) + error("Different number of samples in %s. Perhaps \"bcftools merge\" is what you are looking for?\n", args->fnames[i]); - if ( bcf_hdr_nsamples(hdr) != bcf_hdr_nsamples(args->out_hdr) ) - error("Different number of samples in %s. Perhaps \"bcftools merge\" is what you are looking for?\n", args->fnames[i]); + int j; + for (j=0; jout_hdr->samples[j],hdr->samples[j]) ) + error("Different sample names in %s. Perhaps \"bcftools merge\" is what you are looking for?\n", args->fnames[i]); - int j; - for (j=0; jout_hdr->samples[j],hdr->samples[j]) ) - error("Different sample names in %s. Perhaps \"bcftools merge\" is what you are looking for?\n", args->fnames[i]); - } if ( args->phased_concat ) { int ret = bcf_read(fp, hdr, line); diff --git a/vcfmerge.c b/vcfmerge.c index ea26903d3..c2d3c0880 100644 --- a/vcfmerge.c +++ b/vcfmerge.c @@ -421,11 +421,10 @@ static int info_rules_add_values(args_t *args, bcf_hdr_t *hdr, bcf1_t *line, inf int bcf_hdr_sync(bcf_hdr_t *h); -void bcf_hdr_merge(bcf_hdr_t *hw, const bcf_hdr_t *hr, const char *clash_prefix, int force_samples) +void merge_headers(bcf_hdr_t *hw, const bcf_hdr_t *hr, const char *clash_prefix, int force_samples) { // header lines - int ret = bcf_hdr_combine(hw, hr); - if ( ret!=0 ) error("Error occurred while merging the headers.\n"); + hw = bcf_hdr_merge(hw, hr); // samples int i; @@ -1911,7 +1910,7 @@ void merge_vcf(args_t *args) for (i=0; ifiles->nreaders; i++) { char buf[10]; snprintf(buf,10,"%d",i+1); - bcf_hdr_merge(args->out_hdr, args->files->readers[i].header,buf,args->force_samples); + merge_headers(args->out_hdr, args->files->readers[i].header,buf,args->force_samples); } bcf_hdr_append_version(args->out_hdr, args->argc, args->argv, "bcftools_merge"); bcf_hdr_sync(args->out_hdr); From 7e7a7dbfcd0a65bae14c02299cb4ce1a243544aa Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Wed, 13 May 2015 14:01:42 +0100 Subject: [PATCH 018/211] More control duplicate lines removal with norm (REF still not treated well) --- vcfnorm.c | 46 +++++++++++++++++++++++++++++++++------------- 1 file changed, 33 insertions(+), 13 deletions(-) diff --git a/vcfnorm.c b/vcfnorm.c index d2dd7aeed..613888002 100644 --- a/vcfnorm.c +++ b/vcfnorm.c @@ -1396,7 +1396,7 @@ static bcf1_t *mrows_flush(args_t *args) static void flush_buffer(args_t *args, htsFile *file, int n) { bcf1_t *line; - int i, k, prev_rid = -1, prev_pos = 0, prev_type = 0; + int i, k; for (i=0; irbuf); @@ -1417,16 +1417,6 @@ static void flush_buffer(args_t *args, htsFile *file, int n) continue; } } - // todo: merge with next record if POS and the type are same. For now, just discard if asked to do so. - if ( args->rmdup ) - { - int line_type = bcf_get_variant_types(args->lines[k]); - if ( prev_rid>=0 && prev_rid==args->lines[k]->rid && prev_pos==args->lines[k]->pos && prev_type==line_type ) - continue; - prev_rid = args->lines[k]->rid; - prev_pos = args->lines[k]->pos; - prev_type = line_type; - } bcf_write1(file, args->hdr, args->lines[k]); } if ( args->mrows_op==MROWS_MERGE && !args->rbuf.n ) @@ -1537,11 +1527,29 @@ static void normalize_vcf(args_t *args) bcf_hdr_append_version(args->hdr, args->argc, args->argv, "bcftools_norm"); bcf_hdr_write(out, args->hdr); + int prev_rid = -1, prev_pos = -1, prev_type = 0; while ( bcf_sr_next_line(args->files) ) { args->ntotal++; bcf1_t *line = args->files->readers[0].buffer[0]; + if ( args->rmdup ) + { + int line_type = bcf_get_variant_types(line); + if ( prev_rid>=0 && prev_rid==line->rid && prev_pos==line->pos ) + { + if ( (args->rmdup>>1)&COLLAPSE_ANY ) continue; + if ( (args->rmdup>>1)&COLLAPSE_SNPS && line_type&(VCF_SNP|VCF_MNP) && prev_type&(VCF_SNP|VCF_MNP) ) continue; + if ( (args->rmdup>>1)&COLLAPSE_INDELS && line_type&(VCF_INDEL) && prev_type&(VCF_INDEL) ) continue; + } + else + { + prev_rid = line->rid; + prev_pos = line->pos; + prev_type = 0; + } + prev_type |= line_type; + } // still on the same chromosome? int i,j,ilast = rbuf_last(&args->rbuf); @@ -1597,6 +1605,7 @@ static void usage(void) fprintf(stderr, "Options:\n"); fprintf(stderr, " -c, --check-ref check REF alleles and exit (e), warn (w), exclude (x), or set (s) bad sites [e]\n"); fprintf(stderr, " -D, --remove-duplicates remove duplicate lines of the same type.\n"); + fprintf(stderr, " -d, --rm-dup remove duplicate snps|indels|both|any\n"); fprintf(stderr, " -f, --fasta-ref reference sequence\n"); fprintf(stderr, " -m, --multiallelics <-|+>[type] split multiallelics (-) or join biallelics (+), type: snps|indels|both|any [both]\n"); fprintf(stderr, " -N, --do-not-normalize do not normalize indels (with -m or -c s)\n"); @@ -1639,6 +1648,7 @@ int main_vcfnorm(int argc, char *argv[]) {"targets-file",1,0,'T'}, {"site-win",1,0,'w'}, {"remove-duplicates",0,0,'D'}, + {"rm-dup",1,0,'d'}, {"output",1,0,'o'}, {"output-type",1,0,'O'}, {"check-ref",1,0,'c'}, @@ -1646,9 +1656,16 @@ int main_vcfnorm(int argc, char *argv[]) {0,0,0,0} }; char *tmp; - while ((c = getopt_long(argc, argv, "hr:R:f:w:Do:O:c:m:t:T:sN",loptions,NULL)) >= 0) { + while ((c = getopt_long(argc, argv, "hr:R:f:w:Dd:o:O:c:m:t:T:sN",loptions,NULL)) >= 0) { switch (c) { case 'N': args->do_indels = 0; break; + case 'd': + if ( !strcmp("snps",optarg) ) args->rmdup = COLLAPSE_SNPS<<1; + else if ( !strcmp("indels",optarg) ) args->rmdup = COLLAPSE_INDELS<<1; + else if ( !strcmp("both",optarg) ) args->rmdup = COLLAPSE_BOTH<<1; + else if ( !strcmp("any",optarg) ) args->rmdup = COLLAPSE_ANY<<1; + else error("The argument to -d not recognised: %s\n", optarg); + break; case 'm': if ( optarg[0]=='-' ) args->mrows_op = MROWS_SPLIT; else if ( optarg[0]=='+' ) args->mrows_op = MROWS_MERGE; @@ -1678,7 +1695,10 @@ int main_vcfnorm(int argc, char *argv[]) } break; case 'o': args->output_fname = optarg; break; - case 'D': args->rmdup = 1; break; + case 'D': + fprintf(stderr,"Warning: `-D` is functional but deprecated, replaced by `-d both`.\n"); + args->rmdup = COLLAPSE_NONE<<1; + break; case 's': args->strict_filter = 1; break; case 'f': args->ref_fname = optarg; break; case 'r': args->region = optarg; break; From 4bfe242e9cf28091f5fb097f8ecece6d26d3e17a Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Thu, 25 Jun 2015 15:24:52 +0100 Subject: [PATCH 019/211] Output missing FMT fields as "." rather than negative integer when querying FMT vectors, such as PL{0} --- convert.c | 36 +++++++++++++++++++++++++++++++----- 1 file changed, 31 insertions(+), 5 deletions(-) diff --git a/convert.c b/convert.c index ab7aefe7d..3e289f025 100644 --- a/convert.c +++ b/convert.c @@ -140,10 +140,22 @@ static void process_filter(convert_t *convert, bcf1_t *line, fmt_t *fmt, int isa } else kputc('.', str); } -static inline int bcf_array_ivalue(void *bcf_array, int type, int idx) +static inline int32_t bcf_array_ivalue(void *bcf_array, int type, int idx) { - if ( type==BCF_BT_INT8 ) return ((int8_t*)bcf_array)[idx]; - if ( type==BCF_BT_INT16 ) return ((int16_t*)bcf_array)[idx]; + if ( type==BCF_BT_INT8 ) + { + int8_t val = ((int8_t*)bcf_array)[idx]; + if ( val==bcf_int8_missing ) return bcf_int32_missing; + if ( val==bcf_int8_vector_end ) return bcf_int32_vector_end; + return val; + } + if ( type==BCF_BT_INT16 ) + { + int16_t val = ((int16_t*)bcf_array)[idx]; + if ( val==bcf_int16_missing ) return bcf_int32_missing; + if ( val==bcf_int16_vector_end ) return bcf_int32_vector_end; + return val; + } return ((int32_t*)bcf_array)[idx]; } static void process_info(convert_t *convert, bcf1_t *line, fmt_t *fmt, int isample, kstring_t *str) @@ -243,8 +255,22 @@ static void process_format(convert_t *convert, bcf1_t *line, fmt_t *fmt, int isa kputc('.', str); return; } - if ( fmt->fmt->type == BCF_BT_FLOAT ) ksprintf(str, "%g", ((float*)(fmt->fmt->p + isample*fmt->fmt->size))[fmt->subscript]); - else if ( fmt->fmt->type != BCF_BT_CHAR ) kputw(bcf_array_ivalue(fmt->fmt->p+isample*fmt->fmt->size,fmt->fmt->type,fmt->subscript), str); + if ( fmt->fmt->type == BCF_BT_FLOAT ) + { + float *ptr = (float*)(fmt->fmt->p + isample*fmt->fmt->size); + if ( bcf_float_is_missing(ptr[fmt->subscript]) || bcf_float_is_vector_end(ptr[fmt->subscript]) ) + kputc('.', str); + else + ksprintf(str, "%g", ptr[fmt->subscript]); + } + else if ( fmt->fmt->type != BCF_BT_CHAR ) + { + int32_t ival = bcf_array_ivalue(fmt->fmt->p+isample*fmt->fmt->size,fmt->fmt->type,fmt->subscript); + if ( ival==bcf_int32_missing || ival==bcf_int32_vector_end ) + kputc('.', str); + else + kputw(ival, str); + } else error("TODO: %s:%d .. fmt->type=%d\n", __FILE__,__LINE__, fmt->fmt->type); } else From ddc0bef5b6c1db86ad6f4dd7715db9ba74ccaa70 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Fri, 27 Feb 2015 14:18:02 +0000 Subject: [PATCH 020/211] Updated cnv command: - CNx state removed - automatic optimization of parameters to increase sensitivity when only a fraction of cells is aberrant (at the cose of decreased specificity) - LRR smoothing --- vcfcnv.c | 629 +++++++++++++++++++++++++++++++++++++++++++------------ 1 file changed, 493 insertions(+), 136 deletions(-) diff --git a/vcfcnv.c b/vcfcnv.c index 08b980c6b..6287f5bde 100644 --- a/vcfcnv.c +++ b/vcfcnv.c @@ -35,20 +35,29 @@ #include #include "bcftools.h" #include "HMM.h" +#include "rbuf.h" -#define DBG_HMM_PRN 0 +#define DBG0 0 -#define N_STATES 5 +#define N_STATES 4 #define CN0 0 #define CN1 1 #define CN2 2 #define CN3 3 -#define CNx 4 + +typedef struct +{ + float mean, dev2, norm; +} +gauss_param_t; typedef struct { char *name; - int idx; + int idx; // VCF sample index + float *lrr,*baf, baf_dev2, baf_dev2_dflt; + float cell_frac, cell_frac_dflt; + gauss_param_t gauss_param[18]; double pobs[N_STATES]; FILE *dat_fh, *cn_fh, *summary_fh; char *dat_fname, *cn_fname, *summary_fname; @@ -63,11 +72,12 @@ typedef struct _args_t sample_t query_sample, control_sample; int nstates; // number of states: N_STATES for one sample, N_STATES^2 for two samples - double baf_sigma2, lrr_sigma2; // squared std dev of B-allele frequency and LRR distribution + double lrr_dev2; // squared std dev of LRR distribution double lrr_bias, baf_bias; // LRR/BAF weights double same_prob, ij_prob; // prior of both samples being the same and the transition probability P(i|j) double err_prob; // constant probability of erroneous measurement - double pRR, pRA, pAA, pRR_dflt, pRA_dflt, pAA_dflt; + float *nonref_afs, nonref_af, nonref_af_dflt, fRR, fRA, fAA; + unsigned long int nRR, nRA, nAA; double *tprob, *tprob_arr; // array of transition matrices, precalculated up to ntprob_arr positions int ntprob_arr; @@ -77,18 +87,17 @@ typedef struct _args_t uint32_t *sites; // positions [nsites,msites] int nsites, msites; - double baum_welch_th; + double baum_welch_th, optimize_frac; float plot_th; FILE *summary_fh; char **argv, *regions_list, *summary_fname, *output_dir; char *targets_list, *af_fname; - int argc; + int argc, verbose, lrr_smooth_win; } args_t; FILE *open_file(char **fname, const char *mode, const char *fmt, ...); - static inline void hmm2cn_state(int nstates, int i, int *a, int *b) { *a = i / N_STATES; @@ -100,10 +109,10 @@ static double *init_tprob_matrix(int ndim, double ij_prob, double same_prob) double *mat = (double*) malloc(sizeof(double)*ndim*ndim); assert( ndim==N_STATES || ndim==N_STATES*N_STATES); - double pii = 1 - ij_prob*(N_STATES-1); if ( ndim==N_STATES ) // one sample { + double pii = 1 - ij_prob*(N_STATES-1); if ( pii < ij_prob ) error("Error: -x set a bit too high, P(x|x) < P(x|y): %e vs %e\n", pii,ij_prob); for (j=0; jcn_fh = open_file(&smpl->cn_fname,"w","%s/cn.%s.tab",dir,smpl->name); smpl->summary_fh = open_file(&smpl->summary_fname,"w","%s/summary.%s.tab",dir,smpl->name); fprintf(smpl->dat_fh,"# [1]Chromosome\t[2]Position\t[3]BAF\t[4]LRR\n"); - fprintf(smpl->cn_fh,"# [1]Chromosome\t[2]Position\t[3]CN\t[4]P(CN0)\t[5]P(CN1)\t[6]P(CN2)\t[7]P(CN3)\t[8]P(CNx)\n"); + fprintf(smpl->cn_fh,"# [1]Chromosome\t[2]Position\t[3]CN\t[4]P(CN0)\t[5]P(CN1)\t[6]P(CN2)\t[7]P(CN3)\n"); fprintf(smpl->summary_fh,"# RG, Regions [2]Chromosome\t[3]Start\t[4]End\t[5]Copy Number state\t[6]Quality\n"); } static void close_sample_files(sample_t *smpl) @@ -168,6 +183,7 @@ static void close_sample_files(sample_t *smpl) fclose(smpl->summary_fh); } +static double norm_cdf(double mean, double dev); static void init_data(args_t *args) { args->prev_rid = -1; @@ -292,7 +308,6 @@ static void plot_sample(args_t *args, sample_t *smpl) " heat[1][x] = cn_dat[x][3]\n" " heat[2][x] = cn_dat[x][4]\n" " heat[3][x] = cn_dat[x][5]\n" - " heat[4][x] = cn_dat[x][6]\n" " mesh = ax3.pcolormesh(xgrid, ygrid, heat, cmap='bwr_r')\n" " mesh.set_clim(vmin=-1,vmax=1)\n" " ax3.plot([x[0] for x in cn_dat],[x[1] for x in cn_dat],'.-',ms=3,color='black')\n" @@ -304,9 +319,9 @@ static void plot_sample(args_t *args, sample_t *smpl) " ax2.set_ylabel('BAF')\n" " ax3.set_ylabel('CN')\n" " ax3.set_xlabel('Coordinate (chrom '+chr+')',fontsize=10)\n" - " ax3.set_ylim(-0.1,5.1)\n" - " ax3.set_yticks([0.5,1.5,2.5,3.5,4.5])\n" - " ax3.set_yticklabels(['CN0','CN1','CN2','CN3','CN4'])\n" + " ax3.set_ylim(-0.1,4.1)\n" + " ax3.set_yticks([0.5,1.5,2.5,3.5])\n" + " ax3.set_yticklabels(['CN0','CN1','CN2','CN3'])\n" " plt.subplots_adjust(left=0.08,right=0.95,bottom=0.08,top=0.92)\n" " plt.savefig('%s/plot.%s.chr'+chr+'.png')\n" " plt.close()\n" @@ -428,7 +443,6 @@ static void create_plots(args_t *args) " heat[1][x] = cn_dat[x][3]\n" " heat[2][x] = cn_dat[x][4]\n" " heat[3][x] = cn_dat[x][5]\n" - " heat[4][x] = cn_dat[x][6]\n" " mesh = ax3.pcolormesh(xgrid, ygrid, heat, cmap='bwr')\n" " mesh.set_clim(vmin=-1,vmax=1)\n" " ax3.plot([x[0] for x in cn_dat],[x[1] for x in cn_dat],'-',ms=3,color='black',lw=1.7)\n" @@ -445,7 +459,6 @@ static void create_plots(args_t *args) " heat[1][x] = cn_dat[x][3]\n" " heat[2][x] = cn_dat[x][4]\n" " heat[3][x] = cn_dat[x][5]\n" - " heat[4][x] = cn_dat[x][6]\n" " mesh = ax4.pcolormesh(xgrid, ygrid, heat, cmap='bwr_r')\n" " mesh.set_clim(vmin=-1,vmax=1)\n" " ax4.plot([x[0] for x in cn_dat],[x[1] for x in cn_dat],'-',ms=3,color='black',lw=1.7)\n" @@ -471,12 +484,12 @@ static void create_plots(args_t *args) " ax6.set_ylabel('LRR')\n" " ax5.set_ylabel('BAF')\n" " ax4.set_ylabel('CN')\n" - " ax3.set_ylim(-0.1,5.1)\n" - " ax3.set_yticks([0.5,1.5,2.5,3.5,4.5])\n" - " ax3.set_yticklabels(['CN0','CN1','CN2','CN3','CN4'])\n" - " ax4.set_ylim(-0.1,5.1)\n" - " ax4.set_yticks([0.5,1.5,2.5,3.5,4.5])\n" - " ax4.set_yticklabels(['CN0','CN1','CN2','CN3','CN4'])\n" + " ax3.set_ylim(-0.1,4.1)\n" + " ax3.set_yticks([0.5,1.5,2.5,3.5])\n" + " ax3.set_yticklabels(['CN0','CN1','CN2','CN3'])\n" + " ax4.set_ylim(-0.1,4.1)\n" + " ax4.set_yticks([0.5,1.5,2.5,3.5])\n" + " ax4.set_yticklabels(['CN0','CN1','CN2','CN3'])\n" " plt.subplots_adjust(left=0.08,right=0.95,bottom=0.08,top=0.92,hspace=0)\n" " plt.savefig('%s/plot.%s.%s.chr'+chr+'.png')\n" " plt.close()\n" @@ -501,6 +514,11 @@ static void destroy_data(args_t *args) free(args->eprob); free(args->tprob); free(args->summary_fname); + free(args->nonref_afs); + free(args->query_sample.baf); + free(args->query_sample.lrr); + free(args->control_sample.baf); + free(args->control_sample.lrr); free(args->query_sample.name); free(args->query_sample.dat_fname); free(args->query_sample.cn_fname); @@ -526,12 +544,372 @@ static double avg_ii_prob(int n, double *mat) return avg/n; } +#define GAUSS_CN1_PK_R(smpl) (&((smpl)->gauss_param[0])) +#define GAUSS_CN1_PK_A(smpl) (&((smpl)->gauss_param[1])) +#define GAUSS_CN2_PK_RR(smpl) (&((smpl)->gauss_param[2])) +#define GAUSS_CN2_PK_RA(smpl) (&((smpl)->gauss_param[3])) +#define GAUSS_CN2_PK_AA(smpl) (&((smpl)->gauss_param[4])) +#define GAUSS_CN3_PK_RRR(smpl) (&((smpl)->gauss_param[5])) +#define GAUSS_CN3_PK_RRA(smpl) (&((smpl)->gauss_param[6])) +#define GAUSS_CN3_PK_RAA(smpl) (&((smpl)->gauss_param[7])) +#define GAUSS_CN3_PK_AAA(smpl) (&((smpl)->gauss_param[8])) + +static inline double norm_prob(double baf, gauss_param_t *param) +{ + return exp(-(baf-param->mean)*(baf-param->mean)*0.5/param->dev2) / param->norm / sqrt(2*M_PI*param->dev2); +} + +static int set_observed_prob(args_t *args, sample_t *smpl, int isite) +{ + float baf = smpl->baf[isite]; + float lrr = smpl->lrr[isite]; + + float fRR = args->fRR; + float fRA = args->fRA; + float fAA = args->fAA; + + if ( baf<0 ) + { + // no call: either some technical issue or the call could not be made because it is CN0 + int i; + smpl->pobs[CN0] = 0.5; + for (i=1; ipobs[i] = (1.0-smpl->pobs[CN0])/(N_STATES-1); + return 0; + } + + double cn1_baf = + norm_prob(baf,GAUSS_CN1_PK_R(smpl)) * (fRR + fRA*0.5) + + norm_prob(baf,GAUSS_CN1_PK_A(smpl)) * (fAA + fRA*0.5) ; + double cn2_baf = + norm_prob(baf,GAUSS_CN2_PK_RR(smpl)) * fRR + + norm_prob(baf,GAUSS_CN2_PK_RA(smpl)) * fRA + + norm_prob(baf,GAUSS_CN2_PK_AA(smpl)) * fAA; + double cn3_baf = + norm_prob(baf,GAUSS_CN3_PK_RRR(smpl)) * fRR + + norm_prob(baf,GAUSS_CN3_PK_RRA(smpl)) * fRA*0.5 + + norm_prob(baf,GAUSS_CN3_PK_RAA(smpl)) * fRA*0.5 + + norm_prob(baf,GAUSS_CN3_PK_AAA(smpl)) * fAA; + + double norm = cn1_baf + cn2_baf + cn3_baf; + cn1_baf /= norm; + cn2_baf /= norm; + cn3_baf /= norm; + + #if DBG0 + if ( args->verbose ) fprintf(stderr,"%f\t%f %f %f\n", baf,cn1_baf,cn2_baf,cn3_baf); + #endif + + double cn1_lrr = exp(-(lrr + 0.45)*(lrr + 0.45)/args->lrr_dev2); + double cn2_lrr = exp(-(lrr - 0.00)*(lrr - 0.00)/args->lrr_dev2); + double cn3_lrr = exp(-(lrr - 0.30)*(lrr - 0.30)/args->lrr_dev2); + + smpl->pobs[CN0] = 0; + smpl->pobs[CN1] = args->err_prob + (1 - args->baf_bias + args->baf_bias*cn1_baf)*(1 - args->lrr_bias + args->lrr_bias*cn1_lrr); + smpl->pobs[CN2] = args->err_prob + (1 - args->baf_bias + args->baf_bias*cn2_baf)*(1 - args->lrr_bias + args->lrr_bias*cn2_lrr); + smpl->pobs[CN3] = args->err_prob + (1 - args->baf_bias + args->baf_bias*cn3_baf)*(1 - args->lrr_bias + args->lrr_bias*cn3_lrr); + + return 0; +} + +static void set_emission_prob(args_t *args, int isite) +{ + double *eprob = &args->eprob[args->nstates*isite]; + int i; + for (i=0; iquery_sample.pobs[i]; +} + +static void set_emission_prob2(args_t *args, int isite) +{ + double *eprob = &args->eprob[args->nstates*isite]; + int i, j; + for (i=0; iquery_sample.pobs[i]*args->control_sample.pobs[j]; + } + } +} + +static void set_gauss_params(args_t *args, sample_t *smpl); +static double norm_cdf(double mean, double dev) +{ + double bot = 0, top = 1; + top = 1 - 0.5*erfc((top-mean)/(dev*sqrt(2))); + bot = 1 - 0.5*erfc((bot-mean)/(dev*sqrt(2))); + return top-bot; +} + +static void set_emission_probs(args_t *args) +{ + if ( !args->af_fname ) + { + args->fRR = 0.76; + args->fRA = 0.14; + args->fAA = 0.098; + } + + set_gauss_params(args, &args->query_sample); + if ( args->control_sample.name ) set_gauss_params(args, &args->control_sample); + + #if DBG0 + args->verbose = 1; + args->query_sample.baf[0] = 0; set_observed_prob(args,&args->query_sample,0); + args->query_sample.baf[0] = 1/3.; set_observed_prob(args,&args->query_sample,0); + args->query_sample.baf[0] = 1/2.; set_observed_prob(args,&args->query_sample,0); + args->query_sample.baf[0] = 2/3.; set_observed_prob(args,&args->query_sample,0); + args->query_sample.baf[0] = 1; set_observed_prob(args,&args->query_sample,0); + args->verbose = 0; + #endif + + int i; + for (i=0; insites; i++) + { + if ( args->af_fname ) + { + args->fRR = (1-args->nonref_afs[i])*(1-args->nonref_afs[i]); + args->fRA = 2*args->nonref_afs[i]*(1-args->nonref_afs[i]); + args->fAA = args->nonref_afs[i]*args->nonref_afs[i]; + } + set_observed_prob(args,&args->query_sample,i); + if ( args->control_sample.name ) + { + set_observed_prob(args,&args->control_sample,i); + set_emission_prob2(args,i); + } + else + set_emission_prob(args,i); + } +} + +static void smooth_data(float *dat, int ndat, int win) +{ + if ( win<=1 ) return; + + int i,j, k1 = win/2, k2 = win-k1; + rbuf_t rbuf; + rbuf_init(&rbuf,win); + float sum = 0, *buf = (float*)malloc(sizeof(float)*win); + for (i=0; i=k1 ) + { + j = rbuf_shift(&rbuf); + sum -= buf[j]; + } + if ( i+k2gauss_param[i].dev2 = smpl->baf_dev2; + + double dev = sqrt(smpl->baf_dev2); + + GAUSS_CN1_PK_R(smpl)->mean = 0; + GAUSS_CN1_PK_A(smpl)->mean = 1; + GAUSS_CN1_PK_R(smpl)->norm = norm_cdf(GAUSS_CN1_PK_R(smpl)->mean,dev); + GAUSS_CN1_PK_A(smpl)->norm = norm_cdf(GAUSS_CN1_PK_A(smpl)->mean,dev); + + GAUSS_CN2_PK_RR(smpl)->mean = 0; + GAUSS_CN2_PK_RA(smpl)->mean = 0.5; + GAUSS_CN2_PK_AA(smpl)->mean = 1; + GAUSS_CN2_PK_RR(smpl)->norm = norm_cdf(GAUSS_CN2_PK_RR(smpl)->mean,dev); + GAUSS_CN2_PK_RA(smpl)->norm = norm_cdf(GAUSS_CN2_PK_RA(smpl)->mean,dev); + GAUSS_CN2_PK_AA(smpl)->norm = norm_cdf(GAUSS_CN2_PK_AA(smpl)->mean,dev); + + GAUSS_CN3_PK_RRR(smpl)->mean = 0; + GAUSS_CN3_PK_RRA(smpl)->mean = 1.0/(2+smpl->cell_frac); + GAUSS_CN3_PK_RAA(smpl)->mean = (1.0+smpl->cell_frac)/(2+smpl->cell_frac); + GAUSS_CN3_PK_AAA(smpl)->mean = 1; + GAUSS_CN3_PK_RRR(smpl)->norm = norm_cdf(GAUSS_CN3_PK_RRR(smpl)->mean,dev); + GAUSS_CN3_PK_RRA(smpl)->norm = norm_cdf(GAUSS_CN3_PK_RRA(smpl)->mean,dev); + GAUSS_CN3_PK_RAA(smpl)->norm = norm_cdf(GAUSS_CN3_PK_RAA(smpl)->mean,dev); + GAUSS_CN3_PK_AAA(smpl)->norm = norm_cdf(GAUSS_CN3_PK_AAA(smpl)->mean,dev); +} + +static int update_sample_args(args_t *args, sample_t *smpl, int ismpl) +{ + hmm_t *hmm = args->hmm; + + // estimate the BAF mean and deviation for CN3 + double mean_cn3 = 0, norm_cn3 = 0; + double baf_dev2 = 0, baf_AA_dev2 = 0, norm_baf_AA_dev2 = 0; + + int i, j; + for (i=0; insites; i++) + { + float baf = smpl->baf[i]; + if ( baf>4/5.) { baf_AA_dev2 += (1.0-baf)*(1.0-baf); norm_baf_AA_dev2++; continue; } // skip AA genotypes + if ( baf>0.5 ) baf = 1 - baf; // the bands should be symmetric + if ( baf<1/5.) continue; // skip RR genotypes + + double prob_cn3 = 0, *probs = hmm->fwd + i*hmm->nstates; + if ( !args->control_sample.name ) + { + prob_cn3 = probs[CN3]; + } + else if ( ismpl==0 ) + { + // query sample: CN3 probability must be recovered from all states of the control sample + for (j=0; jcell_frac = 1.0; + return 1; + } + mean_cn3 /= norm_cn3; + for (i=0; insites; i++) + { + float baf = smpl->baf[i]; + if ( baf>0.5 ) baf = 1 - baf; // the bands should be symmetric + if ( baf<1/5.) continue; // skip RR,AA genotypes + + double prob_cn3 = 0, *probs = hmm->fwd + i*hmm->nstates; + if ( !args->control_sample.name ) + { + prob_cn3 = probs[CN3]; + } + else if ( ismpl==0 ) + { + // query sample: CN3 probability must be recovered from all states of the control sample + for (j=0; j0 ); + + double new_frac = 1./mean_cn3 - 2; + if ( mean_cn3 > max_mean_cn3 || new_frac < args->optimize_frac ) + { + // out of bounds, beyond our detection limits. Give up and say it converged + smpl->cell_frac = 1.0; + return 1; + } + if ( new_frac>1 ) new_frac = 1; + int converged = fabs(new_frac - smpl->cell_frac) < 1e-1 ? 1 : 0; + + // Update dev2, but stay within safe limits + if ( baf_dev2 > 3*smpl->baf_dev2_dflt ) baf_dev2 = 3*smpl->baf_dev2_dflt; + else if ( baf_dev2 < 0.5*smpl->baf_dev2_dflt ) baf_dev2 = 0.5*smpl->baf_dev2_dflt; + + smpl->cell_frac = new_frac; + smpl->baf_dev2 = baf_dev2; + + return converged; +} + +// Update parameters which depend on the estimated fraction of aberrant cells +// in CN3. Returns 0 if the current estimate did not need to be updated or 1 +// if there was a change. +static int update_args(args_t *args) +{ + int converged = update_sample_args(args, &args->query_sample, 0); + if ( args->control_sample.name ) + { + converged += update_sample_args(args, &args->control_sample, 1); + return converged==2 ? 0 : 1; + } + return converged ? 0 : 1; +} + static void cnv_flush_viterbi(args_t *args) { if ( !args->nsites ) return; + // Set HMM transition matrix for the new chromsome again. This is for case + // Baum-Welch was used, which is experimental, largerly unsupported and not + // done by default. hmm_t *hmm = args->hmm; hmm_set_tprob(args->hmm, args->tprob, 10000); + + // Smooth LRR values to reduce noise + smooth_data(args->query_sample.lrr,args->nsites, args->lrr_smooth_win); + if ( args->control_sample.name ) smooth_data(args->control_sample.lrr,args->nsites, args->lrr_smooth_win); + + // Set the BAF peak likelihoods, such as P(RRR|CN3), taking account the + // estimated fraction of aberrant cells in the mixture. With the new chromosome, + // reset the fraction to the default value. + args->query_sample.cell_frac = args->query_sample.cell_frac_dflt; + args->control_sample.cell_frac = args->control_sample.cell_frac_dflt; + args->query_sample.baf_dev2 = args->query_sample.baf_dev2_dflt; + args->control_sample.baf_dev2 = args->control_sample.baf_dev2_dflt; + set_gauss_params(args, &args->query_sample); + if ( args->control_sample.name ) set_gauss_params(args, &args->control_sample); + + if ( args->optimize_frac ) + { + int niter = 0; + fprintf(stderr,"Attempting to estimate the fraction of aberrant cells (chr %s):\n", bcf_hdr_id2name(args->hdr,args->prev_rid)); + do + { + fprintf(stderr,"\t.. %f %f", args->query_sample.cell_frac,args->query_sample.baf_dev2); + if ( args->control_sample.name ) + fprintf(stderr,"\t.. %f %f", args->control_sample.cell_frac,args->control_sample.baf_dev2); + fprintf(stderr,"\n"); + set_emission_probs(args); + hmm_run_fwd_bwd(hmm, args->nsites, args->eprob, args->sites); + } + while ( update_args(args) && ++niter<20 ); + if ( niter>=20 ) + { + // no convergence + args->query_sample.cell_frac = args->query_sample.cell_frac_dflt; + args->control_sample.cell_frac = args->control_sample.cell_frac_dflt; + args->query_sample.baf_dev2 = args->query_sample.baf_dev2_dflt; + args->control_sample.baf_dev2 = args->control_sample.baf_dev2_dflt; + set_gauss_params(args, &args->query_sample); + if ( args->control_sample.name ) set_gauss_params(args, &args->control_sample); + } + + fprintf(stderr,"\t.. %f %f", args->query_sample.cell_frac,args->query_sample.baf_dev2); + if ( args->control_sample.name ) + fprintf(stderr,"\t.. %f %f", args->control_sample.cell_frac,args->control_sample.baf_dev2); + fprintf(stderr,"\n"); + } + set_emission_probs(args); + while ( args->baum_welch_th!=0 ) { int nstates = hmm_get_nstates(hmm); @@ -630,76 +1008,15 @@ static void cnv_flush_viterbi(args_t *args) } } -static int set_observed_prob(args_t *args, bcf_fmt_t *baf_fmt, bcf_fmt_t *lrr_fmt, sample_t *smpl) +static int parse_lrr_baf(sample_t *smpl, bcf_fmt_t *baf_fmt, bcf_fmt_t *lrr_fmt, float *baf, float *lrr) { - float baf, lrr; - baf = ((float*)(baf_fmt->p + baf_fmt->size*smpl->idx))[0]; - if ( bcf_float_is_missing(baf) || isnan(baf) ) baf = -0.1; // arbitrary negative value == missing value - - lrr = ((float*)(lrr_fmt->p + lrr_fmt->size*smpl->idx))[0]; - if ( bcf_float_is_missing(lrr) || isnan(lrr) ) baf = -0.1; + *baf = ((float*)(baf_fmt->p + baf_fmt->size*smpl->idx))[0]; + if ( bcf_float_is_missing(*baf) || isnan(*baf) ) *baf = -0.1; // arbitrary negative value == missing value - if ( baf>=0 ) // skip missing values - fprintf(smpl->dat_fh,"%s\t%d\t%.3f\t%.3f\n",bcf_hdr_id2name(args->hdr,args->prev_rid), args->sites[args->nsites-1]+1,baf,lrr); + *lrr = ((float*)(lrr_fmt->p + lrr_fmt->size*smpl->idx))[0]; + if ( bcf_float_is_missing(*lrr) || isnan(*lrr) ) { *lrr = 0; *baf = -0.1; } - if ( baf<0 ) - { - // no call: either some technical issue or the call could not be made because it is CN0 - int i; - smpl->pobs[CN0] = 0.5; - for (i=1; ipobs[i] = (1.0-smpl->pobs[CN0])/(N_STATES-1); - return 0; - } - - double pk0, pk14, pk13, pk12, pk23, pk34, pk1; - pk0 = exp(-baf*baf/args->baf_sigma2); - pk14 = exp(-(baf-1/4.)*(baf-1/4.)/args->baf_sigma2); - pk13 = exp(-(baf-1/3.)*(baf-1/3.)/args->baf_sigma2); - pk12 = exp(-(baf-1/2.)*(baf-1/2.)/args->baf_sigma2); - pk23 = exp(-(baf-2/3.)*(baf-2/3.)/args->baf_sigma2); - pk34 = exp(-(baf-3/4.)*(baf-3/4.)/args->baf_sigma2); - pk1 = exp(-(baf-1.0)*(baf-1.0)/args->baf_sigma2); - - double cn1_baf, cn2_baf, cn3_baf, cn4_baf; - cn1_baf = pk0*(args->pRR+args->pRA/2.) + pk1*(args->pAA+args->pRA/2.); - cn2_baf = pk0*args->pRR + pk1*args->pAA + pk12*args->pRA; - cn3_baf = pk0*args->pRR + pk1*args->pAA + (pk13 + pk23)*args->pRA/2.; - cn4_baf = pk0*args->pRR + pk1*args->pAA + (pk14 + pk12 + pk34)*args->pRA/3.; - - double cn1_lrr, cn2_lrr, cn3_lrr, cn4_lrr; - cn1_lrr = exp(-(lrr + 0.45)*(lrr + 0.45)/args->lrr_sigma2); - cn2_lrr = exp(-(lrr - 0.00)*(lrr - 0.00)/args->lrr_sigma2); - cn3_lrr = exp(-(lrr - 0.30)*(lrr - 0.30)/args->lrr_sigma2); - cn4_lrr = exp(-(lrr - 0.75)*(lrr - 0.75)/args->lrr_sigma2); - - smpl->pobs[CN0] = 0; - smpl->pobs[CN1] = args->err_prob + (1 - args->baf_bias + args->baf_bias*cn1_baf)*(1 - args->lrr_bias + args->lrr_bias*cn1_lrr); - smpl->pobs[CN2] = args->err_prob + (1 - args->baf_bias + args->baf_bias*cn2_baf)*(1 - args->lrr_bias + args->lrr_bias*cn2_lrr); - smpl->pobs[CN3] = args->err_prob + (1 - args->baf_bias + args->baf_bias*cn3_baf)*(1 - args->lrr_bias + args->lrr_bias*cn3_lrr); - smpl->pobs[CNx] = args->err_prob + (1 - args->baf_bias + args->baf_bias*cn4_baf)*(1 - args->lrr_bias + args->lrr_bias*cn4_lrr); - - return 0; -} - -static void set_emission_prob(args_t *args) -{ - double *eprob = &args->eprob[args->nstates*(args->nsites-1)]; - int i; - for (i=0; iquery_sample.pobs[i]; -} - -static void set_emission_prob2(args_t *args) -{ - double *eprob = &args->eprob[args->nstates*(args->nsites-1)]; - int i, j; - for (i=0; iquery_sample.pobs[i]*args->control_sample.pobs[j]; - } - } + return *baf<0 ? 0 : 1; } int read_AF(bcf_sr_regions_t *tgt, bcf1_t *line, double *alt_freq); @@ -719,6 +1036,7 @@ static void cnv_next_line(args_t *args, bcf1_t *line) cnv_flush_viterbi(args); args->prev_rid = line->rid; args->nsites = 0; + args->nRR = args->nAA = args->nRA = 0; } // Process line @@ -728,49 +1046,53 @@ static void cnv_next_line(args_t *args, bcf1_t *line) if ( !(baf_fmt = bcf_get_fmt(args->hdr, line, "BAF")) ) return; if ( !(lrr_fmt = bcf_get_fmt(args->hdr, line, "LRR")) ) return; - // Realloc buffers needed by viterbi and fwd-bwd + float baf1,lrr1,baf2,lrr2; + int ret = 0; + ret += parse_lrr_baf(&args->query_sample, baf_fmt,lrr_fmt,&baf1,&lrr1); + ret += parse_lrr_baf(&args->control_sample,baf_fmt,lrr_fmt,&baf2,&lrr2); + if ( !ret ) return; + + // Realloc buffers needed to store observed data and used by viterbi and fwd-bwd args->nsites++; int m = args->msites; hts_expand(uint32_t,args->nsites,args->msites,args->sites); if ( args->msites!=m ) + { args->eprob = (double*) realloc(args->eprob,sizeof(double)*args->msites*args->nstates); + if ( args->control_sample.name ) + { + args->control_sample.lrr = (float*) realloc(args->control_sample.lrr,sizeof(float)*args->msites); + args->control_sample.baf = (float*) realloc(args->control_sample.baf,sizeof(float)*args->msites); + } + args->query_sample.lrr = (float*) realloc(args->query_sample.lrr,sizeof(float)*args->msites); + args->query_sample.baf = (float*) realloc(args->query_sample.baf,sizeof(float)*args->msites); + if ( args->af_fname ) + args->nonref_afs = (float*) realloc(args->nonref_afs,sizeof(float)*args->msites); + } args->sites[args->nsites-1] = line->pos; - - double alt_freq; - if ( !args->af_fname || read_AF(args->files->targets, line, &alt_freq) < 0 ) + args->query_sample.lrr[args->nsites-1] = lrr1; + args->query_sample.baf[args->nsites-1] = baf1; + if ( args->af_fname ) { - args->pRR = args->pRR_dflt; - args->pRA = args->pRA_dflt; - args->pAA = args->pAA_dflt; + double alt_freq; + args->nonref_afs[args->nsites-1] = read_AF(args->files->targets,line,&alt_freq)<0 ? args->nonref_af_dflt : alt_freq; } - else + if ( args->control_sample.name ) { - args->pRR = (1 - alt_freq)*(1 - alt_freq); - args->pRA = 2*(1 - alt_freq)*alt_freq; - args->pAA = alt_freq*alt_freq; + args->control_sample.lrr[args->nsites-1] = lrr2; + args->control_sample.baf[args->nsites-1] = baf2; + if ( baf2>=0 ) // skip missing values + fprintf(args->control_sample.dat_fh,"%s\t%d\t%.3f\t%.3f\n",bcf_hdr_id2name(args->hdr,args->prev_rid), line->pos+1,baf2,lrr2); } + if ( baf1>=0 ) // skip missing values + fprintf(args->query_sample.dat_fh,"%s\t%d\t%.3f\t%.3f\n",bcf_hdr_id2name(args->hdr,args->prev_rid), line->pos+1,baf1,lrr1); - int ret = set_observed_prob(args, baf_fmt,lrr_fmt, &args->query_sample); - if ( ret<0 ) + if ( baf1>=0 ) { - args->nsites--; - return; + if ( baf1<1/5. ) args->nRR++; + else if ( baf1>4/5. ) args->nAA++; + else args->nRA++; } - if ( args->control_sample.name ) - { - ret = set_observed_prob(args, baf_fmt,lrr_fmt, &args->control_sample); - if ( ret<0 ) - { - args->nsites--; - return; - } - } - - if ( args->control_sample.name ) - set_emission_prob2(args); - else - set_emission_prob(args); - args->nused++; } @@ -779,7 +1101,7 @@ static void usage(args_t *args) fprintf(stderr, "\n"); fprintf(stderr, "About: Copy number variation caller, requires Illumina's B-allele frequency (BAF) and Log R\n"); fprintf(stderr, " Ratio intensity (LRR). The HMM considers the following copy number states: CN 2\n"); - fprintf(stderr, " (normal), 1 (single-copy loss), 0 (complete loss), 3 (single-copy gain), x (other)\n"); + fprintf(stderr, " (normal), 1 (single-copy loss), 0 (complete loss), 3 (single-copy gain)\n"); fprintf(stderr, "Usage: bcftools cnv [OPTIONS] \n"); fprintf(stderr, "General Options:\n"); fprintf(stderr, " -c, --control-sample optional control sample name to highlight differences\n"); @@ -792,11 +1114,15 @@ static void usage(args_t *args) fprintf(stderr, " -t, --targets similar to -r but streams rather than index-jumps\n"); fprintf(stderr, " -T, --targets-file similar to -R but streams rather than index-jumps\n"); fprintf(stderr, "HMM Options:\n"); + fprintf(stderr, " -a, --aberrant fraction of aberrant cells in query and control [1.0,1.0]\n"); fprintf(stderr, " -b, --BAF-weight relative contribution from BAF [1]\n"); - fprintf(stderr, " -e, --err-prob probability of error [1e-4]\n"); + fprintf(stderr, " -d, --BAF-dev expected BAF deviation in query and control [0.04,0.04]\n"); // experimental + fprintf(stderr, " -e, --err-prob uniform error probability [1e-4]\n"); fprintf(stderr, " -l, --LRR-weight relative contribution from LRR [0.2]\n"); + fprintf(stderr, " -L, --LRR-smooth-win window of LRR moving average smoothing [10]\n"); + fprintf(stderr, " -O, --optimize estimate fraction of aberrant cells down to [1.0]\n"); fprintf(stderr, " -P, --same-prob prior probability of -s/-c being same [1e-1]\n"); - fprintf(stderr, " -x, --xy-prob P(x|y) transition probability [1e-8]\n"); + fprintf(stderr, " -x, --xy-prob P(x|y) transition probability [1e-9]\n"); fprintf(stderr, "\n"); exit(1); } @@ -808,6 +1134,11 @@ int main_vcfcnv(int argc, char *argv[]) args->argc = argc; args->argv = argv; args->files = bcf_sr_init(); args->plot_th = 1e9; // by default plot none + args->nonref_af_dflt = 0.1; + args->lrr_smooth_win = 10; + + args->query_sample.cell_frac_dflt = 1; + args->control_sample.cell_frac_dflt = 1; // How much FORMAT/LRR and FORMAT/BAF matter args->lrr_bias = 0.2; @@ -815,26 +1146,22 @@ int main_vcfcnv(int argc, char *argv[]) args->err_prob = 1e-4; // Transition probability to a different state and the prior of both samples being the same - args->ij_prob = 1e-8; + args->ij_prob = 1e-9; args->same_prob = 1e-1; // Squared std dev of BAF and LRR values (gaussian noise), estimated from real data (hets, one sample, one chr) - args->baf_sigma2 = 0.08*0.08; // illumina: 0.03 - args->lrr_sigma2 = 0.4*0.4; //0.20*0.20; // illumina: 0.18 - - // Priors for RR, RA, AA genotypes - args->pRR_dflt = 0.76; - args->pRA_dflt = 0.14; - args->pAA_dflt = 0.098; - // args->pRR = 0.69; - // args->pRA = 0.18; - // args->pAA = 0.11; + args->query_sample.baf_dev2_dflt = args->control_sample.baf_dev2_dflt = 0.04*0.04; // illumina: 0.03 + args->lrr_dev2 = 0.1*0.1; //0.20*0.20; // illumina: 0.18 int regions_is_file = 0, targets_is_file = 0; static struct option loptions[] = { + {"BAF-dev",1,0,'d'}, + {"LRR-smooth-win",1,0,'L'}, {"AF-file",1,0,'f'}, - {"baum-welch",1,0,'W'}, + {"baum-welch",1,0,'W'}, // hidden + {"optimize",1,0,'O'}, + {"aberrant",1,0,'a'}, {"err-prob",1,0,'e'}, {"BAF-weight",1,0,'b'}, {"LRR-weight",1,0,'l'}, @@ -851,9 +1178,39 @@ int main_vcfcnv(int argc, char *argv[]) {0,0,0,0} }; char *tmp = NULL; - while ((c = getopt_long(argc, argv, "h?r:R:t:T:s:o:p:l:T:c:b:P:x:e:W:f:",loptions,NULL)) >= 0) { + while ((c = getopt_long(argc, argv, "h?r:R:t:T:s:o:p:l:T:c:b:P:x:e:O:W:f:a:L:d:",loptions,NULL)) >= 0) { switch (c) { + case 'L': + args->lrr_smooth_win = strtol(optarg,&tmp,10); + if ( *tmp ) error("Could not parse: --LRR-smooth-win %s\n", optarg); + break; case 'f': args->af_fname = optarg; break; + case 'O': + args->optimize_frac = strtod(optarg,&tmp); + if ( *tmp ) error("Could not parse: -O %s\n", optarg); + break; + case 'd': + args->query_sample.baf_dev2_dflt = strtod(optarg,&tmp); + if ( *tmp ) + { + if ( *tmp!=',') error("Could not parse: -d %s\n", optarg); + args->control_sample.baf_dev2_dflt = strtod(optarg,&tmp); + if ( *tmp ) error("Could not parse: -a %s\n", optarg); + } + else + args->control_sample.baf_dev2_dflt = args->query_sample.baf_dev2_dflt; + args->query_sample.baf_dev2_dflt *= args->query_sample.baf_dev2_dflt; + args->control_sample.baf_dev2_dflt *= args->control_sample.baf_dev2_dflt; + break; + case 'a': + args->query_sample.cell_frac_dflt = strtod(optarg,&tmp); + if ( *tmp ) + { + if ( *tmp!=',') error("Could not parse: -a %s\n", optarg); + args->control_sample.cell_frac_dflt = strtod(optarg,&tmp); + if ( *tmp ) error("Could not parse: -a %s\n", optarg); + } + break; case 'W': args->baum_welch_th = strtod(optarg,&tmp); if ( *tmp ) error("Could not parse: -W %s\n", optarg); From d2b012f483756089a795f88c84317578d48f23e5 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Thu, 26 Mar 2015 15:59:28 +0000 Subject: [PATCH 021/211] cnv -O: Increase robustness by smoothing HMM lks before updating the mean --- vcfcnv.c | 46 ++++++++++++++++++++++++++++------------------ 1 file changed, 28 insertions(+), 18 deletions(-) diff --git a/vcfcnv.c b/vcfcnv.c index 6287f5bde..1f0e56aba 100644 --- a/vcfcnv.c +++ b/vcfcnv.c @@ -24,6 +24,12 @@ */ +/* + Known issues: + - The --AF-file option behaves like --targets-file, sites not listed in the AFs + are skipped. +*/ + #include #include #include @@ -76,8 +82,9 @@ typedef struct _args_t double lrr_bias, baf_bias; // LRR/BAF weights double same_prob, ij_prob; // prior of both samples being the same and the transition probability P(i|j) double err_prob; // constant probability of erroneous measurement - float *nonref_afs, nonref_af, nonref_af_dflt, fRR, fRA, fAA; + float *nonref_afs, nonref_af, nonref_af_dflt, fRR, fRA, fAA, *tmpf; unsigned long int nRR, nRA, nAA; + int mtmpf; double *tprob, *tprob_arr; // array of transition matrices, precalculated up to ntprob_arr positions int ntprob_arr; @@ -510,6 +517,7 @@ static void destroy_data(args_t *args) { bcf_sr_destroy(args->files); hmm_destroy(args->hmm); + free(args->tmpf); free(args->sites); free(args->eprob); free(args->tprob); @@ -752,11 +760,14 @@ static int update_sample_args(args_t *args, sample_t *smpl, int ismpl) double mean_cn3 = 0, norm_cn3 = 0; double baf_dev2 = 0, baf_AA_dev2 = 0, norm_baf_AA_dev2 = 0; - int i, j; + // experimental: smooth CN3 probs to bias toward bigger events, this lowers + // the FP rate when the data is noisy + hts_expand(float,args->nsites,args->mtmpf,args->tmpf); + int i, j, k = 0; for (i=0; insites; i++) { float baf = smpl->baf[i]; - if ( baf>4/5.) { baf_AA_dev2 += (1.0-baf)*(1.0-baf); norm_baf_AA_dev2++; continue; } // skip AA genotypes + if ( baf>4/5.) continue; // skip AA genotypes if ( baf>0.5 ) baf = 1 - baf; // the bands should be symmetric if ( baf<1/5.) continue; // skip RR genotypes @@ -775,6 +786,18 @@ static int update_sample_args(args_t *args, sample_t *smpl, int ismpl) // same as above but for control sample for (j=0; jtmpf[k++] = prob_cn3; + } + smooth_data(args->tmpf, k, 50); + k = 0; + for (i=0; insites; i++) + { + float baf = smpl->baf[i]; + if ( baf>4/5.) { baf_AA_dev2 += (1.0-baf)*(1.0-baf); norm_baf_AA_dev2++; continue; } // skip AA genotypes + if ( baf>0.5 ) baf = 1 - baf; // the bands should be symmetric + if ( baf<1/5.) continue; // skip RR genotypes + + double prob_cn3 = args->tmpf[k++]; mean_cn3 += prob_cn3 * baf; norm_cn3 += prob_cn3; } @@ -784,27 +807,14 @@ static int update_sample_args(args_t *args, sample_t *smpl, int ismpl) return 1; } mean_cn3 /= norm_cn3; + k = 0; for (i=0; insites; i++) { float baf = smpl->baf[i]; if ( baf>0.5 ) baf = 1 - baf; // the bands should be symmetric if ( baf<1/5.) continue; // skip RR,AA genotypes - double prob_cn3 = 0, *probs = hmm->fwd + i*hmm->nstates; - if ( !args->control_sample.name ) - { - prob_cn3 = probs[CN3]; - } - else if ( ismpl==0 ) - { - // query sample: CN3 probability must be recovered from all states of the control sample - for (j=0; jtmpf[k++]; baf_dev2 += prob_cn3 * (baf - mean_cn3)*(baf - mean_cn3); } From 2b50604dc60b3dca2e87ec763b62110092240ae3 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Thu, 26 Mar 2015 16:04:20 +0000 Subject: [PATCH 022/211] cnv: Update to the modified HMM API --- vcfcnv.c | 4 +++- 1 file changed, 3 insertions(+), 1 deletion(-) diff --git a/vcfcnv.c b/vcfcnv.c index 1f0e56aba..bec54dd6e 100644 --- a/vcfcnv.c +++ b/vcfcnv.c @@ -755,6 +755,8 @@ static void set_gauss_params(args_t *args, sample_t *smpl) static int update_sample_args(args_t *args, sample_t *smpl, int ismpl) { hmm_t *hmm = args->hmm; + double *fwd = hmm_get_fwd_bwd_prob(hmm); + int nstates = hmm_get_nstates(hmm); // estimate the BAF mean and deviation for CN3 double mean_cn3 = 0, norm_cn3 = 0; @@ -771,7 +773,7 @@ static int update_sample_args(args_t *args, sample_t *smpl, int ismpl) if ( baf>0.5 ) baf = 1 - baf; // the bands should be symmetric if ( baf<1/5.) continue; // skip RR genotypes - double prob_cn3 = 0, *probs = hmm->fwd + i*hmm->nstates; + double prob_cn3 = 0, *probs = fwd + i*nstates; if ( !args->control_sample.name ) { prob_cn3 = probs[CN3]; From d3f9fe45c6f491f7dc9b5cdabe3c30a8e0006b69 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Mon, 27 Apr 2015 10:15:55 +0100 Subject: [PATCH 023/211] cnv: Prior on CN2; changed the default -P to be more strict (0.5) --- HMM.c | 43 ++++++++++++++++++++++++++++++++++++++----- HMM.h | 8 ++++++++ vcfcnv.c | 44 +++++++++++++++++++++++++++++++++++++++++--- 3 files changed, 87 insertions(+), 8 deletions(-) diff --git a/HMM.c b/HMM.c index 78501ca55..91965449f 100644 --- a/HMM.c +++ b/HMM.c @@ -50,6 +50,7 @@ struct _hmm_t set_tprob_f set_tprob; // Optional user function to set / modify transition probabilities // at each site (one step of Viterbi algorithm) void *set_tprob_data; + double *init_probs; // Initial state probabilities, NULL for uniform probs }; uint8_t *hmm_get_viterbi_path(hmm_t *hmm) { return hmm->vpath; } @@ -89,6 +90,18 @@ hmm_t *hmm_init(int nstates, double *tprob, int ntprob) return hmm; } +void hmm_init_states(hmm_t *hmm, double *probs) +{ + if ( !probs ) + { + free(hmm->init_probs); + hmm->init_probs = NULL; + } + + if ( !hmm->init_probs ) hmm->init_probs = (double*) malloc(sizeof(double)*hmm->nstates); + memcpy(hmm->init_probs,probs,sizeof(double)*hmm->nstates); +} + void hmm_set_tprob(hmm_t *hmm, double *tprob, int ntprob) { hmm->ntprob_arr = ntprob; @@ -144,7 +157,10 @@ void hmm_run_viterbi(hmm_t *hmm, int n, double *eprobs, uint32_t *sites) // Init all states with equal likelihood int i,j, nstates = hmm->nstates; - for (i=0; ivprob[i] = 1./nstates; + if ( hmm->init_probs ) + for (i=0; ivprob[i] = hmm->init_probs[i]; + else + for (i=0; ivprob[i] = 1./nstates; // Run Viterbi uint32_t prev_pos = sites[0]; @@ -208,8 +224,16 @@ void hmm_run_fwd_bwd(hmm_t *hmm, int n, double *eprobs, uint32_t *sites) // Init all states with equal likelihood int i,j,k, nstates = hmm->nstates; - for (i=0; ifwd[i] = 1./hmm->nstates; - for (i=0; ibwd[i] = 1./hmm->nstates; + if ( hmm->init_probs ) + { + for (i=0; ifwd[i] = hmm->init_probs[i]; + for (i=0; ibwd[i] = hmm->init_probs[i]; + } + else + { + for (i=0; ifwd[i] = 1./hmm->nstates; + for (i=0; ibwd[i] = 1./hmm->nstates; + } // Run fwd uint32_t prev_pos = sites[0]; @@ -288,8 +312,16 @@ void hmm_run_baum_welch(hmm_t *hmm, int n, double *eprobs, uint32_t *sites) // Init all states with equal likelihood int i,j,k, nstates = hmm->nstates; - for (i=0; ifwd[i] = 1./hmm->nstates; - for (i=0; ibwd[i] = 1./hmm->nstates; + if ( hmm->init_probs ) + { + for (i=0; ifwd[i] = hmm->init_probs[i]; + for (i=0; ibwd[i] = hmm->init_probs[i]; + } + else + { + for (i=0; ifwd[i] = 1./hmm->nstates; + for (i=0; ibwd[i] = 1./hmm->nstates; + } // New transition matrix: temporary values double *tmp_xi = (double*) calloc(nstates*nstates,sizeof(double)); @@ -388,6 +420,7 @@ void hmm_run_baum_welch(hmm_t *hmm, int n, double *eprobs, uint32_t *sites) void hmm_destroy(hmm_t *hmm) { + free(hmm->init_probs); free(hmm->vprob); free(hmm->vprob_tmp); free(hmm->vpath); diff --git a/HMM.h b/HMM.h index 3f5e0f10a..7f01245ed 100644 --- a/HMM.h +++ b/HMM.h @@ -44,6 +44,14 @@ typedef void (*set_tprob_f) (hmm_t *hmm, uint32_t prev_pos, uint32_t pos, void * hmm_t *hmm_init(int nstates, double *tprob, int ntprob); void hmm_set_tprob(hmm_t *hmm, double *tprob, int ntprob); +/** + * hmm_init_states() - initial state probabilities + * @probs: initial state probabilities or NULL to reset to default + * + * If uncalled, all states are initialized with the same likelihood + */ +void hmm_init_states(hmm_t *hmm, double *probs); + /** * hmm_get_tprob() - return the array of transition matrices, precalculated * to ntprob positions. The first matrix is the initial tprob matrix diff --git a/vcfcnv.c b/vcfcnv.c index bec54dd6e..a9dfb7fb0 100644 --- a/vcfcnv.c +++ b/vcfcnv.c @@ -87,6 +87,7 @@ typedef struct _args_t int mtmpf; double *tprob, *tprob_arr; // array of transition matrices, precalculated up to ntprob_arr positions + double *iprobs; // states' initial probabilities int ntprob_arr; hmm_t *hmm; @@ -174,6 +175,41 @@ static double *init_tprob_matrix(int ndim, double ij_prob, double same_prob) return mat; } +static double *init_iprobs(int ndim, double same_prob) +{ + int i; + double *probs = (double*) malloc(sizeof(double)*ndim); + + assert( ndim==N_STATES || ndim==N_STATES*N_STATES); + + if ( ndim==N_STATES ) + { + // one sample: prior on CN2 + for (i=0; idat_fh = open_file(&smpl->dat_fname,"w","%s/dat.%s.tab",dir,smpl->name); @@ -225,8 +261,10 @@ static void init_data(args_t *args) args->query_sample.idx = bcf_hdr_id2int(args->hdr,BCF_DT_SAMPLE,args->query_sample.name); args->control_sample.idx = args->control_sample.name ? bcf_hdr_id2int(args->hdr,BCF_DT_SAMPLE,args->control_sample.name) : -1; args->nstates = args->control_sample.name ? N_STATES*N_STATES : N_STATES; - args->tprob = init_tprob_matrix(args->nstates, args->ij_prob, args->same_prob); + args->tprob = init_tprob_matrix(args->nstates, args->ij_prob, args->same_prob); + args->iprobs = init_iprobs(args->nstates, args->same_prob); args->hmm = hmm_init(args->nstates, args->tprob, 10000); + hmm_init_states(args->hmm, args->iprobs); args->summary_fh = stdout; if ( args->output_dir ) @@ -1133,7 +1171,7 @@ static void usage(args_t *args) fprintf(stderr, " -l, --LRR-weight relative contribution from LRR [0.2]\n"); fprintf(stderr, " -L, --LRR-smooth-win window of LRR moving average smoothing [10]\n"); fprintf(stderr, " -O, --optimize estimate fraction of aberrant cells down to [1.0]\n"); - fprintf(stderr, " -P, --same-prob prior probability of -s/-c being same [1e-1]\n"); + fprintf(stderr, " -P, --same-prob prior probability of -s/-c being the same [0.5]\n"); fprintf(stderr, " -x, --xy-prob P(x|y) transition probability [1e-9]\n"); fprintf(stderr, "\n"); exit(1); @@ -1159,7 +1197,7 @@ int main_vcfcnv(int argc, char *argv[]) // Transition probability to a different state and the prior of both samples being the same args->ij_prob = 1e-9; - args->same_prob = 1e-1; + args->same_prob = 0.5; // Squared std dev of BAF and LRR values (gaussian noise), estimated from real data (hets, one sample, one chr) args->query_sample.baf_dev2_dflt = args->control_sample.baf_dev2_dflt = 0.04*0.04; // illumina: 0.03 From 733f25770a8d1318818d1e53e989abb8eaee212c Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Fri, 17 Jul 2015 13:13:32 +0100 Subject: [PATCH 024/211] Further support for case-insensitive REF,ALT allele merging See also 1f81d259b9e970f1aacac136f78f1bec6898238b and samtools/htslib@3fcf7c9026b3dff17ab20893b8019eaf4f3bb675 Fixes #285 Petentially fixes #284 --- test/merge.2.b.vcf | 2 +- vcfmerge.c | 2 +- vcmp.c | 13 +++++++------ 3 files changed, 9 insertions(+), 8 deletions(-) diff --git a/test/merge.2.b.vcf b/test/merge.2.b.vcf index fab439f78..8700f1c79 100644 --- a/test/merge.2.b.vcf +++ b/test/merge.2.b.vcf @@ -26,5 +26,5 @@ 1 3106154 . C CCC 342 PASS AN=4;AC=2 GT:GQ:DP 0/1:245:32 0/1:245:32 1 3106154 . C T 59.2 PASS AN=4;AC=2 GT:GQ:DP 0/1:245:32 0/1:245:32 1 3200000 . C T 59.2 PASS AN=4;AC=2 GT:GQ:DP 0/1:245:32 0/1:245:32 -1 3200010 . C A,T 59.2 PASS AN=4;AC=2 GT:GQ:DP 0/1:245:32 0/1:245:32 +1 3200010 . c A,T 59.2 PASS AN=4;AC=2 GT:GQ:DP 0/1:245:32 0/1:245:32 1 3200020 . C T,G 59.2 PASS AN=4;AC=2 GT:GL ./.:1,4,6,2,5,3 .:1,3,2 diff --git a/vcfmerge.c b/vcfmerge.c index ea26903d3..c98c285c2 100644 --- a/vcfmerge.c +++ b/vcfmerge.c @@ -578,7 +578,7 @@ char **merge_alleles(char **a, int na, int *map, char **b, int *nb, int *mb) ai = a[i]; for (j=1; j<*nb; j++) - if ( !strcmp(ai,b[j]) ) break; + if ( !strcasecmp(ai,b[j]) ) break; if ( j<*nb ) // $b already has the same allele { diff --git a/vcmp.c b/vcmp.c index a117cd344..da0be3024 100644 --- a/vcmp.c +++ b/vcmp.c @@ -53,17 +53,18 @@ int vcmp_set_ref(vcmp_t *vcmp, char *ref1, char *ref2) vcmp->ndref = 0; char *a = ref1, *b = ref2; - while ( *a && *b && *a==*b ) { a++; b++; } + while ( *a && *b && toupper(*a)==toupper(*b) ) { a++; b++; } if ( !*a && !*b ) return 0; if ( *a && *b ) return -1; // refs not compatible + int i; if ( *a ) // ref1 is longer { vcmp->nmatch = b-ref2; while ( *a ) a++; vcmp->ndref = (a-ref1) - vcmp->nmatch; hts_expand(char,vcmp->ndref+1,vcmp->mdref,vcmp->dref); - memcpy(vcmp->dref,ref1+vcmp->nmatch,vcmp->ndref); + for (i=0; indref; i++) vcmp->dref[i] = toupper(ref1[vcmp->nmatch+i]); vcmp->dref[vcmp->ndref] = 0; return 0; } @@ -73,7 +74,7 @@ int vcmp_set_ref(vcmp_t *vcmp, char *ref1, char *ref2) while ( *b ) b++; vcmp->ndref = (b-ref2) - vcmp->nmatch; hts_expand(char,vcmp->ndref+1,vcmp->mdref,vcmp->dref); - memcpy(vcmp->dref,ref2+vcmp->nmatch,vcmp->ndref); + for (i=0; indref; i++) vcmp->dref[i] = toupper(ref2[vcmp->nmatch+i]); vcmp->dref[vcmp->ndref] = 0; vcmp->ndref *= -1; return 0; @@ -85,7 +86,7 @@ int vcmp_find_allele(vcmp_t *vcmp, char **als1, int nals1, char *al2) for (i=0; indref ) { @@ -98,14 +99,14 @@ int vcmp_find_allele(vcmp_t *vcmp, char **als1, int nals1, char *al2) { if ( vcmp->ndref<0 ) continue; for (j=0; jndref; j++) - if ( !a[j] || a[j]!=vcmp->dref[j] ) break; + if ( !a[j] || toupper(a[j])!=vcmp->dref[j] ) break; if ( j!=vcmp->ndref || a[j] ) continue; break; // found } if ( vcmp->ndref>0 ) continue; for (j=0; j<-vcmp->ndref; j++) - if ( !b[j] || b[j]!=vcmp->dref[j] ) break; + if ( !b[j] || toupper(b[j])!=vcmp->dref[j] ) break; if ( j!=-vcmp->ndref || b[j] ) continue; break; // found } From cecff77a83c1b76a9edc7e4e7ae6692e0517d5d3 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Fri, 17 Jul 2015 08:39:49 +0100 Subject: [PATCH 025/211] more informative error message: annotate supports FMT fields only from a VCF Closes #294 --- vcfannotate.c | 5 ++++- 1 file changed, 4 insertions(+), 1 deletion(-) diff --git a/vcfannotate.c b/vcfannotate.c index 00630a58b..b7ba548be 100644 --- a/vcfannotate.c +++ b/vcfannotate.c @@ -1240,8 +1240,11 @@ static void init_columns(args_t *args) } } } - else if ( args->tgts_is_vcf && (!strncasecmp("FORMAT/",str.s, 7) || !strncasecmp("FMT/",str.s,4)) ) + else if ( !strncasecmp("FORMAT/",str.s, 7) || !strncasecmp("FMT/",str.s,4) ) { + if ( !args->tgts_is_vcf ) + error("Error: FORMAT fields can be carried over from a VCF file only.\n"); + char *key = str.s + (!strncasecmp("FMT/",str.s,4) ? 4 : 7); if ( force_samples<0 ) force_samples = replace; if ( force_samples>=0 && replace!=REPLACE_ALL ) force_samples = replace;; From ae5663dfc4542257813f73680e0f9cfa571526ba Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Tue, 28 Jul 2015 08:52:47 +0100 Subject: [PATCH 026/211] merge: More informative error message when FILTER is undefined --- vcfmerge.c | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/vcfmerge.c b/vcfmerge.c index c98c285c2..881105aa0 100644 --- a/vcfmerge.c +++ b/vcfmerge.c @@ -789,7 +789,7 @@ void merge_filter(args_t *args, bcf1_t *out) if ( kitr == kh_end(tmph) ) { int id = bcf_hdr_id2int(out_hdr, BCF_DT_ID, flt); - if ( id==-1 ) error("The filter not defined: %s\n", flt); + if ( id==-1 ) error("Error: The filter is not defined in the header: %s\n", flt); hts_expand(int,out->d.n_flt+1,ma->mflt,ma->flt); ma->flt[out->d.n_flt] = id; out->d.n_flt++; From 58a1cf3a7cd473d31aef9ed0e1fc1669cffe47fe Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Sat, 11 Jul 2015 17:01:52 +0100 Subject: [PATCH 027/211] Resolved assert when comparing long GT strings --- filter.c | 14 ++++++++++++-- 1 file changed, 12 insertions(+), 2 deletions(-) diff --git a/filter.c b/filter.c index 20d570e8a..413946bd1 100644 --- a/filter.c +++ b/filter.c @@ -561,12 +561,22 @@ static void filters_set_genotype_string(filter_t *flt, bcf1_t *line, token_t *to return; } int i, blen = 3, nsmpl = bcf_hdr_nsamples(flt->hdr); - kstring_t str; str.s = tok->str_value; str.m = tok->values[0] * nsmpl; str.l = 0; + kstring_t str; + +gt_length_too_big: + str.s = tok->str_value; str.m = tok->values[0] * nsmpl; str.l = 0; for (i=0; i blen ) + { + // too many alternate alleles or ploidy is too large, the genotype does not fit + // three characters ("0/0" vs "10/10"). + tok->str_value = str.s; + blen *= 2; + goto gt_length_too_big; + } plen = str.l - plen; while ( plen Date: Tue, 28 Jul 2015 09:04:32 +0100 Subject: [PATCH 028/211] plugin: new --version switch --- vcfplugin.c | 15 +++++++++++++-- 1 file changed, 13 insertions(+), 2 deletions(-) diff --git a/vcfplugin.c b/vcfplugin.c index a8bf5d34a..c3fac72d1 100644 --- a/vcfplugin.c +++ b/vcfplugin.c @@ -465,6 +465,7 @@ static void usage(args_t *args) fprintf(stderr, " -h, --help list plugin's options\n"); fprintf(stderr, " -l, --list-plugins list available plugins. See BCFTOOLS_PLUGINS environment variable and man page for details\n"); fprintf(stderr, " -v, --verbose print debugging information on plugin failure\n"); + fprintf(stderr, " -V, --version print version string and exit\n"); fprintf(stderr, "\n"); exit(1); } @@ -477,7 +478,7 @@ int main_plugin(int argc, char *argv[]) args->output_fname = "-"; args->output_type = FT_VCF; args->nplugin_paths = -1; - int regions_is_file = 0, targets_is_file = 0, plist_only = 0, usage_only = 0; + int regions_is_file = 0, targets_is_file = 0, plist_only = 0, usage_only = 0, version_only = 0; if ( argc==1 ) usage(args); char *plugin_name = NULL; @@ -485,6 +486,7 @@ int main_plugin(int argc, char *argv[]) static struct option loptions[] = { + {"version",0,0,'V'}, {"verbose",0,0,'v'}, {"help",0,0,'h'}, {"list-plugins",0,0,'l'}, @@ -498,9 +500,10 @@ int main_plugin(int argc, char *argv[]) {"targets-file",1,0,'T'}, {0,0,0,0} }; - while ((c = getopt_long(argc, argv, "h?o:O:r:R:t:T:li:e:v",loptions,NULL)) >= 0) + while ((c = getopt_long(argc, argv, "h?o:O:r:R:t:T:li:e:vV",loptions,NULL)) >= 0) { switch (c) { + case 'V': version_only = 1; break; case 'v': args->verbose = 1; break; case 'o': args->output_fname = optarg; break; case 'O': @@ -528,6 +531,14 @@ int main_plugin(int argc, char *argv[]) if ( usage_only && ! plugin_name ) usage(args); load_plugin(args, plugin_name, 1, &args->plugin); + if ( version_only ) + { + const char *bver, *hver; + args->plugin.version(&bver, &hver); + printf("bcftools %s using htslib %s\n", bcftools_version(), hts_version()); + printf("plugin at %s using htslib %s\n\n", bver, hver); + return 0; + } if ( usage_only ) { From d8b82c3d9f769c6f75446d437a667d1dda521a03 Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Tue, 28 Jul 2015 09:11:37 +0100 Subject: [PATCH 029/211] vcfplugin: header boilerplate mentioned the wrong file --- vcfplugin.c | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/vcfplugin.c b/vcfplugin.c index c3fac72d1..437d40fc6 100644 --- a/vcfplugin.c +++ b/vcfplugin.c @@ -1,6 +1,6 @@ -/* vcfannotate.c -- Annotate and edit VCF/BCF files. +/* vcfplugin.c -- plugin modules for operating on VCF/BCF files. - Copyright (C) 2013-2014 Genome Research Ltd. + Copyright (C) 2013-2015 Genome Research Ltd. Author: Petr Danecek From 5653f1bc4a3a1ffe1e93bdd6d282d669a5f3a129 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Thu, 23 Jul 2015 19:58:25 +0100 Subject: [PATCH 030/211] Include ctype for toupper declaration in vcmp --- vcmp.c | 1 + 1 file changed, 1 insertion(+) diff --git a/vcmp.c b/vcmp.c index da0be3024..8d04b8942 100644 --- a/vcmp.c +++ b/vcmp.c @@ -26,6 +26,7 @@ THE SOFTWARE. */ #include #include #include +#include #include "vcmp.h" struct _vcmp_t From 2962f5cdea669fdc122c133001be02d8b98dcbe5 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Thu, 23 Jul 2015 22:54:06 +0100 Subject: [PATCH 031/211] New fill-tags plugin to set INFO tags AN,AC,AC_Hom,AC_Het,AC_Hemi --- plugins/fill-tags.c | 262 ++++++++++++++++++++++++++++++++++++++++++++ test/fill-tags.out | 40 +++++++ test/test.pl | 4 +- 3 files changed, 305 insertions(+), 1 deletion(-) create mode 100644 plugins/fill-tags.c create mode 100644 test/fill-tags.out diff --git a/plugins/fill-tags.c b/plugins/fill-tags.c new file mode 100644 index 000000000..c7bd7fd24 --- /dev/null +++ b/plugins/fill-tags.c @@ -0,0 +1,262 @@ +/* The MIT License + + Copyright (c) 2015 Genome Research Ltd. + + Author: Petr Danecek + + Permission is hereby granted, free of charge, to any person obtaining a copy + of this software and associated documentation files (the "Software"), to deal + in the Software without restriction, including without limitation the rights + to use, copy, modify, merge, publish, distribute, sublicense, and/or sell + copies of the Software, and to permit persons to whom the Software is + furnished to do so, subject to the following conditions: + + The above copyright notice and this permission notice shall be included in + all copies or substantial portions of the Software. + + THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS OR + IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF MERCHANTABILITY, + FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. IN NO EVENT SHALL THE + AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY CLAIM, DAMAGES OR OTHER + LIABILITY, WHETHER IN AN ACTION OF CONTRACT, TORT OR OTHERWISE, ARISING FROM, + OUT OF OR IN CONNECTION WITH THE SOFTWARE OR THE USE OR OTHER DEALINGS IN + THE SOFTWARE. + + */ + +#include +#include +#include +#include +#include +#include +#include "bcftools.h" + +#define SET_AN (1<<0) +#define SET_AC (1<<1) +#define SET_AC_Hom (1<<2) +#define SET_AC_Het (1<<3) +#define SET_AC_Hemi (1<<4) + +typedef struct +{ + int nhom, nhet, nhemi, nac; +} +counts_t; + +typedef struct +{ + bcf_hdr_t *in_hdr, *out_hdr; + int tags, marr, mcounts, gt_id; + int32_t *arr; + counts_t *counts; +} +args_t; + +static args_t args; + +const char *about(void) +{ + return "Set INFO tags AN, AC, AC_Hom, AC_Het, AC_Hemi.\n"; +} + +const char *usage(void) +{ + return + "\n" + "About: Set INFO tags AN, AC, AC_Hom, AC_Het, AC_Hemi.\n" + "Usage: bcftools +fill-tags [General Options] -- [Plugin Options]\n" + "Options:\n" + " run \"bcftools plugin\" for a list of common options\n" + "\n" + "Plugin options:\n" + " -t, --tags LIST list of output tags. By default, all tags are filled.\n" + "\n" + "Example:\n" + " bcftools +fill-tags in.bcf -Ob -o out.bcf -- -t AN,AC\n" + " bcftools +fill-tags in.bcf -Ob -o out.bcf\n" + "\n"; +} + +int parse_tags(args_t *args, const char *str) +{ + int i, flag = 0, n_tags; + char **tags = hts_readlist(str, 0, &n_tags); + for(i=0; i= 0) + { + switch (c) + { + case 't': args.tags |= parse_tags(&args,optarg); break; + case 'h': + case '?': + default: error("%s", usage()); break; + } + } + if ( optind != argc ) error(usage()); + if ( !args.tags ) args.tags |= SET_AN|SET_AC|SET_AC_Hom|SET_AC_Het|SET_AC_Hemi; + + args.gt_id = bcf_hdr_id2int(args.in_hdr,BCF_DT_ID,"GT"); + if ( args.gt_id<0 ) error("Error: GT field is not present\n"); + + if ( args.tags&SET_AN ) bcf_hdr_append(args.out_hdr, "##INFO="); + if ( args.tags&SET_AC ) bcf_hdr_append(args.out_hdr, "##INFO="); + if ( args.tags&SET_AC_Hom ) bcf_hdr_append(args.out_hdr, "##INFO="); + if ( args.tags&SET_AC_Het ) bcf_hdr_append(args.out_hdr, "##INFO="); + if ( args.tags&SET_AC_Hemi ) bcf_hdr_append(args.out_hdr, "##INFO="); + + return 0; +} + +bcf1_t *process(bcf1_t *rec) +{ + int i; + + bcf_unpack(rec, BCF_UN_FMT); + bcf_fmt_t *fmt_gt = NULL; + for (i=0; in_fmt; i++) + if ( rec->d.fmt[i].id==args.gt_id ) { fmt_gt = &rec->d.fmt[i]; break; } + if ( !fmt_gt ) return rec; // no GT tag + + hts_expand(int32_t,rec->n_allele,args.marr,args.arr); + hts_expand(counts_t,rec->n_allele,args.mcounts,args.counts); + memset(args.arr,0,sizeof(*args.arr)*rec->n_allele); + memset(args.counts,0,sizeof(*args.counts)*rec->n_allele); + + #define BRANCH_INT(type_t,vector_end) { \ + for (i=0; in_sample; i++) \ + { \ + type_t *p = (type_t*) (fmt_gt->p + i*fmt_gt->size); \ + int ial, als = 0; \ + for (ial=0; ialn; ial++) \ + { \ + if ( p[ial]==vector_end ) break; /* smaller ploidy */ \ + if ( bcf_gt_is_missing(p[ial]) ) break; /* missing allele */ \ + int idx = bcf_gt_allele(p[ial]); \ + \ + if ( idx >= rec->n_allele ) \ + error("Incorrect allele (\"%d\") in %s at %s:%d\n",idx,args.in_hdr->samples[i],bcf_seqname(args.in_hdr,rec),rec->pos+1); \ + als |= (1<>= 1; \ + } \ + } \ + } + switch (fmt_gt->type) { + case BCF_BT_INT8: BRANCH_INT(int8_t, bcf_int8_vector_end); break; + case BCF_BT_INT16: BRANCH_INT(int16_t, bcf_int16_vector_end); break; + case BCF_BT_INT32: BRANCH_INT(int32_t, bcf_int32_vector_end); break; + default: error("The GT type is not recognised: %d at %s:%d\n",fmt_gt->type, bcf_seqname(args.in_hdr,rec),rec->pos+1); break; + } + #undef BRANCH_INT + if ( args.tags&SET_AN ) + { + args.arr[0] = 0; + for (i=0; in_allele; i++) + args.arr[0] += args.counts[i].nhet + args.counts[i].nhom + args.counts[i].nhemi; + if ( bcf_update_info_int32(args.out_hdr,rec,"AN",args.arr,1)!=0 ) + error("Error occurred while updating AN at %s:%d\n", bcf_seqname(args.in_hdr,rec),rec->pos+1); + } + if ( args.tags&SET_AC ) + { + int n = rec->n_allele-1; + if ( n>0 ) + { + memset(args.arr,0,sizeof(*args.arr)*rec->n_allele); + for (i=1; in_allele; i++) + args.arr[i] += args.counts[i].nhet + args.counts[i].nhom + args.counts[i].nhemi; + } + if ( bcf_update_info_int32(args.out_hdr,rec,"AC",args.arr+1,n)!=0 ) + error("Error occurred while updating AC at %s:%d\n", bcf_seqname(args.in_hdr,rec),rec->pos+1); + } + if ( args.tags&SET_AC_Het ) + { + int n = rec->n_allele-1; + if ( n>0 ) + { + memset(args.arr,0,sizeof(*args.arr)*rec->n_allele); + for (i=1; in_allele; i++) + args.arr[i] += args.counts[i].nhet; + } + if ( bcf_update_info_int32(args.out_hdr,rec,"AC_Het",args.arr+1,n)!=0 ) + error("Error occurred while updating AC_Het at %s:%d\n", bcf_seqname(args.in_hdr,rec),rec->pos+1); + } + if ( args.tags&SET_AC_Hom ) + { + int n = rec->n_allele-1; + if ( n>0 ) + { + memset(args.arr,0,sizeof(*args.arr)*rec->n_allele); + for (i=1; in_allele; i++) + args.arr[i] += args.counts[i].nhom; + } + if ( bcf_update_info_int32(args.out_hdr,rec,"AC_Hom",args.arr+1,n)!=0 ) + error("Error occurred while updating AC_Hom at %s:%d\n", bcf_seqname(args.in_hdr,rec),rec->pos+1); + } + if ( args.tags&SET_AC_Hemi ) + { + int n = rec->n_allele-1; + if ( n>0 ) + { + memset(args.arr,0,sizeof(*args.arr)*rec->n_allele); + for (i=1; in_allele; i++) + args.arr[i] += args.counts[i].nhemi; + } + if ( bcf_update_info_int32(args.out_hdr,rec,"AC_Hemi",args.arr+1,n)!=0 ) + error("Error occurred while updating AC_Hemi at %s:%d\n", bcf_seqname(args.in_hdr,rec),rec->pos+1); + } + return rec; +} + +void destroy(void) +{ + free(args.counts); + free(args.arr); +} + + + diff --git a/test/fill-tags.out b/test/fill-tags.out new file mode 100644 index 000000000..eb8676f05 --- /dev/null +++ b/test/fill-tags.out @@ -0,0 +1,40 @@ +##fileformat=VCFv4.1 +##FILTER= +##INFO= +##FORMAT= +##INFO= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##FILTER= +##FILTER= +##contig= +##contig= +##contig= +##contig= +##reference=file:///lustre/scratch105/projects/g1k/ref/main_project/human_g1k_v37.fasta +##readme=AAAAAA +##readme=BBBBBB +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +#CHROM POS ID REF ALT QUAL FILTER INFO FORMAT A B +1 3000150 . C T 59.2 PASS AN=4;AC=2;AC_Het=2;AC_Hom=0;AC_Hemi=0 GT:GQ 0/1:245 0/1:245 +1 3000151 . C T 59.2 PASS AN=4;AC=2;AC_Het=2;AC_Hom=0;AC_Hemi=0 GT:DP:GQ 0/1:32:245 0/1:32:245 +1 3062915 id3D GTTT G 12.9 q10 DP4=1,2,3,4;AN=4;AC=2;INDEL;STR=test;AC_Het=2;AC_Hom=0;AC_Hemi=0 GT:GQ:DP:GL 0/1:409:35:-20,-5,-20 0/1:409:35:-20,-5,-20 +1 3062915 idSNP G T,C 12.6 test TEST=5;DP4=1,2,3,4;AN=3;AC=1,1;AC_Het=1,0;AC_Hom=0,0;AC_Hemi=0,1 GT:TT:GQ:DP:GL 0/1:0,1:409:35:-20,-5,-20,-20,-5,-20 2:0,1:409:35:-20,-5,-20 +1 3106154 . CAAA C 342 PASS AN=4;AC=2;AC_Het=2;AC_Hom=0;AC_Hemi=0 GT:GQ:DP 0/1:245:32 0/1:245:32 +1 3106154 . C CT 59.2 PASS AN=4;AC=2;AC_Het=2;AC_Hom=0;AC_Hemi=0 GT:GQ:DP 0/1:245:32 0/1:245:32 +1 3157410 . GA G 90.6 q10 AN=4;AC=4;AC_Het=0;AC_Hom=4;AC_Hemi=0 GT:GQ:DP 1/1:21:21 1/1:21:21 +1 3162006 . GAA G 60.2 PASS AN=4;AC=2;AC_Het=2;AC_Hom=0;AC_Hemi=0 GT:GQ:DP 0/1:212:22 0/1:212:22 +1 3177144 . G T 45 PASS AN=4;AC=2;AC_Het=0;AC_Hom=2;AC_Hemi=0 GT:GQ:DP 0/0:150:30 1/1:150:30 +1 3177144 . G . 45 PASS AN=4 GT:GQ:DP 0/0:150:30 0/0:150:30 +1 3184885 . TAAAA TA,T 61.5 PASS AN=4;AC=2,2;AC_Het=2,2;AC_Hom=0,0;AC_Hemi=0,0 GT:GQ:DP 1/2:12:10 1/2:12:10 +2 3199812 . G GTT,GT 82.7 PASS AN=4;AC=2,2;AC_Het=2,2;AC_Hom=0,0;AC_Hemi=0,0 GT:GQ:DP 1/2:322:26 1/2:322:26 +3 3212016 . CTT C,CT 79 PASS AN=4;AC=2,2;AC_Het=2,2;AC_Hom=0,0;AC_Hemi=0,0 GT:GQ:DP 1/2:91:26 1/2:91:26 +4 3258448 . TACACACAC T . PASS AN=4;AC=2;AC_Het=2;AC_Hom=0;AC_Hemi=0 GT:GQ:DP 0/1:325:31 0/1:325:31 diff --git a/test/test.pl b/test/test.pl index 71d80418c..cd9fbe462 100755 --- a/test/test.pl +++ b/test/test.pl @@ -158,8 +158,10 @@ test_vcf_plugin($opts,in=>'plugin1',out=>'dosage.out',cmd=>'+dosage'); test_vcf_plugin($opts,in=>'fixploidy',out=>'fixploidy.out',cmd=>'+fixploidy',args=>'-- -s {PATH}/fixploidy.samples -p {PATH}/fixploidy.ploidy'); test_vcf_plugin($opts,in=>'vcf2sex',out=>'vcf2sex.out',cmd=>'+vcf2sex',args=>'-- -n 5'); -test_vcf_plugin($opts,in=>'vcf2sex',out=>'vcf2sex.out',cmd=>'+vcf2sex',args=>'-- -gn 5'); +test_vcf_plugin($opts,in=>'vcf2sex',out=>'vcf2sex.out',cmd=>'+vcf2sex',args=>'-- -g GT'); +test_vcf_plugin($opts,in=>'vcf2sex',out=>'vcf2sex.out',cmd=>'+vcf2sex',args=>'-- -g GT -n 5'); test_vcf_plugin($opts,in=>'view.GL',out=>'view.PL.vcf',cmd=>'+tag2tag',args=>'-- -r --gl-to-pl'); +test_vcf_plugin($opts,in=>'merge.a',out=>'fill-tags.out',cmd=>'+fill-tags'); test_vcf_concat($opts,in=>['concat.1.a','concat.1.b'],out=>'concat.1.vcf.out',do_bcf=>0,args=>''); test_vcf_concat($opts,in=>['concat.1.a','concat.1.b'],out=>'concat.1.bcf.out',do_bcf=>1,args=>''); test_vcf_concat($opts,in=>['concat.2.a','concat.2.b'],out=>'concat.2.vcf.out',do_bcf=>0,args=>'-a'); From 653c26ad111f97c18dda6eaad136cffbda5fb4d1 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Thu, 23 Jul 2015 20:34:19 +0100 Subject: [PATCH 032/211] Fix bcftools_pluginCommand=plugin header annotation. --- vcfplugin.c | 1 - 1 file changed, 1 deletion(-) diff --git a/vcfplugin.c b/vcfplugin.c index 437d40fc6..1c2921c65 100644 --- a/vcfplugin.c +++ b/vcfplugin.c @@ -573,7 +573,6 @@ int main_plugin(int argc, char *argv[]) args->plugin.argv = argv + optind; } optind = 0; - args->plugin.argv[0] = plugin_name; args->files = bcf_sr_init(); if ( args->regions_list ) From 264745ee68c8bcb89b4302ced5f14c4c4336a10f Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Fri, 29 May 2015 14:58:47 +0100 Subject: [PATCH 033/211] New isec -n~BITMASK option --- doc/bcftools.txt | 11 ++++++++--- vcfisec.c | 25 ++++++++++++++++++++++--- 2 files changed, 30 insertions(+), 6 deletions(-) diff --git a/doc/bcftools.txt b/doc/bcftools.txt index 1dca046f8..56249f736 100644 --- a/doc/bcftools.txt +++ b/doc/bcftools.txt @@ -906,9 +906,9 @@ in the other files. include only sites for which 'EXPRESSION' is true. See discussion of *-e, --exclude* above. -*-n, --nfiles* \[+-=]'INT':: - output positions present in this many (=), this many or more (+), or this - many or fewer (-) files +*-n, --nfiles* \[+-=]'INT'|~'BITMAP':: + output positions present in this many (=), this many or more (+), this + many or fewer (-), or the exact same (~) files *-o, --output* 'FILE':: see *<>*. When several files are being @@ -958,6 +958,11 @@ Extract records private to A or B comparing by position only bcftools isec -p dir -n-1 -c all A.vcf.gz B.vcf.gz ---- +Print a list of records which are present in A and B but not in C and D +---- + bcftools isec -n~1100 -c all A.vcf.gz B.vcf.gz C.vcf.gz D.vcf.gz +---- + [[merge]] === bcftools merge ['OPTIONS'] 'A.vcf.gz' 'B.vcf.gz' [...] diff --git a/vcfisec.c b/vcfisec.c index 27b812981..c86b0cdb3 100644 --- a/vcfisec.c +++ b/vcfisec.c @@ -41,6 +41,7 @@ THE SOFTWARE. */ #define OP_EQUAL 3 #define OP_VENN 4 #define OP_COMPLEMENT 5 +#define OP_EXACT 6 // Logic of the filters: include or exclude sites which match the filters? #define FLT_INCLUDE 1 @@ -56,6 +57,7 @@ typedef struct FILE *fh_log, *fh_sites; htsFile **fh_out; char **argv, *prefix, *output_fname, **fnames, *write_files, *targets_list, *regions_list; + char *isec_exact; int argc; } args_t; @@ -190,7 +192,12 @@ void isec_vcf(args_t *args) case OP_COMPLEMENT: if ( n!=1 || !bcf_sr_has_line(files,0) ) continue; break; case OP_EQUAL: if ( n != args->isec_n ) continue; break; case OP_PLUS: if ( n < args->isec_n ) continue; break; - case OP_MINUS: if ( n > args->isec_n ) continue; + case OP_MINUS: if ( n > args->isec_n ) continue; break; + case OP_EXACT: + for (i=0; inreaders; i++) + if ( files->has_line[i] != args->isec_exact[i] ) break; + if ( inreaders ) continue; + break; } if ( out_std ) @@ -294,6 +301,16 @@ static void init_data(args_t *args) } } + if ( args->isec_op==OP_EXACT ) + { + if ( strlen(args->isec_exact)!=args->files->nreaders ) + error("The number of files does not match the bitmask: %d vs %s\n", args->files->nreaders,args->isec_exact); + for (i=0; ifiles->nreaders; i++) + if ( args->isec_exact[i]!='0' && args->isec_exact[i]!='1' ) error("Unexpected bitmask: %s\n",args->isec_exact); + for (i=0; ifiles->nreaders; i++) + args->isec_exact[i] -= '0'; + } + // Which files to write: parse the string passed with -w char *p = args->write_files; while (p && *p) @@ -445,7 +462,7 @@ static void usage(void) fprintf(stderr, " -e, --exclude exclude sites for which the expression is true\n"); fprintf(stderr, " -f, --apply-filters require at least one of the listed FILTER strings (e.g. \"PASS,.\")\n"); fprintf(stderr, " -i, --include include only sites for which the expression is true\n"); - fprintf(stderr, " -n, --nfiles [+-=] output positions present in this many (=), this many or more (+), or this many or fewer (-) files\n"); + fprintf(stderr, " -n, --nfiles [+-=~] output positions present in this many (=), this many or more (+), this many or fewer (-), the exact (~) files\n"); fprintf(stderr, " -o, --output write output to a file [standard output]\n"); fprintf(stderr, " -O, --output-type b: compressed BCF, u: uncompressed BCF, z: compressed VCF, v: uncompressed VCF [v]\n"); fprintf(stderr, " -p, --prefix if given, subset each of the input files accordingly, see also -w\n"); @@ -538,9 +555,11 @@ int main_vcfisec(int argc, char *argv[]) if ( *p=='-' ) { args->isec_op = OP_MINUS; p++; } else if ( *p=='+' ) { args->isec_op = OP_PLUS; p++; } else if ( *p=='=' ) { args->isec_op = OP_EQUAL; p++; } + else if ( *p=='~' ) { args->isec_op = OP_EXACT; p++; } else if ( isdigit(*p) ) args->isec_op = OP_EQUAL; else error("Could not parse --nfiles %s\n", optarg); - if ( sscanf(p,"%d",&args->isec_n)!=1 ) error("Could not parse --nfiles %s\n", optarg); + if ( args->isec_op == OP_EXACT ) args->isec_exact = p; + else if ( sscanf(p,"%d",&args->isec_n)!=1 ) error("Could not parse --nfiles %s\n", optarg); } break; case 'h': From 6ccecd140528e5c005934b1f8a6177de6ddda0dc Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Mon, 15 Jun 2015 09:50:24 +0100 Subject: [PATCH 034/211] New annotate -m option to mark sites present/absent in a file --- doc/bcftools.txt | 3 +++ vcfannotate.c | 36 +++++++++++++++++++++++++++++++++--- 2 files changed, 36 insertions(+), 3 deletions(-) diff --git a/doc/bcftools.txt b/doc/bcftools.txt index 56249f736..d7b68072a 100644 --- a/doc/bcftools.txt +++ b/doc/bcftools.txt @@ -291,6 +291,9 @@ This command allows to add or remove annotations. include only sites for which 'EXPRESSION' is true. For valid expressions see *<>*. +*-m, --mark-sites* [+-]'TAG':: + annotate sites which are present ("+") or absent ("-") in the *-a* file with a new INFO/TAG flag + *-o, --output* 'FILE':: see *<>* diff --git a/vcfannotate.c b/vcfannotate.c index b7ba548be..2723e7bc0 100644 --- a/vcfannotate.c +++ b/vcfannotate.c @@ -78,6 +78,9 @@ annot_col_t; #define FLT_INCLUDE 1 #define FLT_EXCLUDE 2 +#define MARK_LISTED 1 +#define MARK_UNLISTED 2 + typedef struct _args_t { bcf_srs_t *files; @@ -115,8 +118,8 @@ typedef struct _args_t kstring_t tmpks; char **argv, *output_fname, *targets_fname, *regions_list, *header_fname; - char *remove_annots, *columns, *rename_chrs, *sample_names; - int argc, drop_header, tgts_is_vcf; + char *remove_annots, *columns, *rename_chrs, *sample_names, *mark_sites; + int argc, drop_header, tgts_is_vcf, mark_sites_logic; } args_t; @@ -1390,6 +1393,14 @@ static void init_data(args_t *args) args->set_ids = convert_init(args->hdr_out, NULL, 0, args->set_ids_fmt); } + if ( args->mark_sites ) + { + if ( !args->targets_fname ) error("The -a option not given\n"); + if ( args->tgts_is_vcf ) error("todo: -a is a VCF\n"); // very easy to add.. + bcf_hdr_printf(args->hdr_out,"##INFO=", + args->mark_sites,args->mark_sites_logic==MARK_LISTED?"":"not ",args->mark_sites); + } + bcf_hdr_append_version(args->hdr_out, args->argc, args->argv, "bcftools_annotate"); if ( !args->drop_header ) { @@ -1545,9 +1556,20 @@ static void annotate(args_t *args, bcf1_t *line) if ( inalines ) { + // there is a matching line for (j=0; jncols; j++) if ( args->cols[j].setter(args,line,&args->cols[j],&args->alines[i]) ) error("fixme: Could not set %s at %s:%d\n", args->cols[j].hdr_key,bcf_seqname(args->hdr,line),line->pos+1); + + } + + if ( args->mark_sites ) + { + // ideally, we'd like to be far more general than this in future, see https://github.com/samtools/bcftools/issues/87 + if ( args->mark_sites_logic==MARK_LISTED ) + bcf_update_info_flag(args->hdr_out,line,args->mark_sites,NULL,inalines?1:0); + else + bcf_update_info_flag(args->hdr_out,line,args->mark_sites,NULL,inalines?0:1); } } else if ( args->files->nreaders == 2 && bcf_sr_has_line(args->files,1) ) @@ -1585,6 +1607,7 @@ static void usage(args_t *args) fprintf(stderr, " -h, --header-lines lines which should be appended to the VCF header\n"); fprintf(stderr, " -I, --set-id [+] set ID column, see man pagee for details\n"); fprintf(stderr, " -i, --include select sites for which the expression is true (see man pagee for details)\n"); + fprintf(stderr, " -m, --mark-sites [+-] add INFO/tag flag to sites which are (\"+\") or are not (\"-\") listed in the -a file\n"); fprintf(stderr, " -o, --output write output to a file [standard output]\n"); fprintf(stderr, " -O, --output-type b: compressed BCF, u: uncompressed BCF, z: compressed VCF, v: uncompressed VCF [v]\n"); fprintf(stderr, " -r, --regions restrict to comma-separated list of regions\n"); @@ -1611,6 +1634,7 @@ int main_vcfannotate(int argc, char *argv[]) static struct option loptions[] = { + {"mark-sites",1,0,'m'}, {"set-id",1,0,'I'}, {"output",1,0,'o'}, {"output-type",1,0,'O'}, @@ -1627,9 +1651,15 @@ int main_vcfannotate(int argc, char *argv[]) {"samples-file",1,0,'S'}, {0,0,0,0} }; - while ((c = getopt_long(argc, argv, "h:?o:O:r:R:a:x:c:i:e:S:s:I:",loptions,NULL)) >= 0) + while ((c = getopt_long(argc, argv, "h:?o:O:r:R:a:x:c:i:e:S:s:I:m:",loptions,NULL)) >= 0) { switch (c) { + case 'm': + args->mark_sites_logic = MARK_LISTED; + if ( optarg[0]=='+' ) args->mark_sites = optarg+1; + else if ( optarg[0]=='-' ) { args->mark_sites = optarg+1; args->mark_sites_logic = MARK_UNLISTED; } + else args->mark_sites = optarg; + break; case 'I': args->set_ids_fmt = optarg; break; case 's': args->sample_names = optarg; break; case 'S': args->sample_names = optarg; args->sample_is_file = 1; break; From d0ff204878f6013a463c1b3641295eb79098a666 Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Tue, 28 Jul 2015 09:51:53 +0100 Subject: [PATCH 035/211] docs update include docs update from: * 6ccecd140528e5c005934b1f8a6177de6ddda0dc * 264745ee68c8bcb89b4302ced5f14c4c4336a10f * 3ba5f38ced4e3938348fa231a2f3d794ee43bc5a --- doc/bcftools.1 | 41 ++++++++++++++++++++++++++++++++--------- doc/bcftools.html | 27 +++++++++++++++++---------- 2 files changed, 49 insertions(+), 19 deletions(-) diff --git a/doc/bcftools.1 b/doc/bcftools.1 index 8988447b7..a56a6b0ba 100644 --- a/doc/bcftools.1 +++ b/doc/bcftools.1 @@ -2,12 +2,12 @@ .\" Title: bcftools .\" Author: [see the "AUTHORS" section] .\" Generator: DocBook XSL Stylesheets v1.76.1 -.\" Date: 2015-06-15 15:56 BST +.\" Date: 2015-07-28 09:49 BST .\" Manual: \ \& .\" Source: \ \& .\" Language: English .\" -.TH "BCFTOOLS" "1" "2015\-06\-15 15:56 BST" "\ \&" "\ \&" +.TH "BCFTOOLS" "1" "2015\-07\-28 09:49 BST" "\ \&" "\ \&" .\" ----------------------------------------------------------------- .\" * Define some portability stuff .\" ----------------------------------------------------------------- @@ -41,7 +41,7 @@ Most commands accept VCF, bgzipped VCF and BCF with filetype detected automatica BCFtools is designed to work on a stream\&. It regards an input file "\-" as the standard input (stdin) and outputs to the standard output (stdout)\&. Several commands can thus be combined with Unix pipes\&. .SS "VERSION" .sp -This manual page was last updated \fB2015\-06\-15 15:56 BST\fR and refers to bcftools git version \fB1\&.2\-45\-g3d18e21+\fR\&. +This manual page was last updated \fB2015\-07\-28 09:49 BST\fR and refers to bcftools git version \fB1\&.2\-74\-g6ccecd1+\fR\&. .SS "BCF1" .sp The BCF1 format output by versions of samtools <= 0\&.1\&.19 is \fBnot\fR compatible with this version of bcftools\&. To read BCF1 files one can use the view command from old versions of bcftools packaged with samtools versions <= 0\&.1\&.19 to convert to VCF, which can then be read by this version of bcftools\&. @@ -549,6 +549,13 @@ is true\&. For valid expressions see \fBEXPRESSIONS\fR\&. .RE .PP +\fB\-m, \-\-mark\-sites\fR \fITAG\fR +.RS 4 +annotate sites which are present ("+") or absent ("\-") in the +\fB\-a\fR +file with a new INFO/TAG flag +.RE +.PP \fB\-o, \-\-output\fR \fIFILE\fR .RS 4 see @@ -1561,9 +1568,9 @@ is true\&. See discussion of above\&. .RE .PP -\fB\-n, \-\-nfiles\fR [+\-=]\fIINT\fR +\fB\-n, \-\-nfiles\fR [+\-=]\fIINT\fR|~\fIBITMAP\fR .RS 4 -output positions present in this many (=), this many or more (+), or this many or fewer (\-) files +output positions present in this many (=), this many or more (+), this many or fewer (\-), or the exact same (~) files .RE .PP \fB\-o, \-\-output\fR \fIFILE\fR @@ -1673,6 +1680,18 @@ Extract records private to A or B comparing by position only .if n \{\ .RE .\} +.sp +Print a list of records which are present in A and B but not in C and D +.sp +.if n \{\ +.RS 4 +.\} +.nf + bcftools isec \-n~1100 \-c all A\&.vcf\&.gz B\&.vcf\&.gz C\&.vcf\&.gz D\&.vcf\&.gz +.fi +.if n \{\ +.RE +.\} .RE .SS "bcftools merge [\fIOPTIONS\fR] \fIA\&.vcf\&.gz\fR \fIB\&.vcf\&.gz\fR [\&...]" .sp @@ -2355,15 +2374,13 @@ Emission probabilities: Transition probabilities: tAZ = P(AZ|HW) \&.\&. from HW to AZ, the \-a parameter tHW = P(HW|AZ) \&.\&. from AZ to HW, the \-H parameter - P(AZ|AZ) = 1 \- P(HW|AZ) = 1 \- tHW - P(HW|HW) = 1 \- P(AZ|HW) = 1 \- tAZ ci = P_i(C) \&.\&. probability of cross\-over at site i, from genetic map AZi = P_i(AZ) \&.\&. probability of site i being AZ/non\-AZ, scaled so that AZi+HWi = 1 HWi = P_i(HW) - P_{i+1}(AZ) = oAZ * max[(1\-tHW) * (1\-ci) * AZ{i\-1} , tAZ * ci * (1\-AZ{i\-1})] - P_{i+1}(HW) = oHW * max[(1\-tAZ) * (1\-ci) * (1\-AZ{i\-1}) , tHW * ci * AZ{i\-1}] + P_{i+1}(AZ) = oAZ * max[(1 \- tAZ * ci) * AZ{i\-1} , tAZ * ci * (1\-AZ{i\-1})] + P_{i+1}(HW) = oHW * max[(1 \- tHW * ci) * (1\-AZ{i\-1}) , tHW * ci * AZ{i\-1}] .fi .if n \{\ .RE @@ -2378,6 +2395,12 @@ Transition probabilities: \fBGeneral Options:\fR .RS 4 .PP +\fB\-\-AF\-dflt\fR \fIFLOAT\fR +.RS 4 +in case allele frequency is not known, use the +\fIFLOAT\fR\&. By default, sites where allele frequency cannot be determined, or is 0, are skipped\&. +.RE +.PP \fB\-\-AF\-tag\fR \fITAG\fR .RS 4 use the specified INFO tag diff --git a/doc/bcftools.html b/doc/bcftools.html index 28b8928c7..9919479fb 100644 --- a/doc/bcftools.html +++ b/doc/bcftools.html @@ -1,13 +1,13 @@ -bcftools

Name

bcftools — utilities for variant calling and manipulating VCFs and BCFs.

Synopsis

bcftools [--version|--version-only] [--help] [COMMAND] [OPTIONS]

DESCRIPTION

BCFtools is a set of utilities that manipulate variant calls in the Variant +bcftools

Name

bcftools — utilities for variant calling and manipulating VCFs and BCFs.

Synopsis

bcftools [--version|--version-only] [--help] [COMMAND] [OPTIONS]

DESCRIPTION

BCFtools is a set of utilities that manipulate variant calls in the Variant Call Format (VCF) and its binary counterpart BCF. All commands work transparently with both VCFs and BCFs, both uncompressed and BGZF-compressed.

Most commands accept VCF, bgzipped VCF and BCF with filetype detected automatically even when streaming from a pipe. Indexed VCF and BCF will work in all situations. Un-indexed VCF and BCF and streams will work in most, but not all situations.

BCFtools is designed to work on a stream. It regards an input file "-" as the standard input (stdin) and outputs to the standard output (stdout). Several -commands can thus be combined with Unix pipes.

VERSION

This manual page was last updated 2015-06-15 15:56 BST and refers to bcftools git version 1.2-45-g3d18e21+.

BCF1

The BCF1 format output by versions of samtools <= 0.1.19 is not +commands can thus be combined with Unix pipes.

VERSION

This manual page was last updated 2015-07-28 09:49 BST and refers to bcftools git version 1.2-74-g6ccecd1+.

BCF1

The BCF1 format output by versions of samtools <= 0.1.19 is not compatible with this version of bcftools. To read BCF1 files one can use the view command from old versions of bcftools packaged with samtools versions <= 0.1.19 to convert to VCF, which can then be read by @@ -245,6 +245,10 @@ include only sites for which EXPRESSION is true. For valid expressions see EXPRESSIONS.

+-m, --mark-sites TAG +
+ annotate sites which are present ("+") or absent ("-") in the -a file with a new INFO/TAG flag +
-o, --output FILE
see Common Options @@ -874,10 +878,10 @@ include only sites for which EXPRESSION is true. See discussion of -e, --exclude above.
--n, --nfiles [+-=]INT +-n, --nfiles [+-=]INT|~BITMAP
- output positions present in this many (=), this many or more (+), or this - many or fewer (-) files + output positions present in this many (=), this many or more (+), this + many or fewer (-), or the exact same (~) files
-o, --output FILE
@@ -912,7 +916,7 @@
list of input files to output given as 1-based indices. With -p and no -w, all files are written. -

Examples:

Create intersection and complements of two sets saving the output in dir/*

    bcftools isec -p dir A.vcf.gz B.vcf.gz

Filter sites in A and B (but not in C) and create intersection

    bcftools isec -e'MAF<0.01' -i'dbSNP=1' -e- A.vcf.gz B.vcf.gz C.vcf.gz -p dir

Extract and write records from A shared by both A and B using exact allele match

    bcftools isec -p dir -n=2 -w1 A.vcf.gz B.vcf.gz

Extract records private to A or B comparing by position only

    bcftools isec -p dir -n-1 -c all A.vcf.gz B.vcf.gz

bcftools merge [OPTIONS] A.vcf.gz B.vcf.gz […]

Merge multiple VCF/BCF files from non-overlapping sample sets to create one +

Examples:

Create intersection and complements of two sets saving the output in dir/*

    bcftools isec -p dir A.vcf.gz B.vcf.gz

Filter sites in A and B (but not in C) and create intersection

    bcftools isec -e'MAF<0.01' -i'dbSNP=1' -e- A.vcf.gz B.vcf.gz C.vcf.gz -p dir

Extract and write records from A shared by both A and B using exact allele match

    bcftools isec -p dir -n=2 -w1 A.vcf.gz B.vcf.gz

Extract records private to A or B comparing by position only

    bcftools isec -p dir -n-1 -c all A.vcf.gz B.vcf.gz

Print a list of records which are present in A and B but not in C and D

    bcftools isec -n~1100 -c all A.vcf.gz B.vcf.gz C.vcf.gz D.vcf.gz

bcftools merge [OPTIONS] A.vcf.gz B.vcf.gz […]

Merge multiple VCF/BCF files from non-overlapping sample sets to create one multi-sample file. For example, when merging file A.vcf.gz containing samples S1, S2 and S3 and file B.vcf.gz containing samples S3 and S4, the output file will contain four samples named S1, S2, S3, 2:S3 @@ -1274,15 +1278,18 @@ Transition probabilities: tAZ = P(AZ|HW) .. from HW to AZ, the -a parameter tHW = P(HW|AZ) .. from AZ to HW, the -H parameter - P(AZ|AZ) = 1 - P(HW|AZ) = 1 - tHW - P(HW|HW) = 1 - P(AZ|HW) = 1 - tAZ ci = P_i(C) .. probability of cross-over at site i, from genetic map AZi = P_i(AZ) .. probability of site i being AZ/non-AZ, scaled so that AZi+HWi = 1 HWi = P_i(HW) - P_{i+1}(AZ) = oAZ * max[(1-tHW) * (1-ci) * AZ{i-1} , tAZ * ci * (1-AZ{i-1})] - P_{i+1}(HW) = oHW * max[(1-tAZ) * (1-ci) * (1-AZ{i-1}) , tHW * ci * AZ{i-1}]

General Options:

+ P_{i+1}(AZ) = oAZ * max[(1 - tAZ * ci) * AZ{i-1} , tAZ * ci * (1-AZ{i-1})] + P_{i+1}(HW) = oHW * max[(1 - tHW * ci) * (1-AZ{i-1}) , tHW * ci * AZ{i-1}]

General Options:

+--AF-dflt FLOAT +
+ in case allele frequency is not known, use the FLOAT. By default, sites where + allele frequency cannot be determined, or is 0, are skipped. +
--AF-tag TAG
use the specified INFO tag TAG as an allele frequency estimate From 40ee806a6f649a16d22f19f2c0755a28dce54f05 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Fri, 17 Jul 2015 10:09:53 +0100 Subject: [PATCH 036/211] Fix in -i/-e filtering in the convert command; query missing GT fields e.g. as GT="." --- doc/bcftools.txt | 5 +++++ filter.c | 31 ++++++++++++++++++++++++------- vcfconvert.c | 5 +++-- 3 files changed, 32 insertions(+), 9 deletions(-) diff --git a/doc/bcftools.txt b/doc/bcftools.txt index d7b68072a..574ac7ef5 100644 --- a/doc/bcftools.txt +++ b/doc/bcftools.txt @@ -1678,6 +1678,11 @@ These filtering expressions are accepted by *<>*, DP=".", DP!="." +* missing genotypes can be matched regardless of phase and ploidy (".|.", "./.", ".") +using this expression + + GT="." + * TYPE for variant type in REF,ALT columns (indel,snp,mnp,ref,other) TYPE="indel" | TYPE="snp" diff --git a/filter.c b/filter.c index 413946bd1..8c3d0837a 100644 --- a/filter.c +++ b/filter.c @@ -568,15 +568,32 @@ static void filters_set_genotype_string(filter_t *flt, bcf1_t *line, token_t *to for (i=0; i blen ) + + #define BRANCH(type_t) { \ + type_t *ptr = (type_t*) (fmt->p + i*fmt->size); \ + if ( !(ptr[0]>>1) ) kputc('.',&str); \ + } + switch (fmt->type) { + case BCF_BT_INT8: BRANCH(int8_t); break; + case BCF_BT_INT16: BRANCH(int16_t); break; + case BCF_BT_INT32: BRANCH(int32_t); break; + default: fprintf(stderr,"FIXME: type %d in bcf_format_gt?\n", fmt->type); abort(); break; + } + #undef BRANCH + + if ( plen==str.l ) { - // too many alternate alleles or ploidy is too large, the genotype does not fit - // three characters ("0/0" vs "10/10"). - tok->str_value = str.s; - blen *= 2; - goto gt_length_too_big; + bcf_format_gt(fmt, i, &str); + if ( str.l - plen > blen ) + { + // too many alternate alleles or ploidy is too large, the genotype does not fit + // three characters ("0/0" vs "10/10"). + tok->str_value = str.s; + blen *= 2; + goto gt_length_too_big; + } } + plen = str.l - plen; while ( plenfiles, args->infname) ) error("Failed to open %s: %s\n", args->infname,bcf_sr_strerror(args->files->errnum)); - if ( args->filter_str ) - args->filter = filter_init(args->header, args->filter_str); args->header = args->files->readers[0].header; + if ( args->filter_str ) + args->filter = filter_init(args->header, args->filter_str); + int i, nsamples = 0, *samples = NULL; if ( args->sample_list && strcmp("-",args->sample_list) ) { From b62ae45ba53ac1088424dab4a9f4b245e6994754 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Mon, 9 Mar 2015 21:37:12 +0000 Subject: [PATCH 037/211] bugfix in filtering expressions involving ALT=. sites --- filter.c | 7 ++++++- 1 file changed, 6 insertions(+), 1 deletion(-) diff --git a/filter.c b/filter.c index 8c3d0837a..ccc844568 100644 --- a/filter.c +++ b/filter.c @@ -664,7 +664,12 @@ static void filters_set_ac(filter_t *flt, bcf1_t *line, token_t *tok) if ( tok->idx>=0 ) { tok->nvalues = 1; - tok->values[0] = flt->tmpi[tok->idx+1]; + tok->values[0] = tok->idx+1n_allele ? flt->tmpi[tok->idx+1] : 0; + } + else if ( line->n_allele==1 ) // no ALT + { + tok->nvalues = 1; + tok->values[0] = 0; } else { From d3af7da5b4551cb0ff1c02950e32e2c334499047 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Sun, 3 May 2015 08:31:30 +0100 Subject: [PATCH 038/211] rbuf_expand0 macro made analogous to hts_expand0 --- rbuf.h | 25 +++++++++++++++---------- test/test-rbuf.c | 2 +- vcffilter.c | 2 +- 3 files changed, 17 insertions(+), 12 deletions(-) diff --git a/rbuf.h b/rbuf.h index 89ff9aabd..3d2805c77 100644 --- a/rbuf.h +++ b/rbuf.h @@ -174,23 +174,28 @@ static inline void rbuf_shift_n(rbuf_t *rbuf, int n) * rbuf_expand0() - expand round buffer and set the newly allocated elements to 0 * @rbuf: the rbuf holder * @type_t: data type + * @n: requested number of elements * @data: data array to be realloced * * Note: The new array is linearized and leaves the rbuf.f offset untouched, * thus the size of the new buffer is determined by the current position. */ -#define rbuf_expand0(rbuf,type_t,data) { \ - int m = (rbuf)->m + (rbuf)->f + 1; \ - m--, m|=m>>1, m|=m>>2, m|=m>>4, m|=m>>8, m|=m>>16, m++; /* kroundup32 */ \ - data = (type_t*) realloc(data, sizeof(type_t)*m); \ - type_t *ptr = data; \ - memset(ptr+(rbuf)->m,0,sizeof(type_t)*(m-(rbuf)->m)); \ - if ( (rbuf)->f ) \ +#define rbuf_expand0(rbuf,type_t,n,data) \ +{ \ + if ( n > (rbuf)->m ) \ { \ - memcpy(ptr+(rbuf)->m,ptr,sizeof(type_t)*(rbuf)->f); \ - memset(ptr,0,sizeof(type_t)*(rbuf)->f); \ + int m = n + (rbuf)->f; \ + m--, m|=m>>1, m|=m>>2, m|=m>>4, m|=m>>8, m|=m>>16, m++; /* kroundup32 */ \ + data = (type_t*) realloc(data, sizeof(type_t)*m); \ + type_t *ptr = data; \ + memset(ptr+(rbuf)->m,0,sizeof(type_t)*(m-(rbuf)->m)); \ + if ( (rbuf)->f ) \ + { \ + memcpy(ptr+(rbuf)->m,ptr,sizeof(type_t)*(rbuf)->f); \ + memset(ptr,0,sizeof(type_t)*(rbuf)->f); \ + } \ + (rbuf)->m = m; \ } \ - (rbuf)->m = m; \ } #endif diff --git a/test/test-rbuf.c b/test/test-rbuf.c index c428339fc..bc8ebe92b 100644 --- a/test/test-rbuf.c +++ b/test/test-rbuf.c @@ -64,7 +64,7 @@ int main(int argc, char **argv) debug_print(&rbuf, dat); printf("Expanding:\n"); - rbuf_expand0(&rbuf,int,dat); + rbuf_expand0(&rbuf,int,rbuf.n+1,dat); debug_print(&rbuf, dat); free(dat); diff --git a/vcffilter.c b/vcffilter.c index 481941c64..f2abf0f4b 100644 --- a/vcffilter.c +++ b/vcffilter.c @@ -227,7 +227,7 @@ static void buffered_filters(args_t *args, bcf1_t *line) if ( ilast>=0 && line->rid != args->rbuf_lines[ilast]->rid ) flush_buffer(args, args->rbuf.n); // new chromosome, flush everything - if ( args->rbuf.n >= args->rbuf.m ) rbuf_expand0(&args->rbuf,bcf1_t*,args->rbuf_lines); + rbuf_expand0(&args->rbuf,bcf1_t*,args->rbuf.n,args->rbuf_lines); // Insert the new record in the buffer. The line would be overwritten in // the next bcf_sr_next_line call, therefore we need to swap it with an From 33464ef77f4604f440cd10c6f0d6cd73a539ab05 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Sun, 3 May 2015 08:34:12 +0100 Subject: [PATCH 039/211] Moved hts_bcf_wmode to be accesible by plugins --- vcfisec.c | 8 -------- version.c | 8 ++++++++ 2 files changed, 8 insertions(+), 8 deletions(-) diff --git a/vcfisec.c b/vcfisec.c index c86b0cdb3..c082d68d0 100644 --- a/vcfisec.c +++ b/vcfisec.c @@ -128,14 +128,6 @@ FILE *open_file(char **fname, const char *mode, const char *fmt, ...) return fp; } -const char *hts_bcf_wmode(int file_type) -{ - if ( file_type == FT_BCF ) return "wbu"; // uncompressed BCF - if ( file_type & FT_BCF ) return "wb"; // compressed BCF - if ( file_type & FT_GZ ) return "wz"; // compressed VCF - return "w"; // uncompressed VCF -} - void isec_vcf(args_t *args) { bcf_srs_t *files = args->files; diff --git a/version.c b/version.c index 4a2ea7d35..00eeb5ab2 100644 --- a/version.c +++ b/version.c @@ -44,4 +44,12 @@ void error(const char *format, ...) exit(-1); } +const char *hts_bcf_wmode(int file_type) +{ + if ( file_type == FT_BCF ) return "wbu"; // uncompressed BCF + if ( file_type & FT_BCF ) return "wb"; // compressed BCF + if ( file_type & FT_GZ ) return "wz"; // compressed VCF + return "w"; // uncompressed VCF +} + From 0b8f0eaa67a4a4f73a566b739baddd9ac98d3959 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Wed, 20 May 2015 10:07:07 +0100 Subject: [PATCH 040/211] norm: Replace IUPAC ambiguity codes in fasta ref with Ns --- vcfnorm.c | 38 ++++++++++++++++++++++++++++++++++---- 1 file changed, 34 insertions(+), 4 deletions(-) diff --git a/vcfnorm.c b/vcfnorm.c index 613888002..b8a9ba30f 100644 --- a/vcfnorm.c +++ b/vcfnorm.c @@ -79,6 +79,18 @@ typedef struct } args_t; +static inline int replace_iupac_codes(char *seq, int nseq) +{ + // Replace ambiguity codes with N for now, it awaits to be seen what the VCF spec codifies in the end + int i, n = 0; + for (i=0; id.allele[0]); @@ -91,9 +103,11 @@ static void fix_ref(args_t *args, bcf1_t *line) char *ref = faidx_fetch_seq(args->fai, (char*)bcf_seqname(args->hdr,line), line->pos, line->pos+maxlen-1, &len); if ( !ref ) error("faidx_fetch_seq failed at %s:%d\n", bcf_seqname(args->hdr,line),line->pos+1); + replace_iupac_codes(ref,len); - // is the REF different? args->nref.tot++; + + // is the REF different? if ( !strncasecmp(line->d.allele[0],ref,reflen) ) { free(ref); return; } // is the REF allele missing or N? @@ -106,6 +120,14 @@ static void fix_ref(args_t *args, bcf1_t *line) return; } + // does REF contain non-standard bases? + if ( replace_iupac_codes(line->d.allele[0],strlen(line->d.allele[0])) ) + { + args->nref.set++; + bcf_update_alleles(args->hdr,line,(const char**)line->d.allele,line->n_allele); + if ( !strncasecmp(line->d.allele[0],ref,reflen) ) { free(ref); return; } + } + // is it swapped? for (i=1; in_allele; i++) { @@ -235,13 +257,21 @@ static int realign(args_t *args, bcf1_t *line) bcf_unpack(line, BCF_UN_STR); // Sanity check REF - int nref, reflen = strlen(line->d.allele[0]); + int i, nref, reflen = strlen(line->d.allele[0]); char *ref = faidx_fetch_seq(args->fai, (char*)args->hdr->id[BCF_DT_CTG][line->rid].key, line->pos, line->pos+reflen-1, &nref); if ( !ref ) error("faidx_fetch_seq failed at %s:%d\n", args->hdr->id[BCF_DT_CTG][line->rid].key, line->pos+1); + replace_iupac_codes(ref,nref); + + // does REF contain non-standard bases? + if ( replace_iupac_codes(line->d.allele[0],reflen) ) + { + args->nchanged++; + bcf_update_alleles(args->hdr,line,(const char**)line->d.allele,line->n_allele); + } if ( strcasecmp(ref,line->d.allele[0]) ) { if ( args->check_ref==CHECK_REF_EXIT ) - error("Reference allele mismatch at %s:%d .. '%s' vs '%s'\n", bcf_seqname(args->hdr,line),line->pos+1,ref,line->d.allele[0]); + error("Reference allele mismatch at %s:%d .. REF_SEQ:'%s' vs VCF:'%s'\n", bcf_seqname(args->hdr,line),line->pos+1,ref,line->d.allele[0]); if ( args->check_ref & CHECK_REF_WARN ) fprintf(stderr,"REF_MISMATCH\t%s\t%d\t%s\n", bcf_seqname(args->hdr,line),line->pos+1,line->d.allele[0]); free(ref); @@ -253,7 +283,6 @@ static int realign(args_t *args, bcf1_t *line) if ( line->n_allele == 1 ) return ERR_OK; // a REF // make a copy of each allele for trimming - int i; hts_expand0(kstring_t,line->n_allele,args->ntmp_als,args->tmp_als); kstring_t *als = args->tmp_als; for (i=0; in_allele; i++) @@ -290,6 +319,7 @@ static int realign(args_t *args, bcf1_t *line) free(ref); ref = faidx_fetch_seq(args->fai, (char*)args->hdr->id[BCF_DT_CTG][line->rid].key, line->pos-npad, line->pos-1, &nref); if ( !ref ) error("faidx_fetch_seq failed at %s:%d\n", args->hdr->id[BCF_DT_CTG][line->rid].key, line->pos-npad+1); + replace_iupac_codes(ref,nref); for (i=0; in_allele; i++) { ks_resize(&als[i], als[i].l + npad); From 1b485cee87c03ca06d36a902f394d105e0cdc5d2 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Fri, 24 Apr 2015 09:51:34 +0100 Subject: [PATCH 041/211] norm: Set freed alleles to NULL to prevent multiple free()s --- vcfnorm.c | 6 +++++- 1 file changed, 5 insertions(+), 1 deletion(-) diff --git a/vcfnorm.c b/vcfnorm.c index b8a9ba30f..aa82e949d 100644 --- a/vcfnorm.c +++ b/vcfnorm.c @@ -1312,7 +1312,11 @@ static void merge_biallelics_to_multiallelic(args_t *args, bcf1_t *dst, bcf1_t * if ( !args->als ) error("Failed to merge alleles at %s:%d\n", bcf_seqname(args->hdr,dst),dst->pos+1); } bcf_update_alleles(args->hdr, dst, (const char**)args->als, args->nals); - for (i=0; inals; i++) free(args->als[i]); + for (i=0; inals; i++) + { + free(args->als[i]); + args->als[i] = NULL; + } if ( lines[0]->d.n_flt ) bcf_update_filter(args->hdr, dst, lines[0]->d.flt, lines[0]->d.n_flt); for (i=1; i Date: Mon, 9 Mar 2015 21:53:01 +0000 Subject: [PATCH 042/211] stats: previously omitted ALT=. sites now count as SNPs in per-sample stats (HomRR counts) --- test/check.chk | 5 +++-- test/stats.chk | 3 +++ vcfstats.c | 7 +++++-- 3 files changed, 11 insertions(+), 4 deletions(-) diff --git a/test/check.chk b/test/check.chk index 1012e5c81..4ad6cf806 100644 --- a/test/check.chk +++ b/test/check.chk @@ -5,6 +5,7 @@ # SN [2]id [3]key [4]value SN 0 number of samples: 2 SN 0 number of records: 18 +SN 0 number of no-ALTs: 1 SN 0 number of SNPs: 5 SN 0 number of MNPs: 1 SN 0 number of indels: 9 @@ -70,8 +71,8 @@ DP 0 32 4 11.111111 0 0.000000 DP 0 35 4 11.111111 0 0.000000 # PSC, Per-sample counts # PSC [2]id [3]sample [4]nRefHom [5]nNonRefHom [6]nHets [7]nTransitions [8]nTransversions [9]nIndels [10]average depth [11]nSingletons -PSC 0 A 0 2 3 3 2 9 28.7 1 -PSC 0 B 1 1 3 2 2 9 28.7 0 +PSC 0 A 0 2 4 3 2 9 28.7 1 +PSC 0 B 1 1 4 2 2 9 28.7 0 # HWE # HWE [2]id [3]1st ALT allele frequency [4]Number of observations [5]25th percentile [6]median [7]75th percentile HWE 0 0.000000 2 0.490000 0.490000 0.990000 diff --git a/test/stats.chk b/test/stats.chk index ea87209c1..6f603866d 100644 --- a/test/stats.chk +++ b/test/stats.chk @@ -1,6 +1,7 @@ SN 0 number of samples: 3 SN 1 number of samples: 3 SN 0 number of records: 0 +SN 0 number of no-ALTs: 0 SN 0 number of SNPs: 0 SN 0 number of MNPs: 0 SN 0 number of indels: 0 @@ -8,6 +9,7 @@ SN 0 number of others: 0 SN 0 number of multiallelic sites: 0 SN 0 number of multiallelic SNP sites: 0 SN 1 number of records: 0 +SN 1 number of no-ALTs: 0 SN 1 number of SNPs: 0 SN 1 number of MNPs: 0 SN 1 number of indels: 0 @@ -15,6 +17,7 @@ SN 1 number of others: 0 SN 1 number of multiallelic sites: 0 SN 1 number of multiallelic SNP sites: 0 SN 2 number of records: 3 +SN 2 number of no-ALTs: 0 SN 2 number of SNPs: 3 SN 2 number of MNPs: 0 SN 2 number of indels: 0 diff --git a/vcfstats.c b/vcfstats.c index e0a0c2c83..8892f25fd 100644 --- a/vcfstats.c +++ b/vcfstats.c @@ -75,7 +75,7 @@ smpl_r_t; typedef struct { - int n_snps, n_indels, n_mnps, n_others, n_mals, n_snp_mals, n_records; + int n_snps, n_indels, n_mnps, n_others, n_mals, n_snp_mals, n_records, n_noalts; int *af_ts, *af_tv, *af_snps; // first bin of af_* stats are singletons #if HWE_STATS int *af_hwe; @@ -809,7 +809,7 @@ static void do_sample_stats(args_t *args, stats_t *stats, bcf_sr_t *reader, int case GT_HOM_AA: nalt_tot++; break; } #endif - if ( line_type&VCF_SNP ) + if ( line_type&VCF_SNP || line_type==VCF_REF ) // count ALT=. as SNP { if ( gt == GT_HET_RA ) stats->smpl_hets[is]++; else if ( gt == GT_HET_AA ) stats->smpl_hets[is]++; @@ -1019,6 +1019,8 @@ static void do_vcf_stats(args_t *args) stats->n_records++; + if ( line_type==VCF_REF ) + stats->n_noalts++; if ( line_type&VCF_SNP ) do_snp_stats(args, stats, reader); if ( line_type&VCF_INDEL ) @@ -1095,6 +1097,7 @@ static void print_stats(args_t *args) { stats_t *stats = &args->stats[id]; printf("SN\t%d\tnumber of records:\t%d\n", id, stats->n_records); + printf("SN\t%d\tnumber of no-ALTs:\t%d\n", id, stats->n_noalts); printf("SN\t%d\tnumber of SNPs:\t%d\n", id, stats->n_snps); printf("SN\t%d\tnumber of MNPs:\t%d\n", id, stats->n_mnps); printf("SN\t%d\tnumber of indels:\t%d\n", id, stats->n_indels); From 6fed5ac7a68a2cd0bc2121b99bcfbb3eacbec3e5 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Fri, 15 May 2015 09:35:43 +0100 Subject: [PATCH 043/211] stats: output also indel nHET and nAA in PSI stats --- test/check.chk | 4 ++++ test/stats.chk | 9 +++++++++ vcfstats.c | 33 +++++++++++++++++++++++---------- 3 files changed, 36 insertions(+), 10 deletions(-) diff --git a/test/check.chk b/test/check.chk index 4ad6cf806..0f78e654e 100644 --- a/test/check.chk +++ b/test/check.chk @@ -73,6 +73,10 @@ DP 0 35 4 11.111111 0 0.000000 # PSC [2]id [3]sample [4]nRefHom [5]nNonRefHom [6]nHets [7]nTransitions [8]nTransversions [9]nIndels [10]average depth [11]nSingletons PSC 0 A 0 2 4 3 2 9 28.7 1 PSC 0 B 1 1 4 2 2 9 28.7 0 +# PSI, Per-Sample Indels +# PSI [2]id [3]sample [4]in-frame [5]out-frame [6]not applicable [7]out/(in+out) ratio [8]nHets [9]nAA +PSI 0 A 0 0 0 0.00 9 0 +PSI 0 B 0 0 0 0.00 9 0 # HWE # HWE [2]id [3]1st ALT allele frequency [4]Number of observations [5]25th percentile [6]median [7]75th percentile HWE 0 0.000000 2 0.490000 0.490000 0.990000 diff --git a/test/stats.chk b/test/stats.chk index 6f603866d..6b2dd3be2 100644 --- a/test/stats.chk +++ b/test/stats.chk @@ -87,4 +87,13 @@ PSC 1 C 0 0 0 0 0 0 0.0 0 PSC 2 A 3 0 0 0 0 0 0.0 0 PSC 2 B 0 0 3 3 0 0 0.0 0 PSC 2 C 0 3 0 3 0 0 0.0 0 +PSI 0 A 0 0 0 0.00 0 0 +PSI 0 B 0 0 0 0.00 0 0 +PSI 0 C 0 0 0 0.00 0 0 +PSI 1 A 0 0 0 0.00 0 0 +PSI 1 B 0 0 0 0.00 0 0 +PSI 1 C 0 0 0 0.00 0 0 +PSI 2 A 0 0 0 0.00 0 0 +PSI 2 B 0 0 0 0.00 0 0 +PSI 2 C 0 0 0 0.00 0 0 HWE 2 49.000000 3 0.330000 0.330000 0.330000 diff --git a/vcfstats.c b/vcfstats.c index 8892f25fd..a207ccc53 100644 --- a/vcfstats.c +++ b/vcfstats.c @@ -92,6 +92,7 @@ typedef struct int in_frame, out_frame, na_frame, in_frame_alt1, out_frame_alt1, na_frame_alt1; int subst[15]; int *smpl_hets, *smpl_homRR, *smpl_homAA, *smpl_ts, *smpl_tv, *smpl_indels, *smpl_ndp, *smpl_sngl; + int *smpl_indel_hets, *smpl_indel_homs; int *smpl_frm_shifts; // not-applicable, in-frame, out-frame unsigned long int *smpl_dp; idist_t dp, dp_sites; @@ -437,6 +438,8 @@ static void init_stats(args_t *args) stats->smpl_hets = (int *) calloc(args->files->n_smpl,sizeof(int)); stats->smpl_homAA = (int *) calloc(args->files->n_smpl,sizeof(int)); stats->smpl_homRR = (int *) calloc(args->files->n_smpl,sizeof(int)); + stats->smpl_indel_hets = (int *) calloc(args->files->n_smpl,sizeof(int)); + stats->smpl_indel_homs = (int *) calloc(args->files->n_smpl,sizeof(int)); stats->smpl_ts = (int *) calloc(args->files->n_smpl,sizeof(int)); stats->smpl_tv = (int *) calloc(args->files->n_smpl,sizeof(int)); stats->smpl_indels = (int *) calloc(args->files->n_smpl,sizeof(int)); @@ -514,6 +517,8 @@ static void destroy_stats(args_t *args) if (stats->smpl_hets) free(stats->smpl_hets); if (stats->smpl_homAA) free(stats->smpl_homAA); if (stats->smpl_homRR) free(stats->smpl_homRR); + if (stats->smpl_indel_homs) free(stats->smpl_indel_homs); + if (stats->smpl_indel_hets) free(stats->smpl_indel_hets); if (stats->smpl_ts) free(stats->smpl_ts); if (stats->smpl_tv) free(stats->smpl_tv); if (stats->smpl_indels) free(stats->smpl_indels); @@ -827,7 +832,12 @@ static void do_sample_stats(args_t *args, stats_t *stats, bcf_sr_t *reader, int } if ( line_type&VCF_INDEL ) { - if ( gt != GT_HOM_RR ) stats->smpl_indels[is]++; + if ( gt != GT_HOM_RR ) + { + stats->smpl_indels[is]++; + if ( gt==GT_HET_RA || gt==GT_HET_AA ) stats->smpl_indel_hets[is]++; + else if ( gt==GT_HOM_AA ) stats->smpl_indel_homs[is]++; + } if ( stats->smpl_frm_shifts ) { assert( ialn_allele && jaln_allele ); @@ -1357,19 +1367,22 @@ static void print_stats(args_t *args) } - if ( args->exons ) + printf("# PSI, Per-Sample Indels\n# PSI\t[2]id\t[3]sample\t[4]in-frame\t[5]out-frame\t[6]not applicable\t[7]out/(in+out) ratio\t[8]nHets\t[9]nAA\n"); + for (id=0; idnstats; id++) { - printf("# PSI, Per-Sample Indels\n# PSI\t[2]id\t[3]sample\t[4]in-frame\t[5]out-frame\t[6]not applicable\t[7]out/(in+out) ratio\n"); - for (id=0; idnstats; id++) + stats_t *stats = &args->stats[id]; + for (i=0; ifiles->n_smpl; i++) { - stats_t *stats = &args->stats[id]; - for (i=0; ifiles->n_smpl; i++) + int na = 0, in = 0, out = 0; + if ( args->exons ) { - int na = stats->smpl_frm_shifts[i*3 + 0]; - int in = stats->smpl_frm_shifts[i*3 + 1]; - int out = stats->smpl_frm_shifts[i*3 + 2]; - printf("PSI\t%d\t%s\t%d\t%d\t%d\t%.2f\n", id,args->files->samples[i], in,out,na,in+out?1.0*out/(in+out):0); + na = stats->smpl_frm_shifts[i*3 + 0]; + in = stats->smpl_frm_shifts[i*3 + 1]; + out = stats->smpl_frm_shifts[i*3 + 2]; } + int nhom = stats->smpl_indel_homs[i]; + int nhet = stats->smpl_indel_hets[i]; + printf("PSI\t%d\t%s\t%d\t%d\t%d\t%.2f\t%d\t%d\n", id,args->files->samples[i], in,out,na,in+out?1.0*out/(in+out):0,nhet,nhom); } } From eee5780494c9716df2d99ec50bc4b347e638d843 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Tue, 10 Mar 2015 14:22:46 +0000 Subject: [PATCH 044/211] gtcheck: switch automatically to -G99 at ALT=. sites in absence of PLs --- vcfgtcheck.c | 14 ++++++++++++-- 1 file changed, 12 insertions(+), 2 deletions(-) diff --git a/vcfgtcheck.c b/vcfgtcheck.c index e3f03cc94..ac45e122f 100644 --- a/vcfgtcheck.c +++ b/vcfgtcheck.c @@ -408,8 +408,18 @@ static void check_gt(args_t *args) if ( !fake_pls ) { if ( (npl=bcf_get_format_int32(args->sm_hdr, sm_line, "PL", &args->pl_arr, &args->npl_arr)) <= 0 ) - error("PL not present at %s:%d?", args->sm_hdr->id[BCF_DT_CTG][sm_line->rid].key, sm_line->pos+1); - npl /= bcf_hdr_nsamples(args->sm_hdr); + { + if ( sm_line->n_allele==1 ) + { + // PL values may not be present when ALT=. (mpileup/bcftools output), in that case + // switch automatically to GT at these sites + npl = fake_PLs(args, args->sm_hdr, sm_line); + } + else + error("PL not present at %s:%d?\n", args->sm_hdr->id[BCF_DT_CTG][sm_line->rid].key, sm_line->pos+1); + } + else + npl /= bcf_hdr_nsamples(args->sm_hdr); } else npl = fake_PLs(args, args->sm_hdr, sm_line); From 7e15f83ae728f71c87f32b3d68e231f16022d182 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Tue, 10 Mar 2015 14:31:37 +0000 Subject: [PATCH 045/211] gtcheck: more informative description of discordance per-site --- vcfgtcheck.c | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/vcfgtcheck.c b/vcfgtcheck.c index ac45e122f..cbfba2510 100644 --- a/vcfgtcheck.c +++ b/vcfgtcheck.c @@ -99,7 +99,7 @@ static void plot_check(args_t *args, char *target_sample, char *query_sample) "fig,ax1 = plt.subplots(figsize=(8,5))\n" "ax2 = ax1.twinx()\n" "plots = ax1.plot([x[0] for x in dat],'o-', ms=3, color='g', mec='g', label='Discordance (total)')\n" - "plots += ax1.plot([x[1] for x in dat], '^', ms=3, color='r', mec='r', label='Discordance (per site)')\n" + "plots += ax1.plot([x[1] for x in dat], '^', ms=3, color='r', mec='r', label='Discordance (avg per site)')\n" "plots += ax2.plot([x[2] for x in dat],'v', ms=3, color='k', label='Number of sites')\n" "if iq!=-1:\n" " ax1.plot([iq],[dat[iq][0]],'o',color='orange', ms=9)\n" @@ -496,7 +496,7 @@ static void check_gt(args_t *args) for (i=0; ilks[i]; qsort(p, nsamples, sizeof(int*), cmp_doubleptr); - fprintf(fp, "# [1]CN\t[2]Discordance with %s (total)\t[3]Discordance (score per site)\t[4]Number of sites compared\t[5]Sample\t[6]Sample ID\n", args->sm_hdr->samples[query_isample]); + fprintf(fp, "# [1]CN\t[2]Discordance with %s (total)\t[3]Discordance (avg score per site)\t[4]Number of sites compared\t[5]Sample\t[6]Sample ID\n", args->sm_hdr->samples[query_isample]); for (i=0; ilks; From 255ee9a151cf7ca23ff6cf6f294f2d89dac48ea6 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Wed, 13 May 2015 10:16:50 +0100 Subject: [PATCH 046/211] Support for -i/-e filtering in vcfstats For consistency, changed existing -i/-e in vcfstats to -I/-E. [NEWS] * stats: -i/-e short options changed to -I/-E to accommodate the filtering -i/-e (--include/--exclude) options used in other tools --- doc/bcftools.txt | 12 ++++++++-- vcfstats.c | 60 ++++++++++++++++++++++++++++++++++++++---------- 2 files changed, 58 insertions(+), 14 deletions(-) diff --git a/doc/bcftools.txt b/doc/bcftools.txt index 574ac7ef5..027cb4b7e 100644 --- a/doc/bcftools.txt +++ b/doc/bcftools.txt @@ -1439,7 +1439,11 @@ columns. *--debug*:: produce verbose per-site and per-sample output -*-e, --exons* 'file.gz':: +*-e, --exclude* 'EXPRESSION':: + exclude sites for which 'EXPRESSION' is true. For valid expressions see + *<>*. + +*-E, --exons* 'file.gz':: tab-delimited file with exons for indel frameshifts statistics. The columns of the file are CHR, FROM, TO, with 1-based, inclusive, positions. The file is BGZF-compressed and indexed with tabix @@ -1453,7 +1457,11 @@ columns. *-F, --fasta-ref* 'ref.fa':: faidx indexed reference sequence file to determine INDEL context -*-i, --split-by-ID*:: +*-i, --include* 'EXPRESSION':: + include only sites for which 'EXPRESSION' is true. For valid expressions see + *<>*. + +*-I, --split-by-ID*:: collect stats separately for sites which have the ID column set ("known sites") or which do not have the ID column set ("novel sites"). diff --git a/vcfstats.c b/vcfstats.c index a207ccc53..578be7bce 100644 --- a/vcfstats.c +++ b/vcfstats.c @@ -1,6 +1,6 @@ /* vcfstats.c -- Produces stats which can be plotted using plot-vcfstats. - Copyright (C) 2012-2014 Genome Research Ltd. + Copyright (C) 2012-2015 Genome Research Ltd. Author: Petr Danecek @@ -38,6 +38,11 @@ THE SOFTWARE. */ #include #include #include "bcftools.h" +#include "filter.h" + +// Logic of the filters: include or exclude sites which match the filters? +#define FLT_INCLUDE 1 +#define FLT_EXCLUDE 2 #define HWE_STATS 1 #define QUAL_STATS 1 @@ -146,6 +151,11 @@ typedef struct char **argv, *exons_fname, *regions_list, *samples_list, *targets_list; int argc, verbose_sites, first_allele_only, samples_is_file; int split_by_id, nstats; + + filter_t *filter[2]; + char *filter_str; + int filter_logic; // include or exclude sites which match the filters? One of FLT_INCLUDE/FLT_EXCLUDE + // Per Sample r working data arrays of size equal to number of samples smpl_r_t* smpl_r_snps; smpl_r_t* smpl_r_indels; @@ -388,6 +398,13 @@ static void init_stats(args_t *args) args->nstats = args->files->nreaders==1 ? 1 : 3; if ( args->split_by_id ) args->nstats = 2; + if ( args->filter_str ) + { + args->filter[0] = filter_init(bcf_sr_get_header(args->files,0), args->filter_str); + if ( args->files->nreaders==2 ) + args->filter[1] = filter_init(bcf_sr_get_header(args->files,1), args->filter_str); + } + // AF corresponds to AC but is more robust for mixture of haploid and diploid GTs args->m_af = 101; for (i=0; ifiles->nreaders; i++) @@ -548,6 +565,8 @@ static void destroy_stats(args_t *args) free(args->smpl_r_snps); free(args->smpl_r_indels); if (args->indel_ctx) indel_ctx_destroy(args->indel_ctx); + if (args->filter[0]) filter_destroy(args->filter[0]); + if (args->filter[1]) filter_destroy(args->filter[1]); } static void init_iaf(args_t *args, bcf_sr_t *reader) @@ -1011,15 +1030,26 @@ static void do_vcf_stats(args_t *args) { bcf_sr_t *reader = NULL; bcf1_t *line = NULL; - int ret = 0, i; + int ret = 0, i, pass = 1; for (i=0; inreaders; i++) { if ( !bcf_sr_has_line(files,i) ) continue; + if ( args->filter[i] ) + { + int is_ok = filter_test(args->filter[i], bcf_sr_get_line(files,i), NULL); + if ( args->filter_logic & FLT_EXCLUDE ) is_ok = is_ok ? 0 : 1; + if ( !is_ok ) { pass = 0; break; } + } ret |= 1<readers[i]; - line = files->readers[i].buffer[0]; + if ( !reader ) + { + reader = &files->readers[i]; + line = bcf_sr_get_line(files,i); + } + } + if ( !pass ) continue; + int line_type = bcf_get_variant_types(line); init_iaf(args, reader); @@ -1441,10 +1471,12 @@ static void usage(void) fprintf(stderr, " -1, --1st-allele-only include only 1st allele at multiallelic sites\n"); fprintf(stderr, " -c, --collapse treat as identical records with , see man page for details [none]\n"); fprintf(stderr, " -d, --depth depth distribution: min,max,bin size [0,500,1]\n"); - fprintf(stderr, " -e, --exons tab-delimited file with exons for indel frameshifts (chr,from,to; 1-based, inclusive, bgzip compressed)\n"); + fprintf(stderr, " -e, --exclude exclude sites for which the expression is true (see man page for details)\n"); + fprintf(stderr, " -E, --exons tab-delimited file with exons for indel frameshifts (chr,from,to; 1-based, inclusive, bgzip compressed)\n"); fprintf(stderr, " -f, --apply-filters require at least one of the listed FILTER strings (e.g. \"PASS,.\")\n"); fprintf(stderr, " -F, --fasta-ref faidx indexed reference sequence file to determine INDEL context\n"); - fprintf(stderr, " -i, --split-by-ID collect stats for sites with ID separately (known vs novel)\n"); + fprintf(stderr, " -i, --include select sites for which the expression is true (see man page for details)\n"); + fprintf(stderr, " -I, --split-by-ID collect stats for sites with ID separately (known vs novel)\n"); fprintf(stderr, " -r, --regions restrict to comma-separated list of regions\n"); fprintf(stderr, " -R, --regions-file restrict to regions listed in a file\n"); fprintf(stderr, " -s, --samples list of samples for sample stats, \"-\" to include all samples\n"); @@ -1469,6 +1501,8 @@ int main_vcfstats(int argc, char *argv[]) static struct option loptions[] = { {"1st-allele-only",0,0,'1'}, + {"include",1,0,'i'}, + {"exclude",1,0,'e'}, {"help",0,0,'h'}, {"collapse",1,0,'c'}, {"regions",1,0,'r'}, @@ -1476,17 +1510,17 @@ int main_vcfstats(int argc, char *argv[]) {"verbose",0,0,'v'}, {"depth",1,0,'d'}, {"apply-filters",1,0,'f'}, - {"exons",1,0,'e'}, + {"exons",1,0,'E'}, {"samples",1,0,'s'}, {"samples-file",1,0,'S'}, - {"split-by-ID",0,0,'i'}, + {"split-by-ID",0,0,'I'}, {"targets",1,0,'t'}, {"targets-file",1,0,'T'}, {"fasta-ref",1,0,'F'}, {"user-tstv",1,0,'u'}, {0,0,0,0} }; - while ((c = getopt_long(argc, argv, "hc:r:R:e:s:S:d:it:T:F:f:1u:v",loptions,NULL)) >= 0) { + while ((c = getopt_long(argc, argv, "hc:r:R:e:s:S:d:i:t:T:F:f:1u:vIE:",loptions,NULL)) >= 0) { switch (c) { case 'u': add_user_stats(args,optarg); break; case '1': args->first_allele_only = 1; break; @@ -1513,10 +1547,12 @@ int main_vcfstats(int argc, char *argv[]) case 'f': args->files->apply_filters = optarg; break; case 'r': args->regions_list = optarg; break; case 'R': args->regions_list = optarg; regions_is_file = 1; break; - case 'e': args->exons_fname = optarg; break; + case 'E': args->exons_fname = optarg; break; case 's': args->samples_list = optarg; break; case 'S': args->samples_list = optarg; args->samples_is_file = 1; break; - case 'i': args->split_by_id = 1; break; + case 'I': args->split_by_id = 1; break; + case 'e': args->filter_str = optarg; args->filter_logic |= FLT_EXCLUDE; break; + case 'i': args->filter_str = optarg; args->filter_logic |= FLT_INCLUDE; break; case 'h': case '?': usage(); default: error("Unknown argument: %s\n", optarg); From 0bde8e0eaa50c17614bcc2d54e28f279bdff2ae6 Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Fri, 17 Jul 2015 13:34:18 +0100 Subject: [PATCH 047/211] remove install dependency on asciidoc doc/bcftools.1 exists and is updated by the maintainers from the bcftools.txt asciidoc, so there is no need to build this file for installation add some documentation to the Makefile to explain docs dependency on asciidoc Fixes #289 --- Makefile | 8 +++++++- 1 file changed, 7 insertions(+), 1 deletion(-) diff --git a/Makefile b/Makefile index bb75b8503..15eef3c25 100644 --- a/Makefile +++ b/Makefile @@ -178,9 +178,15 @@ doc/bcftools.1: doc/bcftools.txt doc/bcftools.html: doc/bcftools.txt cd doc && a2x -adate="$(DOC_DATE)" -aversion=$(DOC_VERSION) --doctype manpage --format xhtml bcftools.txt +# make docs target depends the a2x asciidoc program docs: doc/bcftools.1 doc/bcftools.html -install: $(PROG) doc/bcftools.1 +# To avoid an install dependency on asciidoc, the make install target +# does not depend on doc/bcftools.1 +# bcftools.1 is a generated file from the asciidoc bcftools.txt file. +# Since there is no make dependency, bcftools.1 can be out-of-date and +# make docs can be run to update if asciidoc is available +install: $(PROG) $(INSTALL_DIR) $(DESTDIR)$(bindir) $(DESTDIR)$(man1dir) $(DESTDIR)$(plugindir) $(INSTALL_PROGRAM) $(PROG) plot-vcfstats vcfutils.pl $(DESTDIR)$(bindir) $(INSTALL_DATA) doc/bcftools.1 $(DESTDIR)$(man1dir) From c4a53ac222735905e01f1ab0a6c22fc46de17c27 Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Tue, 28 Jul 2015 16:01:11 +0100 Subject: [PATCH 048/211] update man docs --- doc/bcftools.1 | 51 ++++++++++++++++++++++++++++++++++++++++------- doc/bcftools.html | 25 +++++++++++++++++------ doc/bcftools.txt | 4 ++-- 3 files changed, 65 insertions(+), 15 deletions(-) diff --git a/doc/bcftools.1 b/doc/bcftools.1 index a56a6b0ba..1269ac051 100644 --- a/doc/bcftools.1 +++ b/doc/bcftools.1 @@ -2,12 +2,12 @@ .\" Title: bcftools .\" Author: [see the "AUTHORS" section] .\" Generator: DocBook XSL Stylesheets v1.76.1 -.\" Date: 2015-07-28 09:49 BST +.\" Date: 2015-07-28 16:00 BST .\" Manual: \ \& .\" Source: \ \& .\" Language: English .\" -.TH "BCFTOOLS" "1" "2015\-07\-28 09:49 BST" "\ \&" "\ \&" +.TH "BCFTOOLS" "1" "2015\-07\-28 16:00 BST" "\ \&" "\ \&" .\" ----------------------------------------------------------------- .\" * Define some portability stuff .\" ----------------------------------------------------------------- @@ -41,7 +41,7 @@ Most commands accept VCF, bgzipped VCF and BCF with filetype detected automatica BCFtools is designed to work on a stream\&. It regards an input file "\-" as the standard input (stdin) and outputs to the standard output (stdout)\&. Several commands can thus be combined with Unix pipes\&. .SS "VERSION" .sp -This manual page was last updated \fB2015\-07\-28 09:49 BST\fR and refers to bcftools git version \fB1\&.2\-74\-g6ccecd1+\fR\&. +This manual page was last updated \fB2015\-07\-28 16:00 BST\fR and refers to bcftools git version \fB1\&.2\-96\-g5d52a36+\fR\&. .SS "BCF1" .sp The BCF1 format output by versions of samtools <= 0\&.1\&.19 is \fBnot\fR compatible with this version of bcftools\&. To read BCF1 files one can use the view command from old versions of bcftools packaged with samtools versions <= 0\&.1\&.19 to convert to VCF, which can then be read by this version of bcftools\&. @@ -2531,7 +2531,15 @@ ranges of depth distribution: min, max, and size of the bin produce verbose per\-site and per\-sample output .RE .PP -\fB\-e, \-\-exons\fR \fIfile\&.gz\fR +\fB\-e, \-\-exclude\fR \fIEXPRESSION\fR +.RS 4 +exclude sites for which +\fIEXPRESSION\fR +is true\&. For valid expressions see +\fBEXPRESSIONS\fR\&. +.RE +.PP +\fB\-E, \-\-exons\fR \fIfile\&.gz\fR .RS 4 tab\-delimited file with exons for indel frameshifts statistics\&. The columns of the file are CHR, FROM, TO, with 1\-based, inclusive, positions\&. The file is BGZF\-compressed and indexed with tabix .RE @@ -2557,7 +2565,15 @@ see faidx indexed reference sequence file to determine INDEL context .RE .PP -\fB\-i, \-\-split\-by\-ID\fR +\fB\-i, \-\-include\fR \fIEXPRESSION\fR +.RS 4 +include only sites for which +\fIEXPRESSION\fR +is true\&. For valid expressions see +\fBEXPRESSIONS\fR\&. +.RE +.PP +\fB\-I, \-\-split\-by\-ID\fR .RS 4 collect stats separately for sites which have the ID column set ("known sites") or which do not have the ID column set ("novel sites")\&. .RE @@ -3014,13 +3030,34 @@ FlagA=1 && FlagB=0 .sp -1 .IP \(bu 2.3 .\} -"\&." to test missing values in INFO tags +"\&." to test missing values +.sp +.if n \{\ +.RS 4 +.\} +.nf +DP="\&.", DP!="\&.", ALT="\&." +.fi +.if n \{\ +.RE +.\} +.RE +.sp +.RS 4 +.ie n \{\ +\h'-04'\(bu\h'+03'\c +.\} +.el \{\ +.sp -1 +.IP \(bu 2.3 +.\} +missing genotypes can be matched regardless of phase and ploidy ("\&.|\&.", "\&./\&.", "\&.") using this expression .sp .if n \{\ .RS 4 .\} .nf -DP="\&.", DP!="\&." +GT="\&." .fi .if n \{\ .RE diff --git a/doc/bcftools.html b/doc/bcftools.html index 9919479fb..2202b9f30 100644 --- a/doc/bcftools.html +++ b/doc/bcftools.html @@ -1,13 +1,13 @@ -bcftools

Name

bcftools — utilities for variant calling and manipulating VCFs and BCFs.

Synopsis

bcftools [--version|--version-only] [--help] [COMMAND] [OPTIONS]

DESCRIPTION

BCFtools is a set of utilities that manipulate variant calls in the Variant +bcftools

Name

bcftools — utilities for variant calling and manipulating VCFs and BCFs.

Synopsis

bcftools [--version|--version-only] [--help] [COMMAND] [OPTIONS]

DESCRIPTION

BCFtools is a set of utilities that manipulate variant calls in the Variant Call Format (VCF) and its binary counterpart BCF. All commands work transparently with both VCFs and BCFs, both uncompressed and BGZF-compressed.

Most commands accept VCF, bgzipped VCF and BCF with filetype detected automatically even when streaming from a pipe. Indexed VCF and BCF will work in all situations. Un-indexed VCF and BCF and streams will work in most, but not all situations.

BCFtools is designed to work on a stream. It regards an input file "-" as the standard input (stdin) and outputs to the standard output (stdout). Several -commands can thus be combined with Unix pipes.

VERSION

This manual page was last updated 2015-07-28 09:49 BST and refers to bcftools git version 1.2-74-g6ccecd1+.

BCF1

The BCF1 format output by versions of samtools <= 0.1.19 is not +commands can thus be combined with Unix pipes.

VERSION

This manual page was last updated 2015-07-28 16:00 BST and refers to bcftools git version 1.2-96-g5d52a36+.

BCF1

The BCF1 format output by versions of samtools <= 0.1.19 is not compatible with this version of bcftools. To read BCF1 files one can use the view command from old versions of bcftools packaged with samtools versions <= 0.1.19 to convert to VCF, which can then be read by @@ -1379,7 +1379,12 @@

produce verbose per-site and per-sample output
--e, --exons file.gz +-e, --exclude EXPRESSION +
+ exclude sites for which EXPRESSION is true. For valid expressions see + EXPRESSIONS. +
+-E, --exons file.gz
tab-delimited file with exons for indel frameshifts statistics. The columns of the file are CHR, FROM, TO, with 1-based, inclusive, positions. The file @@ -1393,7 +1398,12 @@
faidx indexed reference sequence file to determine INDEL context
--i, --split-by-ID +-i, --include EXPRESSION +
+ include only sites for which EXPRESSION is true. For valid expressions see + EXPRESSIONS. +
+-I, --split-by-ID
collect stats separately for sites which have the ID column set ("known sites") or which do not have the ID column set ("novel sites"). @@ -1601,8 +1611,11 @@ FILTER, QUAL, ID, REF, ALT[0]
  • 1 (or 0) to test the presence (or absence) of a flag

    FlagA=1 && FlagB=0
  • -"." to test missing values in INFO tags -

    DP=".", DP!="."
  • +"." to test missing values +

    DP=".", DP!=".", ALT="."
  • +missing genotypes can be matched regardless of phase and ploidy (".|.", "./.", ".") +using this expression +

    GT="."
  • TYPE for variant type in REF,ALT columns (indel,snp,mnp,ref,other)

    TYPE="indel" | TYPE="snp"
  • array subscripts, "*" for any field diff --git a/doc/bcftools.txt b/doc/bcftools.txt index 027cb4b7e..7fa3361f3 100644 --- a/doc/bcftools.txt +++ b/doc/bcftools.txt @@ -1682,9 +1682,9 @@ These filtering expressions are accepted by *<>*, FlagA=1 && FlagB=0 -* "." to test missing values in INFO tags +* "." to test missing values - DP=".", DP!="." + DP=".", DP!=".", ALT="." * missing genotypes can be matched regardless of phase and ploidy (".|.", "./.", ".") using this expression From 21e745acd9fe61c5844d2c63bc1a1eee6f827ad5 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Thu, 28 May 2015 10:41:32 +0100 Subject: [PATCH 049/211] call: new ploidy handling --- doc/bcftools.txt | 47 +++++- ploidy.c | 22 ++- ploidy.h | 14 +- vcfcall.c | 406 ++++++++++++++++++++++++++++++----------------- 4 files changed, 329 insertions(+), 160 deletions(-) diff --git a/doc/bcftools.txt b/doc/bcftools.txt index 7fa3361f3..0f6b43efd 100644 --- a/doc/bcftools.txt +++ b/doc/bcftools.txt @@ -194,8 +194,29 @@ specific commands to see if they apply. File of sample names to include or exclude if prefixed with "^". One sample per line. The command *<>* accepts an optional second - column indicating ploidy (0, 1 or 2) and can parse also PED files. - With *<> -C* 'trio', PED file is expected. + column indicating ploidy (0, 1 or 2) or sex (as defined by + *<>*, for example "F" or "M"), and can parse also PED + files. If the second column is not present, + the sex "F" is assumed. + With *<> -C* 'trio', PED file is expected. File + formats examples: +---- + sample1 1 + sample2 2 + sample3 2 + + or + + sample1 M + sample2 F + sample3 F + + or a .ped file (here is shown a minimum working example, the first column is + ignored and the last indicates sex: 1=male, 2=female) + + ignored daughterA fatherA motherA 2 + ignored sonB fatherB motherB 1 +---- *-t, --targets* \[^]'chr'|'chr:pos'|'chr:from-to'|'chr:from-'[,...]:: Similar as *-r, --regions*, but the next position is accessed by streaming the @@ -370,6 +391,28 @@ demand. The original calling model can be invoked with the *-c* option. *-O, --output-type* 'b'|'u'|'z'|'v':: see *<>* +*--ploidy* 'ASSEMBLY'['?'][[ploidy]]:: + predefined ploidy, use 'list' (or any other unused word) to print a list + of all predefined assemblies. Append a question mark to print the actual + definition. See also *--ploidy-file*. + +*--ploidy-file* 'FILE':: + ploidy definition given as a space/tab-delimited list of + CHROM, FROM, TO, SEX, PLOIDY. The SEX codes are arbitrary and + correspond to the ones used by *<>*. + The default ploidy can be given using the starred records (see + below), unlisted regions have ploidy 2. The default ploidy definition is +---- + X 1 60000 M 1 + X 2699521 154931043 M 1 + Y 1 59373566 M 1 + Y 1 59373566 F 0 + MT 1 16569 M 1 + MT 1 16569 F 1 + * * * M 2 + * * * F 2 +---- + *-r, --regions* 'chr'|'chr:pos'|'chr:from-to'|'chr:from-'[,...]:: see *<>* diff --git a/ploidy.c b/ploidy.c index 44dac77f8..3d3027aa2 100644 --- a/ploidy.c +++ b/ploidy.c @@ -33,12 +33,20 @@ struct _ploidy_t { int nsex, msex; // number of genders, m:number of allocated elements in id2sex array int dflt, min, max; // ploidy: default, min and max (only explicitly listed) + int *sex2dflt; regidx_t *idx; void *sex2id; char **id2sex; kstring_t tmp_str; }; +typedef struct +{ + int sex, ploidy; +} +sex_ploidy_t; + + regidx_t *ploidy_regions(ploidy_t *ploidy) { return ploidy->idx; @@ -78,6 +86,8 @@ int ploidy_parse(const char *line, char **chr_beg, char **chr_end, reg_t *reg, v hts_expand0(char*,ploidy->nsex,ploidy->msex,ploidy->id2sex); ploidy->id2sex[ploidy->nsex-1] = strdup(ploidy->tmp_str.s); sp->sex = khash_str2int_inc(ploidy->sex2id, ploidy->id2sex[ploidy->nsex-1]); + ploidy->sex2dflt = (int*) realloc(ploidy->sex2dflt,sizeof(int)*ploidy->nsex); + ploidy->sex2dflt[ploidy->nsex-1] = ploidy->dflt; } ss = se; @@ -88,6 +98,15 @@ int ploidy_parse(const char *line, char **chr_beg, char **chr_end, reg_t *reg, v if ( sp->ploidy < ploidy->min ) ploidy->min = sp->ploidy; if ( sp->ploidy > ploidy->max ) ploidy->max = sp->ploidy; + // Special case, chr="*" stands for a default value + ss = (char*) line; + while ( *ss && isspace(*ss) ) ss++; + if ( ss[0]=='*' && (!ss[1] || isspace(ss[1])) ) + { + ploidy->sex2dflt[ploidy->nsex-1] = sp->ploidy; + return -1; + } + return 0; } @@ -141,6 +160,7 @@ void ploidy_destroy(ploidy_t *ploidy) if ( ploidy->idx ) regidx_destroy(ploidy->idx); free(ploidy->id2sex); free(ploidy->tmp_str.s); + free(ploidy->sex2dflt); free(ploidy); } @@ -157,7 +177,7 @@ int ploidy_query(ploidy_t *ploidy, char *seq, int pos, int *sex2ploidy, int *min if ( min ) *min = ploidy->dflt; if ( max ) *max = ploidy->dflt; if ( sex2ploidy ) - for (i=0; insex; i++) sex2ploidy[i] = ploidy->dflt; + for (i=0; insex; i++) sex2ploidy[i] = ploidy->sex2dflt[i]; return 0; } diff --git a/ploidy.h b/ploidy.h index b505eb95f..6deef737f 100644 --- a/ploidy.h +++ b/ploidy.h @@ -40,13 +40,16 @@ ploidy_destroy(pld); An example of ploidy file format follows. The coordinates are 1-based and - inclusive: + inclusive. The "*" records define the default ploidy for each sex. If not + present, the default_ploidy passed to ploidy_init is used instead: X 1 60000 M 1 X 2699521 154931043 M 1 Y 1 59373566 M 1 Y 1 59373566 F 0 MT 1 16569 M 1 MT 1 16569 F 1 + * * * M 2 + * * * F 2 */ #ifndef __PLOIDY_H__ @@ -56,17 +59,10 @@ typedef struct _ploidy_t ploidy_t; -typedef struct -{ - int sex, ploidy; -} -sex_ploidy_t; - - /* * ploidy_init() * @param fname: input file name or NULL if default ploidy from example above should be used - * @param dflt: default ploidy to use for unlisted regions + * @param dflt: default ploidy to use for unlisted regions (the '* * *' records have precedence). * * Returns new structure on success or NULL on error. */ diff --git a/vcfcall.c b/vcfcall.c index 1aad4662f..181f73ef5 100644 --- a/vcfcall.c +++ b/vcfcall.c @@ -34,10 +34,12 @@ THE SOFTWARE. */ #include #include #include +#include #include #include "bcftools.h" #include "call.h" #include "prob1.h" +#include "ploidy.h" void error(const char *format, ...); @@ -73,6 +75,12 @@ typedef struct char *regions, *targets; // regions to process int regions_is_file, targets_is_file; + char *samples_fname; + int samples_is_file; + int *sample2sex; // mapping for ploidy. If negative, interpreted as -1*ploidy + int *sex2ploidy, *sex2ploidy_prev, nsex; + ploidy_t *ploidy; + bcf1_t *missed_line; call_t aux; // parameters and temporary data gvcf_t gvcf; @@ -92,43 +100,96 @@ typedef struct } args_t; -static family_t *get_family(family_t *fam, int nfam, char *name) +static char **add_sample(void *name2idx, char **lines, int *nlines, int *mlines, char *name, char sex, int *ith) { - int i; - for (i=0; ifams, call->nfams, str.s); - if ( !fam ) + char sex = col_ends[3][1]=='1' ? 'M' : 'F'; + lines = add_sample(name2idx, lines, &nlines, &mlines, col_ends[0]+1, sex, &j); + if ( strcmp(col_ends[1]+1,"0") && strcmp(col_ends[2]+1,"0") ) // father and mother { call->nfams++; hts_expand(family_t, call->nfams, call->mfams, call->fams); - fam = &call->fams[call->nfams-1]; - fam->name = strdup(str.s); - for (j=0; j<3; j++) fam->sample[j] = -1; - } - - int ploidy = 2; - if ( call->flag & (CALL_CHR_X|CALL_CHR_Y) ) - { - if ( col_ends[3][1]=='1' ) ploidy = 1; // male: one chrX and one chrY copy - else - ploidy = call->flag & CALL_CHR_X ? 2 : 0; // female: two chrX copies, no chrY - } - sam = add_sample(sam, &n, &max, col_ends[0]+1, ploidy, &j); - if ( strcmp(col_ends[1]+1,"0") ) // father - { - if ( fam->sample[CHILD]>=0 ) error("Multiple childs in %s [%s,%s]\n", str.s, sam[j],sam[fam->sample[CHILD]]); - fam->sample[CHILD] = j; - if ( fam->sample[FATHER]>=0 ) error("Two fathers in %s?\n", str.s); - sam = add_sample(sam, &n, &max, col_ends[1]+1, call->flag & (CALL_CHR_X|CALL_CHR_Y) ? 1 : 2, &fam->sample[FATHER]); - } - if ( strcmp(col_ends[2]+1,"0") ) // mother - { - if ( fam->sample[MOTHER]>=0 ) error("Two mothers in %s?\n", str.s); - sam = add_sample(sam, &n, &max, col_ends[2]+1, call->flag & CALL_CHR_Y ? 0 : 2, &fam->sample[MOTHER]); + family_t *fam = &call->fams[call->nfams-1]; + fam_str.l = 0; + ksprintf(&fam_str,"father=%s, mother=%s, child=%s", col_ends[1]+1,col_ends[2]+1,col_ends[0]+1); + fam->name = strdup(fam_str.s); + + if ( !khash_str2int_has_key(name2idx, col_ends[1]+1) ) + lines = add_sample(name2idx, lines, &nlines, &mlines, col_ends[1]+1, 'M', &fam->sample[FATHER]); + if ( !khash_str2int_has_key(name2idx, col_ends[2]+1) ) + lines = add_sample(name2idx, lines, &nlines, &mlines, col_ends[2]+1, 'F', &fam->sample[MOTHER]); + + khash_str2int_get(name2idx, col_ends[0]+1, &fam->sample[CHILD]); + khash_str2int_get(name2idx, col_ends[1]+1, &fam->sample[FATHER]); + khash_str2int_get(name2idx, col_ends[2]+1, &fam->sample[MOTHER]); } } free(str.s); + free(fam_str.s); + khash_str2int_destroy_free(name2idx); - if ( i!=_n ) // not a ped file + if ( i!=nvals ) // not a ped file { - if ( i>0 ) error("Could not parse the samples, thought it was PED format, some rows have 5 columns?!\n"); + if ( i>0 ) error("Could not parse samples, not a PED format.\n"); return NULL; } - assert( n==_n ); - for (i=0; infams; i++) - assert( call->fams[i].sample[0]>=0 && call->fams[i].sample[1]>=0 && call->fams[i].sample[2]>=0 ); // multiple childs, not a trio - - // for (i=0; infams; i++) - // fprintf(stderr,"mother=%s, father=%s, child=%s\n", sam[call->fams[i].sample[MOTHER]],sam[call->fams[i].sample[FATHER]],sam[call->fams[i].sample[CHILD]]); - - return sam; + *nsmpl = nlines; + return lines; } @@ -203,44 +250,80 @@ static char **parse_ped_samples(call_t *call, char **vals, int _n) * Alternatively, if no such file exists, the file name is interpreted * as a comma-separated list of samples. When ploidy is not present, * the default ploidy 2 is assumed. - * - * Returns an array of sample names, where the byte value just after \0 - * indicates the ploidy. */ -static char **read_samples(call_t *call, const char *fn, int is_file, int *_n) +static void set_samples(args_t *args, const char *fn, int is_file) { - int i, n; - char **vals = hts_readlist(fn, is_file, &n); - if ( !vals ) error("Could not read the file: %s\n", fn); + int i, nlines; + char **lines = hts_readlist(fn, is_file, &nlines); + if ( !lines ) error("Could not read the file: %s\n", fn); + + int nsmpls; + char **smpls = parse_ped_samples(&args->aux, lines, nlines, &nsmpls); + if ( smpls ) + { + for (i=0; isamples_map = (int*) malloc(sizeof(int)*bcf_hdr_nsamples(args->aux.hdr)); // for subsetting + args->sample2sex = (int*) malloc(sizeof(int)*bcf_hdr_nsamples(args->aux.hdr)); + int dflt_sex_id = ploidy_add_sex(args->ploidy, "F"); + for (i=0; iaux.hdr); i++) args->sample2sex[i] = dflt_sex_id; + + int *old2new = (int*) malloc(sizeof(int)*bcf_hdr_nsamples(args->aux.hdr)); + for (i=0; iaux.hdr); i++) old2new[i] = -1; - char **smpls = parse_ped_samples(call, vals, n); - if ( !smpls ) + int nsmpl = 0, map_needed = 0; + for (i=0; iaux.hdr, BCF_DT_SAMPLE, ss); + if ( ismpl < 0 ) { fprintf(stderr,"Warning: No such sample in the VCF: %s\n",ss); continue; } + + ss = se+1; + while ( *ss && isspace(*ss) ) ss++; + if ( !*ss ) ss = "2"; // default ploidy + se = ss; + while ( *se && !isspace(*se) ) se++; + if ( se==ss ) { *xptr = x; error("Could not parse: \"%s\"\n", lines[i]); } + + if ( ss[1]==0 && (ss[0]=='0' || ss[0]=='1' || ss[0]=='2') ) + args->sample2sex[nsmpl] = -1*(ss[0]-'0'); + else + args->sample2sex[nsmpl] = ploidy_add_sex(args->ploidy, ss); + + if ( ismpl!=nsmpl ) map_needed = 1; + args->samples_map[nsmpl] = ismpl; + old2new[ismpl] = nsmpl; + nsmpl++; + } + + for (i=0; iaux.nfams; i++) + { + int j, nmiss = 0; + family_t *fam = &args->aux.fams[i]; + for (j=0; j<3; j++) { - char *s = vals[i]; - while ( *s && !isspace(*s) ) s++; - int len = s-vals[i]; - smpls[i] = (char*) malloc(len+2); - strncpy(smpls[i],vals[i],len); - smpls[i][len] = 0; - while ( *s && isspace(*s) ) s++; - int x = 2; - if ( *s ) - { - x = (int)s[0] - '0'; // Convert ASCII digit to decimal - if (x != 0 && x != 1 && x != 2) error("Ploidy can only be 0, 1 or 2: %s\n", vals[i]); - } - smpls[i][len+1] = x; + fam->sample[i] = old2new[fam->sample[i]]; + if ( fam->sample[i]<0 ) nmiss++; } + assert( nmiss==0 || nmiss==3 ); } + free(old2new); - for (i=0; isamples_map); args->samples_map = NULL; } - *_n = n; - return smpls; + args->nsamples = nsmpl; + args->samples = lines; } static void init_missed_line(args_t *args) @@ -302,13 +385,29 @@ static void init_data(args_t *args) error("Failed to read the targets: %s\n", args->regions); } - int i; if ( !bcf_sr_add_reader(args->aux.srs, args->bcf_fname) ) error("Failed to open %s: %s\n", args->bcf_fname,bcf_sr_strerror(args->aux.srs->errnum)); + args->aux.hdr = bcf_sr_get_header(args->aux.srs,0); - if ( args->nsamples && args->nsamples != bcf_hdr_nsamples(args->aux.srs->readers[0].header) ) + int i; + if ( args->samples_fname ) { - args->samples_map = (int *) malloc(sizeof(int)*args->nsamples); - args->aux.hdr = bcf_hdr_subset(args->aux.srs->readers[0].header, args->nsamples, args->samples, args->samples_map); + set_samples(args, args->samples_fname, args->samples_is_file); + if ( args->aux.flag&CALL_CONSTR_TRIO ) + { + if ( 3*args->aux.nfams!=args->nsamples ) error("Expected only trios in %s, sorry!\n", args->samples_fname); + fprintf(stderr,"Detected %d samples in %d trio families\n", args->nsamples,args->aux.nfams); + } + args->nsex = ploidy_nsex(args->ploidy); + args->sex2ploidy = (int*) calloc(args->nsex,sizeof(int)); + args->sex2ploidy_prev = (int*) calloc(args->nsex,sizeof(int)); + args->aux.ploidy = (uint8_t*) malloc(args->nsamples); + for (i=0; insamples; i++) args->aux.ploidy[i] = 2; + for (i=0; insex; i++) args->sex2ploidy_prev[i] = 2; + } + + if ( args->samples_map ) + { + args->aux.hdr = bcf_hdr_subset(bcf_sr_get_header(args->aux.srs,0), args->nsamples, args->samples, args->samples_map); if ( !args->aux.hdr ) error("Error occurred while subsetting samples\n"); for (i=0; insamples; i++) if ( args->samples_map[i]<0 ) error("No such sample: %s\n", args->samples[i]); @@ -316,43 +415,12 @@ static void init_data(args_t *args) } else { - args->aux.hdr = bcf_hdr_dup(args->aux.srs->readers[0].header); + args->aux.hdr = bcf_hdr_dup(bcf_sr_get_header(args->aux.srs,0)); for (i=0; insamples; i++) if ( bcf_hdr_id2int(args->aux.hdr,BCF_DT_SAMPLE,args->samples[i])<0 ) error("No such sample: %s\n", args->samples[i]); } - // Reorder ploidy and family indexes to match mpileup's output and exclude samples which are not available - if ( args->aux.ploidy ) - { - for (i=0; iaux.nfams; i++) - { - int j; - for (j=0; j<3; j++) - { - int k = bcf_hdr_id2int(args->aux.hdr, BCF_DT_SAMPLE, args->samples[ args->aux.fams[i].sample[j] ]); - if ( k<0 ) error("No such sample: %s\n", args->samples[ args->aux.fams[i].sample[j] ]); - args->aux.fams[i].sample[j] = k; - } - } - uint8_t *ploidy = (uint8_t*) calloc(bcf_hdr_nsamples(args->aux.hdr), 1); - for (i=0; insamples; i++) // i index in -s sample list - { - int j = bcf_hdr_id2int(args->aux.hdr, BCF_DT_SAMPLE, args->samples[i]); // j index in the output VCF / subset VCF - if ( j<0 ) - { - fprintf(stderr,"Warning: no such sample: \"%s\"\n", args->samples[i]); - continue; - } - ploidy[j] = args->aux.ploidy[i]; - } - args->nsamples = bcf_hdr_nsamples(args->aux.hdr); - for (i=0; insamples; i++) - assert( ploidy[i]==0 || ploidy[i]==1 || ploidy[i]==2 ); - free(args->aux.ploidy); - args->aux.ploidy = ploidy; - } - args->out_fh = hts_open(args->output_fname, hts_bcf_wmode(args->output_type)); if ( args->out_fh == NULL ) error("Can't write to \"%s\": %s\n", args->output_fname, strerror(errno)); @@ -400,11 +468,15 @@ static void destroy_data(args_t *args) free(args->aux.fams); } if ( args->missed_line ) bcf_destroy(args->missed_line); + ploidy_destroy(args->ploidy); if ( args->gvcf.line ) bcf_destroy(args->gvcf.line); free(args->gvcf.gt); free(args->gvcf.dp); + free(args->sex2ploidy); + free(args->sex2ploidy_prev); free(args->samples); free(args->samples_map); + free(args->sample2sex); free(args->aux.ploidy); bcf_hdr_destroy(args->aux.hdr); hts_close(args->out_fh); @@ -455,6 +527,39 @@ static int parse_format_flag(const char *str) } +ploidy_t *init_ploidy(char *alias) +{ + const ploidy_predef_t *pld = ploidy_predefs; + + int detailed = 0, len = strlen(alias); + if ( alias[len-1]=='?' ) { detailed = 1; alias[len-1] = 0; } + + while ( pld->alias && strcasecmp(alias,pld->alias) ) pld++; + + if ( !pld->alias ) + { + fprintf(stderr,"Predefined ploidies:\n"); + pld = ploidy_predefs; + while ( pld->alias ) + { + fprintf(stderr,"%s\n .. %s\n\n", pld->alias,pld->about); + if ( detailed ) + fprintf(stderr,"%s\n", pld->ploidy); + pld++; + } + fprintf(stderr,"Run as --ploidy (e.g. --ploidy GRCh37).\n"); + fprintf(stderr,"To see the detailed ploidy definition, append a question mark (e.g. --ploidy GRCh37?).\n"); + fprintf(stderr,"\n"); + exit(-1); + } + else if ( detailed ) + { + fprintf(stderr,"%s", pld->ploidy); + exit(-1); + } + return ploidy_init_string(pld->ploidy,2); +} + static void usage(args_t *args) { fprintf(stderr, "\n"); @@ -468,6 +573,8 @@ static void usage(args_t *args) fprintf(stderr, "File format options:\n"); fprintf(stderr, " -o, --output write output to a file [standard output]\n"); fprintf(stderr, " -O, --output-type output type: 'b' compressed BCF; 'u' uncompressed BCF; 'z' compressed VCF; 'v' uncompressed VCF [v]\n"); + fprintf(stderr, " --ploidy [?] predefined ploidy, 'list' to print available settings, append '?' for details\n"); + fprintf(stderr, " --ploidy-file space/tab-delimited list of CHROM,FROM,TO,SEX,PLOIDY\n"); fprintf(stderr, " -r, --regions restrict to comma-separated list of regions\n"); fprintf(stderr, " -R, --regions-file restrict to regions listed in a file\n"); fprintf(stderr, " -s, --samples list of samples to include [all samples]\n"); @@ -506,7 +613,7 @@ static void usage(args_t *args) int main_vcfcall(int argc, char *argv[]) { - char *samples_fname = NULL; + char *ploidy_fname = NULL, *ploidy = NULL; args_t args; memset(&args, 0, sizeof(args_t)); args.argc = argc; args.argv = argv; @@ -522,8 +629,7 @@ int main_vcfcall(int argc, char *argv[]) args.aux.trio_Pm_SNPs = 1 - 1e-8; args.aux.trio_Pm_ins = args.aux.trio_Pm_del = 1 - 1e-9; - int i, c, samples_is_file = 0; - + int c; static struct option loptions[] = { {"help",0,0,'h'}, @@ -551,6 +657,10 @@ int main_vcfcall(int argc, char *argv[]) {"chromosome-X",0,0,'X'}, {"chromosome-Y",0,0,'Y'}, {"novel-rate",1,0,'n'}, + {"ploidy",1,0,1}, + {"ploidy-file",1,0,2}, + {"chromosome-X",1,0,'X'}, + {"chromosome-Y",1,0,'Y'}, {0,0,0,0} }; @@ -564,6 +674,10 @@ int main_vcfcall(int argc, char *argv[]) args.gvcf.min_dp = strtol(optarg,&tmp,10); if ( *tmp ) error("Could not parse, expected integer argument: -g %s\n", optarg); break; + case 2 : ploidy_fname = optarg; break; + case 1 : ploidy = optarg; break; + case 'X': ploidy = "X"; fprintf(stderr,"Warning: -X will be deprecated, please use --ploidy instead.\n"); break; + case 'Y': ploidy = "Y"; fprintf(stderr,"Warning: -Y will be deprecated, please use --ploidy instead.\n"); break; case 'f': args.aux.output_tags |= parse_format_flag(optarg); break; case 'M': args.flag &= ~CF_ACGT_ONLY; break; // keep sites where REF is N case 'N': args.flag |= CF_ACGT_ONLY; break; // omit sites where first base in REF is N (the new default) @@ -586,8 +700,6 @@ int main_vcfcall(int argc, char *argv[]) else if ( !strcasecmp(optarg,"trio") ) args.aux.flag |= CALL_CONSTR_TRIO; else error("Unknown argument to -C: \"%s\"\n", optarg); break; - case 'X': args.aux.flag |= CALL_CHR_X; break; - case 'Y': args.aux.flag |= CALL_CHR_Y; break; case 'V': if ( !strcasecmp(optarg,"snps") ) args.flag |= CF_INDEL_ONLY; else if ( !strcasecmp(optarg,"indels") ) args.flag |= CF_NO_INDEL; @@ -606,11 +718,15 @@ int main_vcfcall(int argc, char *argv[]) case 'R': args.regions = optarg; args.regions_is_file = 1; break; case 't': args.targets = optarg; break; case 'T': args.targets = optarg; args.targets_is_file = 1; break; - case 's': samples_fname = optarg; break; - case 'S': samples_fname = optarg; samples_is_file = 1; break; + case 's': args.samples_fname = optarg; break; + case 'S': args.samples_fname = optarg; args.samples_is_file = 1; break; default: usage(&args); } } + // Sanity check options and initialize + if ( ploidy_fname ) args.ploidy = ploidy_init(ploidy_fname, 2); + else if ( ploidy ) args.ploidy = init_ploidy(ploidy); + if ( optind>=argc ) { if ( !isatty(fileno((FILE *)stdin)) ) args.bcf_fname = "-"; // reading from stdin @@ -618,18 +734,13 @@ int main_vcfcall(int argc, char *argv[]) } else args.bcf_fname = argv[optind++]; - // Sanity check options and initialize - if ( samples_fname ) + if ( !ploidy_fname && !ploidy ) { - args.samples = read_samples(&args.aux, samples_fname, samples_is_file, &args.nsamples); - args.aux.ploidy = (uint8_t*) calloc(args.nsamples+1, 1); - args.aux.all_diploid = 1; - for (i=0; i Date: Wed, 5 Aug 2015 12:21:21 +0100 Subject: [PATCH 050/211] vcfnorm: merge records even if tags are missing from some records * replaced some asserts with more informative error messages * merging of Number=G INFO fields for haploid sites is still a todo * tags that are not in the first record are going to be dropped, but this would require a more substantial rewrite Fixes #282 --- test/norm.merge.3.out | 34 ++++++++++++++++++++++++++++++++++ test/norm.merge.3.vcf | 37 +++++++++++++++++++++++++++++++++++++ test/test.pl | 1 + vcfnorm.c | 41 +++++++++++++++++++++++++++++++---------- 4 files changed, 103 insertions(+), 10 deletions(-) create mode 100644 test/norm.merge.3.out create mode 100644 test/norm.merge.3.vcf diff --git a/test/norm.merge.3.out b/test/norm.merge.3.out new file mode 100644 index 000000000..788a42751 --- /dev/null +++ b/test/norm.merge.3.out @@ -0,0 +1,34 @@ +##fileformat=VCFv4.2 +##FILTER= +##contig= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +#CHROM POS ID REF ALT QUAL FILTER INFO FORMAT sample_1 sample_2 +11 48245184 . C G . PASS FL=0.34;FLG=0.1,0,0.9;FLA=88.4;FLR=99,88.4;INT=0;INTG=0,1,9;INTA=88;INTR=99,88;F1;ST=alpha;STA=alpha;STR=alpha,beta;STG=alpha,beta,gamma GT:FL:FLG:FLA:FLR:INT:INTG:INTA:INTR:ST:STA:STR:STG 0|0:0.34:0.1,0,0.9:88.4:99,88.4:0:0,1,9:88:99,88:alpha:alpha:alpha,beta:alpha,beta,gamma 0|0:0.34:0.1,0,0.9:88.4:99,88.4:0:0,1,9:88:99,88:alpha:alpha:alpha,beta:alpha,beta,gamma +11 48245185 . C G,T . PASS FL=0.34;FLG=0.1,0,0.9,.,.,.;FLA=88.4,.;FLR=99,88.4,.;INT=0;INTG=0,1,9,.,.,.;INTA=88,.;INTR=99,88,.;F1;ST=alpha;STA=alpha,.;STR=alpha,beta,.;STG=alpha,beta,gamma,.,.,. GT:FL:FLG:FLA:FLR:INT:INTG:INTA:INTR:ST:STA:STR:STG 0|0:0.34:0.1,0,0.9,.,.,.:88.4,.:99,88.4,.:0:0,1,9,.,.,.:88,.:99,88,.:alpha:alpha,.:alpha,beta,.:alpha,beta,gamma,.,.,. 0|0:0.34:0.1,0,0.9,.,.,.:88.4,.:99,88.4,.:0:0,1,9,.,.,.:88,.:99,88,.:alpha:alpha,.:alpha,beta,.:alpha,beta,gamma,.,.,. +11 48245186 . C G,T . PASS FL=0.34;FLA=88.4,88.4;FLR=99,88.4,88.4;INT=0;INTA=88,11;INTR=99,88,11;F1;ST=alpha;STA=alpha,beta;STR=alpha,beta,gamma GT:FL:FLA:FLR:INT:INTA:INTR:ST:STA:STR 0|0:0.34:88.4,11:99,88.4,11:0:88,11:99,88,11:alpha:alpha,beta:alpha,beta,gamma 0|0:0.34:88.4,11:99,88.4,11:0:88,11:99,88,11:alpha:alpha,beta:alpha,beta,gamma +11 48245187 . C G,T . PASS FL=0.34;FLA=88.4,.;FLR=99,88.4,.;INT=0;INTA=88,.;INTR=99,88,.;F1;ST=alpha;STA=alpha,.;STR=alpha,beta,. GT:FL:FLG:FLA:FLR:INT:INTG:INTA:INTR:ST:STA:STR:STG 0:0.34:0.1,0,.:88.4,.:99,88.4,.:0:0,1,.:88,.:99,88,.:alpha:alpha,.:alpha,beta,.:alpha,beta,. 0:0.34:0.1,0,.:88.4,.:99,88.4,.:0:0,1,.:88,.:99,88,.:alpha:alpha,.:alpha,beta,.:alpha,beta,. diff --git a/test/norm.merge.3.vcf b/test/norm.merge.3.vcf new file mode 100644 index 000000000..f2b980a09 --- /dev/null +++ b/test/norm.merge.3.vcf @@ -0,0 +1,37 @@ +##fileformat=VCFv4.2 +##contig= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +#CHROM POS ID REF ALT QUAL FILTER INFO FORMAT sample_1 sample_2 +11 48245184 . C G . PASS FL=0.34;FLG=0.1,0,0.9;FLA=88.4;FLR=99.0,88.4;INT=0;INTG=0,1,9;INTA=88;INTR=99,88;F1;ST=alpha;STA=alpha;STR=alpha,beta;STG=alpha,beta,gamma GT:FL:FLG:FLA:FLR:INT:INTG:INTA:INTR:ST:STA:STR:STG 0|0:0.34:0.1,0,0.9:88.4:99.0,88.4:0:0,1,9:88:99,88:alpha:alpha:alpha,beta:alpha,beta,gamma 0|0:0.34:0.1,0,0.9:88.4:99.0,88.4:0:0,1,9:88:99,88:alpha:alpha:alpha,beta:alpha,beta,gamma +11 48245184 . C G . PASS . GT 0/0 0/0 +11 48245185 . C G . PASS FL=0.34;FLG=0.1,0,0.9;FLA=88.4;FLR=99.0,88.4;INT=0;INTG=0,1,9;INTA=88;INTR=99,88;F1;ST=alpha;STA=alpha;STR=alpha,beta;STG=alpha,beta,gamma GT:FL:FLG:FLA:FLR:INT:INTG:INTA:INTR:ST:STA:STR:STG 0|0:0.34:0.1,0,0.9:88.4:99.0,88.4:0:0,1,9:88:99,88:alpha:alpha:alpha,beta:alpha,beta,gamma 0|0:0.34:0.1,0,0.9:88.4:99.0,88.4:0:0,1,9:88:99,88:alpha:alpha:alpha,beta:alpha,beta,gamma +11 48245185 . C T . PASS . GT 0/0 0/0 +11 48245186 . C G,T . PASS FL=0.34;FLA=88.4,88.4;FLR=99.0,88.4,88.4;INT=0;INTA=88,11;INTR=99,88,11;F1;ST=alpha;STA=alpha,beta;STR=alpha,beta,gamma GT:FL:FLA:FLR:INT:INTA:INTR:ST:STA:STR 0|0:0.34:88.4,11:99.0,88.4,11:0:88,11:99,88,11:alpha:alpha,beta:alpha,beta,gamma 0|0:0.34:88.4,11:99.0,88.4,11:0:88,11:99,88,11:alpha:alpha,beta:alpha,beta,gamma +11 48245186 . C T . PASS . GT 0/0 0/0 +11 48245187 . C G . PASS FL=0.34;FLA=88.4;FLR=99.0,88.4;INT=0;INTA=88;INTR=99,88;F1;ST=alpha;STA=alpha;STR=alpha,beta GT:FL:FLG:FLA:FLR:INT:INTG:INTA:INTR:ST:STA:STR:STG 0:0.34:0.1,0:88.4:99.0,88.4:0:0,1:88:99,88:alpha:alpha:alpha,beta:alpha,beta 0:0.34:0.1,0:88.4:99.0,88.4:0:0,1:88:99,88:alpha:alpha:alpha,beta:alpha,beta +11 48245187 . C T . PASS . GT 0 0 diff --git a/test/test.pl b/test/test.pl index cd9fbe462..0cbed476b 100755 --- a/test/test.pl +++ b/test/test.pl @@ -93,6 +93,7 @@ test_vcf_norm($opts,in=>'norm.split',out=>'norm.split.out',args=>'-m-'); test_vcf_norm($opts,in=>'norm.merge',out=>'norm.merge.out',args=>'-m+'); test_vcf_norm($opts,in=>'norm.merge.2',out=>'norm.merge.2.out',args=>'-m+'); +test_vcf_norm($opts,in=>'norm.merge.3',out=>'norm.merge.3.out',args=>'-m+'); test_vcf_norm($opts,in=>'norm.merge',out=>'norm.merge.strict.out',args=>'-m+ -s'); test_vcf_norm($opts,in=>'norm.setref',out=>'norm.setref.out',args=>'-Nc s',fai=>'norm'); test_vcf_view($opts,in=>'view',out=>'view.1.out',args=>'-aUc1 -C1 -s NA00002 -v snps',reg=>''); diff --git a/vcfnorm.c b/vcfnorm.c index aa82e949d..9135430f5 100644 --- a/vcfnorm.c +++ b/vcfnorm.c @@ -803,7 +803,8 @@ static void merge_info_numeric(args_t *args, bcf1_t **lines, int nlines, bcf_inf int i,k,len = bcf_hdr_id2length(args->hdr,BCF_HL_INFO,info->key); \ if ( len==BCF_VL_A ) \ { \ - assert( nvals_ori==lines[0]->n_allele - 1); \ + if (nvals_ori!=lines[0]->n_allele - 1) \ + error("vcfnorm: number of fields in first record at position %s:%d for INFO tag %s not as expected [found: %d vs expected:%d]\n", bcf_seqname(args->hdr,lines[0]),lines[0]->pos+1, tag, nvals_ori, lines[0]->n_allele-1); \ int nvals = dst->n_allele - 1; \ ENLARGE_ARRAY(type_t,set_missing,args->tmp_arr1,args->ntmp_arr1,1,nvals_ori,nvals); \ vals = (type_t*) args->tmp_arr1; \ @@ -811,8 +812,10 @@ static void merge_info_numeric(args_t *args, bcf1_t **lines, int nlines, bcf_inf { \ int ntmp2 = args->ntmp_arr2 / sizeof(type_t); \ int nvals2 = bcf_get_info_##type(args->hdr,lines[i],tag,&args->tmp_arr2,&ntmp2); \ + if (nvals2<0) continue; /* info tag does not exist in this record, skip */ \ args->ntmp_arr2 = ntmp2 * sizeof(type_t); \ - assert( nvals2==lines[i]->n_allele-1 ); \ + if (nvals2!=lines[i]->n_allele-1) \ + error("vcfnorm: could not merge INFO tag %s at position %s:%d\n", tag, bcf_seqname(args->hdr,lines[i]),lines[i]->pos+1); \ vals2 = (type_t*) args->tmp_arr2; \ for (k=0; kn_allele ); \ + if (nvals_ori!=lines[0]->n_allele) \ + error("vcfnorm: number of fields in first record at position %s:%d for INFO tag %s not as expected [found: %d vs expected:%d]\n", bcf_seqname(args->hdr,lines[0]),lines[0]->pos+1, tag, nvals_ori, lines[0]->n_allele); \ int nvals = dst->n_allele; \ ENLARGE_ARRAY(type_t,set_missing,args->tmp_arr1,args->ntmp_arr1,1,nvals_ori,nvals); \ vals = (type_t*) args->tmp_arr1; \ @@ -832,8 +836,10 @@ static void merge_info_numeric(args_t *args, bcf1_t **lines, int nlines, bcf_inf { \ int ntmp2 = args->ntmp_arr2 / sizeof(type_t); \ int nvals2 = bcf_get_info_##type(args->hdr,lines[i],tag,&args->tmp_arr2,&ntmp2); \ + if (nvals2<0) continue; /* info tag does not exist in this record, skip */ \ args->ntmp_arr2 = ntmp2 * sizeof(type_t); \ - assert( nvals2==lines[i]->n_allele ); \ + if (nvals2!=lines[i]->n_allele) \ + error("vcfnorm: could not merge INFO tag %s at position %s:%d\n", tag, bcf_seqname(args->hdr,lines[i]),lines[i]->pos+1); \ vals2 = (type_t*) args->tmp_arr2; \ for (k=0; kn_allele*(lines[0]->n_allele+1)/2 ); /* expecting diploid gt in INFO */ \ + /* expecting diploid gt in INFO */ \ + if (nvals_ori!=lines[0]->n_allele*(lines[0]->n_allele+1)/2) { \ + fprintf(stderr, "todo: merge Number=G INFO fields for haploid sites\n"); \ + error("vcfnorm: number of fields in first record at position %s:%d for INFO tag %s not as expected [found: %d vs expected:%d]\n", bcf_seqname(args->hdr,lines[0]),lines[0]->pos+1, tag, nvals_ori, lines[0]->n_allele*(lines[0]->n_allele+1)/2); \ + } \ int nvals = dst->n_allele*(dst->n_allele+1)/2; \ ENLARGE_ARRAY(type_t,set_missing,args->tmp_arr1,args->ntmp_arr1,1,nvals_ori,nvals); \ vals = (type_t*) args->tmp_arr1; \ @@ -853,8 +863,10 @@ static void merge_info_numeric(args_t *args, bcf1_t **lines, int nlines, bcf_inf { \ int ntmp2 = args->ntmp_arr2 / sizeof(type_t); \ int nvals2 = bcf_get_info_##type(args->hdr,lines[i],tag,&args->tmp_arr2,&ntmp2); \ + if (nvals2<0) continue; /* info tag does not exist in this record, skip */ \ args->ntmp_arr2 = ntmp2 * sizeof(type_t); \ - assert( nvals2==lines[i]->n_allele*(lines[i]->n_allele+1)/2 ); \ + if (nvals2!=lines[i]->n_allele*(lines[i]->n_allele+1)/2) \ + error("vcfnorm: could not merge INFO tag %s at position %s:%d\n", tag, bcf_seqname(args->hdr,lines[i]),lines[i]->pos+1); \ vals2 = (type_t*) args->tmp_arr2; \ int ia,ib; \ k = 0; \ @@ -906,6 +918,7 @@ static void merge_info_string(args_t *args, bcf1_t **lines, int nlines, bcf_info for (i=0; ihdr,lines[i],tag); + if (!src) continue; for (j=jfrom; jn_allele; j++) copy_string_field((char*)src->vptr, j-jfrom, src->len, &str, args->maps[i].map[j]-jfrom); } @@ -922,6 +935,7 @@ static void merge_info_string(args_t *args, bcf1_t **lines, int nlines, bcf_info for (i=0; ihdr,lines[i],tag); + if (!src) continue; int iori, jori, kori = 0; for (iori=0; iorin_allele; iori++) { @@ -945,7 +959,6 @@ static void merge_info_string(args_t *args, bcf1_t **lines, int nlines, bcf_info bcf_get_info_string(args->hdr,lines[0],tag,&args->tmp_arr1,&args->ntmp_arr1); bcf_update_info_string(args->hdr,dst,tag,args->tmp_arr1); } - } static void merge_format_genotype(args_t *args, bcf1_t **lines, int nlines, bcf_fmt_t *fmt, bcf1_t *dst) { @@ -1021,9 +1034,11 @@ static void merge_format_numeric(args_t *args, bcf1_t **lines, int nlines, bcf_f { \ int ntmp2 = args->ntmp_arr2 / sizeof(type_t); \ int nvals2 = bcf_get_format_##type(args->hdr,lines[i],tag,&args->tmp_arr2,&ntmp2); \ + if (nvals2<0) continue; /* format tag does not exist in this record, skip */ \ args->ntmp_arr2 = ntmp2 * sizeof(type_t); \ nvals2 /= nsmpl; \ - assert( nvals2==lines[i]->n_allele-1 ); \ + if (nvals2!=lines[i]->n_allele-1) \ + error("vcfnorm: could not merge FORMAT tag %s at position %s:%d\n", tag, bcf_seqname(args->hdr,lines[i]),lines[i]->pos+1); \ vals = (type_t*) args->tmp_arr1; \ vals2 = (type_t*) args->tmp_arr2; \ for (j=0; jntmp_arr2 / sizeof(type_t); \ int nvals2 = bcf_get_format_##type(args->hdr,lines[i],tag,&args->tmp_arr2,&ntmp2); \ + if (nvals2<0) continue; /* format tag does not exist in this record, skip */ \ args->ntmp_arr2 = ntmp2 * sizeof(type_t); \ nvals2 /= nsmpl; \ - assert( nvals2==lines[i]->n_allele ); \ + if (nvals2!=lines[i]->n_allele) \ + error("vcfnorm: could not merge FORMAT tag %s at position %s:%d\n", tag, bcf_seqname(args->hdr,lines[i]),lines[i]->pos+1); \ vals = (type_t*) args->tmp_arr1; \ vals2 = (type_t*) args->tmp_arr2; \ for (j=0; jntmp_arr2 / sizeof(type_t); \ int nvals2 = bcf_get_format_##type(args->hdr,lines[i],tag,&args->tmp_arr2,&ntmp2); \ + if (nvals2<0) continue; /* format tag does not exist in this record, skip */ \ args->ntmp_arr2 = ntmp2 * sizeof(type_t); \ nvals2 /= nsmpl; \ int ndiploid = lines[i]->n_allele*(lines[i]->n_allele+1)/2; \ int line_diploid = nvals2==ndiploid ? 1 : 0; \ - assert( nvals2==1 || nvals2==lines[i]->n_allele || nvals2==lines[i]->n_allele*(lines[i]->n_allele+1)/2); \ + if (!(nvals2==1 || nvals2==lines[i]->n_allele || nvals2==lines[i]->n_allele*(lines[i]->n_allele+1)/2)) \ + error("vcfnorm: could not merge FORMAT tag %s at position %s:%d\n", tag, bcf_seqname(args->hdr,lines[i]),lines[i]->pos+1); \ vals = (type_t*) args->tmp_arr1; \ vals2 = (type_t*) args->tmp_arr2; \ for (j=0; jhdr,lines[i],tag,&args->tmp_arr1,&args->ntmp_arr1); + if (nret<0) continue; /* format tag does not exist in this record, skip */ \ nret /= nsmpl; for (k=0; khdr,lines[i],tag,&args->tmp_arr1,&args->ntmp_arr1); + if (nret<0) continue; /* format tag does not exist in this record, skip */ \ nret /= nsmpl; } for (k=0; k Date: Wed, 5 Aug 2015 15:37:31 +0100 Subject: [PATCH 051/211] update man docs with new concat options --- doc/bcftools.1 | 21 ++++++++++++++++----- doc/bcftools.html | 16 ++++++++++++---- doc/bcftools.txt | 10 ++++++++-- 3 files changed, 36 insertions(+), 11 deletions(-) diff --git a/doc/bcftools.1 b/doc/bcftools.1 index 1269ac051..4a428e327 100644 --- a/doc/bcftools.1 +++ b/doc/bcftools.1 @@ -2,12 +2,12 @@ .\" Title: bcftools .\" Author: [see the "AUTHORS" section] .\" Generator: DocBook XSL Stylesheets v1.76.1 -.\" Date: 2015-07-28 16:00 BST +.\" Date: 2015-08-05 15:36 BST .\" Manual: \ \& .\" Source: \ \& .\" Language: English .\" -.TH "BCFTOOLS" "1" "2015\-07\-28 16:00 BST" "\ \&" "\ \&" +.TH "BCFTOOLS" "1" "2015\-08\-05 15:36 BST" "\ \&" "\ \&" .\" ----------------------------------------------------------------- .\" * Define some portability stuff .\" ----------------------------------------------------------------- @@ -41,7 +41,7 @@ Most commands accept VCF, bgzipped VCF and BCF with filetype detected automatica BCFtools is designed to work on a stream\&. It regards an input file "\-" as the standard input (stdin) and outputs to the standard output (stdout)\&. Several commands can thus be combined with Unix pipes\&. .SS "VERSION" .sp -This manual page was last updated \fB2015\-07\-28 16:00 BST\fR and refers to bcftools git version \fB1\&.2\-96\-g5d52a36+\fR\&. +This manual page was last updated \fB2015\-08\-05 15:36 BST\fR and refers to bcftools git version \fB1\&.2\-104\-gf47097b+\fR\&. .SS "BCF1" .sp The BCF1 format output by versions of samtools <= 0\&.1\&.19 is \fBnot\fR compatible with this version of bcftools\&. To read BCF1 files one can use the view command from old versions of bcftools packaged with samtools versions <= 0\&.1\&.19 to convert to VCF, which can then be read by this version of bcftools\&. @@ -828,12 +828,23 @@ Concatenate or combine VCF/BCF files\&. All source files must have the same samp First coordinate of the next file can precede last record of the current file\&. .RE .PP -\fB\-D, \-\-remove\-duplicates\fR +\fB\-c, \-\-compact\-PS\fR +.RS 4 +Do not output PS tag at each site, only at the start of a new phase set block\&. +.RE +.PP +\fB\-d, \-\-rm\-dups\fR \fIsnps\fR|\fIindels\fR|\fIboth\fR|\fIall\fR|\fInone\fR .RS 4 -If a record is present in multiple files, output only the first instance\&. Requires +Output duplicate records of specified type present in multiple files only once\&. Requires \fB\-a, \-\-allow\-overlaps\fR\&. .RE .PP +\fB\-D, \-\-remove\-duplicates\fR +.RS 4 +Alias for +\fB\-d none\fR +.RE +.PP \fB\-f, \-\-file\-list\fR \fIFILE\fR .RS 4 Read the list of files from a file\&. diff --git a/doc/bcftools.html b/doc/bcftools.html index 2202b9f30..1e85ce392 100644 --- a/doc/bcftools.html +++ b/doc/bcftools.html @@ -1,13 +1,13 @@ -bcftools

    Name

    bcftools — utilities for variant calling and manipulating VCFs and BCFs.

    Synopsis

    bcftools [--version|--version-only] [--help] [COMMAND] [OPTIONS]

    DESCRIPTION

    BCFtools is a set of utilities that manipulate variant calls in the Variant +bcftools

    Name

    bcftools — utilities for variant calling and manipulating VCFs and BCFs.

    Synopsis

    bcftools [--version|--version-only] [--help] [COMMAND] [OPTIONS]

    DESCRIPTION

    BCFtools is a set of utilities that manipulate variant calls in the Variant Call Format (VCF) and its binary counterpart BCF. All commands work transparently with both VCFs and BCFs, both uncompressed and BGZF-compressed.

    Most commands accept VCF, bgzipped VCF and BCF with filetype detected automatically even when streaming from a pipe. Indexed VCF and BCF will work in all situations. Un-indexed VCF and BCF and streams will work in most, but not all situations.

    BCFtools is designed to work on a stream. It regards an input file "-" as the standard input (stdin) and outputs to the standard output (stdout). Several -commands can thus be combined with Unix pipes.

    VERSION

    This manual page was last updated 2015-07-28 16:00 BST and refers to bcftools git version 1.2-96-g5d52a36+.

    BCF1

    The BCF1 format output by versions of samtools <= 0.1.19 is not +commands can thus be combined with Unix pipes.

    VERSION

    This manual page was last updated 2015-08-05 15:36 BST and refers to bcftools git version 1.2-104-gf47097b+.

    BCF1

    The BCF1 format output by versions of samtools <= 0.1.19 is not compatible with this version of bcftools. To read BCF1 files one can use the view command from old versions of bcftools packaged with samtools versions <= 0.1.19 to convert to VCF, which can then be read by @@ -440,11 +440,19 @@

    First coordinate of the next file can precede last record of the current file.
    --D, --remove-duplicates +-c, --compact-PS +
    + Do not output PS tag at each site, only at the start of a new phase set block. +
    +-d, --rm-dups snps|indels|both|all|none
    - If a record is present in multiple files, output only the first instance. + Output duplicate records of specified type present in multiple files only once. Requires -a, --allow-overlaps.
    +-D, --remove-duplicates +
    + Alias for -d none +
    -f, --file-list FILE
    Read the list of files from a file. diff --git a/doc/bcftools.txt b/doc/bcftools.txt index 7fa3361f3..657fefef8 100644 --- a/doc/bcftools.txt +++ b/doc/bcftools.txt @@ -476,10 +476,16 @@ the *-a, --allow-overlaps* option is specified. *-a, --allow-overlaps*:: First coordinate of the next file can precede last record of the current file. -*-D, --remove-duplicates*:: - If a record is present in multiple files, output only the first instance. +*-c, --compact-PS*:: + Do not output PS tag at each site, only at the start of a new phase set block. + +*-d, --rm-dups* 'snps'|'indels'|'both'|'all'|'none':: + Output duplicate records of specified type present in multiple files only once. Requires *-a, --allow-overlaps*. +*-D, --remove-duplicates*:: + Alias for *-d none* + *-f, --file-list* 'FILE':: Read the list of files from a file. From 21aca6d0932792d0e4f479e1401a64c292f9d2c3 Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Wed, 5 Aug 2015 15:59:46 +0100 Subject: [PATCH 052/211] cleanup GRCh38 alias description --- vcfcall.c | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/vcfcall.c b/vcfcall.c index 181f73ef5..7eb56b33e 100644 --- a/vcfcall.c +++ b/vcfcall.c @@ -145,7 +145,7 @@ static ploidy_predef_t ploidy_predefs[] = "* * * F 2\n" }, { .alias = "GRCh38", - .about = "Human Genome reference assembly GRCh38 / hg38, plain chromosome naming (1,2,3,..)", + .about = "Human Genome reference assembly GRCh38 / hg38", .ploidy = "X 1 9999 M 1\n" "X 2781480 155701381 M 1\n" From ef11927ac5fc6feca75279d93b56061cf3ae6e96 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Wed, 29 Jul 2015 21:35:22 +0100 Subject: [PATCH 053/211] Three ways to add values in annotate: -c +ID, =ID, or ID - The same for FILTER, plus fix to make it behave as described in the man page. --- doc/bcftools.txt | 7 ++++-- test/annotate4.out | 2 +- test/annotate5.out | 4 ++-- test/annotate9.out | 29 ++++++++++++++++++++++ test/annotate9.vcf | 28 ++++++++++++++++++++++ test/annots9.tab | 5 ++++ test/annots9.vcf | 28 ++++++++++++++++++++++ test/test.pl | 3 ++- vcfannotate.c | 60 ++++++++++++++++++++++++++++++---------------- 9 files changed, 139 insertions(+), 27 deletions(-) create mode 100644 test/annotate9.out create mode 100644 test/annotate9.vcf create mode 100644 test/annots9.tab create mode 100644 test/annots9.vcf diff --git a/doc/bcftools.txt b/doc/bcftools.txt index 657fefef8..0c64c4265 100644 --- a/doc/bcftools.txt +++ b/doc/bcftools.txt @@ -261,8 +261,11 @@ This command allows to add or remove annotations. can be edited, where INFO tags can be written both as "INFO/TAG" or simply "TAG", and FORMAT tags can be written as "FORMAT/TAG" or "FMT/TAG". To carry over all INFO annotations, use "INFO". To add all INFO annotations except - "TAG", use "^INFO/TAG". By default, existing values are replaced. To add - values without overwriting existing annotations, use "+TAG" instead of "TAG". + "TAG", use "^INFO/TAG". By default, existing values are replaced. + To add annotations without overwriting existing values (that is, to add missing tags or + add values to existing tags with missing values), use "+TAG" instead of "TAG". + To append to existing values (rather than replacing or leaving untouched), use "=TAG" + (instead of "TAG" or "+TAG"). To replace only existing values without modifying missing annotations, use "-TAG". If the annotation file is not a VCF/BCF, all new annotations must be defined via *-h, --header-lines*. diff --git a/test/annotate4.out b/test/annotate4.out index 674024200..934cf8993 100644 --- a/test/annotate4.out +++ b/test/annotate4.out @@ -13,7 +13,7 @@ ##FILTER= ##FILTER= #CHROM POS ID REF ALT QUAL FILTER INFO FORMAT A B C -1 3000001 xx C T 11 . IINT=11;IFLT=1.1;ISTR=xxx GT:FINT:FFLT:FSTR .:11:1.1:xxx .:11:1.1:x 0/0:11:1.1:x +1 3000001 xx C T 11 PASS IINT=11;IFLT=1.1;ISTR=xxx GT:FINT:FFLT:FSTR .:11:1.1:xxx .:11:1.1:x 0/0:11:1.1:x 1 3000002 id C T 99 q99 FLAG;IINT=88,99;IFLT=8.8,9.9;ISTR=888,999 GT:FINT:FFLT:FSTR 0|1:77:7.7:77 1|1:88,99:8.8,9.9:888,999 .:.:.:. 1 3000003 id C T 99 q99 FLAG;IINT=88,99;IFLT=8.8,9.9;ISTR=888,999 GT:FINT:FFLT:FSTR 0|1:77:7.7:77 1|1:88,99:8.8,9.9:888,999 0/0:.:.:. 1 3000004 id C T 99 q99 FLAG;IINT=88,99;IFLT=8.8,9.9;ISTR=888,999 GT:FINT:FFLT:FSTR 0|1:77:7.7:77 1|1:88,99:8.8,9.9:888,999 0/0:11:1.1:xxx diff --git a/test/annotate5.out b/test/annotate5.out index d3ab76451..a57261ee6 100644 --- a/test/annotate5.out +++ b/test/annotate5.out @@ -15,5 +15,5 @@ #CHROM POS ID REF ALT QUAL FILTER INFO FORMAT A B C 1 3000001 xx C T 11 PASS IINT=11;IFLT=1.1;ISTR=xxx GT:FINT:FFLT:FSTR .:11:1.1:xxx 0/0:11:1.1:x 0/0:11:1.1:x 1 3000002 id C T 99 q99 FLAG;IINT=88,99;IFLT=8.8,9.9;ISTR=888,999 GT 0|1 . . -1 3000003 id C T 99 q11;q99 FLAG;IINT=88,99;IFLT=8.8,9.9;ISTR=888,999 GT:FINT:FFLT:FSTR 0|1:.:.:. 0/0:.:.:. 0/0:.:.:. -1 3000004 id C T 99 q11;q99 FLAG;IINT=11;IFLT=1.1;ISTR=xxx GT:FINT:FFLT:FSTR 0|1:11:1.1:x 0/0:11:1.1:xxx 0/0:11:1.1:xxx +1 3000003 id C T 99 q11 FLAG;IINT=88,99;IFLT=8.8,9.9;ISTR=888,999 GT:FINT:FFLT:FSTR 0|1:.:.:. 0/0:.:.:. 0/0:.:.:. +1 3000004 id C T 99 q11 FLAG;IINT=11;IFLT=1.1;ISTR=xxx GT:FINT:FFLT:FSTR 0|1:11:1.1:x 0/0:11:1.1:xxx 0/0:11:1.1:xxx diff --git a/test/annotate9.out b/test/annotate9.out new file mode 100644 index 000000000..66c872da3 --- /dev/null +++ b/test/annotate9.out @@ -0,0 +1,29 @@ +##fileformat=VCFv4.1 +##FILTER= +##INFO= +##FORMAT= +##INFO= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##FILTER= +##FILTER= +##contig= +##contig= +##contig= +##contig= +##test= +##reference=file:///lustre/scratch105/projects/g1k/ref/main_project/human_g1k_v37.fasta +##readme=AAAAAA +##readme=BBBBBB +##INFO= +##INFO= +##INFO= +##INFO= +#CHROM POS ID REF ALT QUAL FILTER INFO FORMAT A B +1 3000150 id150 C T 59.2 PASS AN=4;AC=2 GT:GQ 0/1:245 0/1:245 +1 3000151 id3000151 C T 59.2 PASS AN=4;AC=2 GT:DP:GQ 0/1:32:245 0/1:32:245 +1 3062915 id3D GTTT G 12.9 q10 DP4=1,2,3,4;AN=4;AC=2;INDEL;STR=test GT:GQ:DP:GL 0/1:409:35:-20,-5,-20 0/1:409:35:-20,-5,-20 +1 3062915 idSNP G T,C 12.6 test TEST=5;DP4=1,2,3,4;AN=3;AC=1,1 GT:TT:GQ:DP:GL 0/1:0,1:409:35:-20,-5,-20,-20,-5,-20 2:0,1:409:35:-20,-5,-20 +1 3106154 id3106154 CAAA C 342 PASS AN=4;AC=2 GT:GQ:DP 0/1:245:32 0/1:245:32 diff --git a/test/annotate9.vcf b/test/annotate9.vcf new file mode 100644 index 000000000..659516744 --- /dev/null +++ b/test/annotate9.vcf @@ -0,0 +1,28 @@ +##fileformat=VCFv4.1 +##INFO= +##FORMAT= +##INFO= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##FILTER= +##FILTER= +##contig= +##contig= +##contig= +##contig= +##test= +##reference=file:///lustre/scratch105/projects/g1k/ref/main_project/human_g1k_v37.fasta +##readme=AAAAAA +##readme=BBBBBB +##INFO= +##INFO= +##INFO= +##INFO= +#CHROM POS ID REF ALT QUAL FILTER INFO FORMAT A B +1 3000150 id150 C T 59.2 PASS AN=4;AC=2 GT:GQ 0/1:245 0/1:245 +1 3000151 . C T 59.2 PASS AN=4;AC=2 GT:DP:GQ 0/1:32:245 0/1:32:245 +1 3062915 id3D GTTT G 12.9 q10 DP4=1,2,3,4;AN=4;AC=2;INDEL;STR=test GT:GQ:DP:GL 0/1:409:35:-20,-5,-20 0/1:409:35:-20,-5,-20 +1 3062915 idSNP G T,C 12.6 test TEST=5;DP4=1,2,3,4;AN=3;AC=1,1 GT:TT:GQ:DP:GL 0/1:0,1:409:35:-20,-5,-20,-20,-5,-20 2:0,1:409:35:-20,-5,-20 +1 3106154 . CAAA C 342 PASS AN=4;AC=2 GT:GQ:DP 0/1:245:32 0/1:245:32 diff --git a/test/annots9.tab b/test/annots9.tab new file mode 100644 index 000000000..678e3c4ab --- /dev/null +++ b/test/annots9.tab @@ -0,0 +1,5 @@ +1 3000150 C T id3000150 +1 3000151 C T id3000151 +1 3062915 GTTT G id3062915_3D +1 3062915 G T,C id3062915_NP +1 3106154 CAAA C id3106154 diff --git a/test/annots9.vcf b/test/annots9.vcf new file mode 100644 index 000000000..6ff2cceb3 --- /dev/null +++ b/test/annots9.vcf @@ -0,0 +1,28 @@ +##fileformat=VCFv4.1 +##INFO= +##FORMAT= +##INFO= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##FILTER= +##FILTER= +##contig= +##contig= +##contig= +##contig= +##test= +##reference=file:///lustre/scratch105/projects/g1k/ref/main_project/human_g1k_v37.fasta +##readme=AAAAAA +##readme=BBBBBB +##INFO= +##INFO= +##INFO= +##INFO= +#CHROM POS ID REF ALT QUAL FILTER INFO FORMAT A B +1 3000150 id3000150 C T 59.2 PASS AN=4;AC=2 GT:GQ 0/1:245 0/1:245 +1 3000151 id3000151 C T 59.2 PASS AN=4;AC=2 GT:DP:GQ 0/1:32:245 0/1:32:245 +1 3062915 id3062915_3D GTTT G 12.9 q10 DP4=1,2,3,4;AN=4;AC=2;INDEL;STR=test GT:GQ:DP:GL 0/1:409:35:-20,-5,-20 0/1:409:35:-20,-5,-20 +1 3062915 id3062915_NP G T,C 12.6 test TEST=5;DP4=1,2,3,4;AN=3;AC=1,1 GT:TT:GQ:DP:GL 0/1:0,1:409:35:-20,-5,-20,-20,-5,-20 2:0,1:409:35:-20,-5,-20 +1 3106154 id3106154 CAAA C 342 PASS AN=4;AC=2 GT:GQ:DP 0/1:245:32 0/1:245:32 diff --git a/test/test.pl b/test/test.pl index 0cbed476b..08ab49bba 100755 --- a/test/test.pl +++ b/test/test.pl @@ -155,6 +155,7 @@ test_vcf_annotate($opts,in=>'annotate4',vcf=>'annots4',out=>'annotate8.out',args=>'-c +INFO'); test_vcf_annotate($opts,in=>'annotate4',tab=>'annots4',out=>'annotate8.out',args=>'-c CHROM,POS,REF,ALT,+FA,+FR,+IA,+IR,+SA,+SR'); test_vcf_plugin($opts,in=>'plugin1',out=>'missing2ref.out',cmd=>'+missing2ref'); +test_vcf_annotate($opts,in=>'annotate9',tab=>'annots9',out=>'annotate9.out',args=>'-c CHROM,POS,REF,ALT,+ID'); test_vcf_plugin($opts,in=>'plugin1',out=>'fill-AN-AC.out',cmd=>'+fill-AN-AC'); test_vcf_plugin($opts,in=>'plugin1',out=>'dosage.out',cmd=>'+dosage'); test_vcf_plugin($opts,in=>'fixploidy',out=>'fixploidy.out',cmd=>'+fixploidy',args=>'-- -s {PATH}/fixploidy.samples -p {PATH}/fixploidy.ploidy'); @@ -682,7 +683,7 @@ sub test_vcf_annotate bgzip_tabix($opts,file=>$args{tab},suffix=>'tab',args=>'-s1 -b2 -e2'); $annot_fname = "-a $$opts{tmp}/$args{tab}.tab.gz"; $in_fname = "$$opts{path}/$args{in}.vcf"; - $hdr = "-h $$opts{path}/$args{in}.hdr"; + $hdr = -e "$$opts{path}/$args{in}.hdr" ? "-h $$opts{path}/$args{in}.hdr" : ''; } elsif ( exists($args{vcf}) ) { diff --git a/vcfannotate.c b/vcfannotate.c index 2723e7bc0..621da5739 100644 --- a/vcfannotate.c +++ b/vcfannotate.c @@ -66,6 +66,7 @@ annot_line_t; #define REPLACE_MISSING 0 // replace only missing values #define REPLACE_ALL 1 // replace both missing and existing values #define REPLACE_EXISTING 2 // replace only if tgt is not missing +#define SET_OR_APPEND 3 // set new value if missing or non-existent, append otherwise typedef struct _annot_col_t { int icol, replace, number; // number: one of BCF_VL_* types @@ -362,41 +363,52 @@ static void init_header_lines(args_t *args) } static int setter_filter(args_t *args, bcf1_t *line, annot_col_t *col, void *data) { + // note: so far this works only with one filter, not a list of filters annot_line_t *tab = (annot_line_t*) data; + if ( tab->cols[col->icol] && tab->cols[col->icol][0]=='.' && !tab->cols[col->icol][1] ) return 0; // don't replace with "." hts_expand(int,1,args->mtmpi,args->tmpi); args->tmpi[0] = bcf_hdr_id2int(args->hdr_out, BCF_DT_ID, tab->cols[col->icol]); if ( args->tmpi[0]<0 ) error("The FILTER is not defined in the header: %s\n", tab->cols[col->icol]); + if ( col->replace==SET_OR_APPEND ) { bcf_add_filter(args->hdr_out,line,args->tmpi[0]); return 0; } if ( col->replace!=REPLACE_MISSING ) + { + bcf_update_filter(args->hdr_out,line,NULL,0); + bcf_update_filter(args->hdr_out,line,args->tmpi,1); + return 0; + } + + // only update missing FILTER + if ( !(line->unpacked & BCF_UN_FLT) ) bcf_unpack(line, BCF_UN_FLT); + if ( !line->d.n_flt ) bcf_update_filter(args->hdr_out,line,args->tmpi,1); - else - bcf_add_filter(args->hdr_out,line,args->tmpi[0]); return 0; } static int vcf_setter_filter(args_t *args, bcf1_t *line, annot_col_t *col, void *data) { + int i; bcf1_t *rec = (bcf1_t*) data; if ( !(rec->unpacked & BCF_UN_FLT) ) bcf_unpack(rec, BCF_UN_FLT); - hts_expand(int,rec->d.n_flt,args->mtmpi,args->tmpi); - int i; - if ( col->replace!=REPLACE_MISSING ) + if ( !(line->unpacked & BCF_UN_FLT) ) bcf_unpack(line, BCF_UN_FLT); + if ( !rec->d.n_flt ) return 0; // don't overwrite with a missing value + if ( col->replace==SET_OR_APPEND || col->replace==REPLACE_MISSING ) { + if ( col->replace==REPLACE_MISSING && line->d.n_flt ) return 0; // only update missing FILTER for (i=0; id.n_flt; i++) { const char *flt = bcf_hdr_int2id(args->files->readers[1].header, BCF_DT_ID, rec->d.flt[i]); - args->tmpi[i] = bcf_hdr_id2int(args->hdr_out, BCF_DT_ID, flt); + bcf_add_filter(args->hdr_out,line,bcf_hdr_id2int(args->hdr_out, BCF_DT_ID, flt)); } - bcf_update_filter(args->hdr_out,line,args->tmpi,rec->d.n_flt); return 0; } - else + hts_expand(int,rec->d.n_flt,args->mtmpi,args->tmpi); + for (i=0; id.n_flt; i++) { - for (i=0; id.n_flt; i++) - { - const char *flt = bcf_hdr_int2id(args->files->readers[1].header, BCF_DT_ID, rec->d.flt[i]); - bcf_add_filter(args->hdr_out,line,bcf_hdr_id2int(args->hdr_out, BCF_DT_ID, flt)); - } - return 0; + const char *flt = bcf_hdr_int2id(args->files->readers[1].header, BCF_DT_ID, rec->d.flt[i]); + args->tmpi[i] = bcf_hdr_id2int(args->hdr_out, BCF_DT_ID, flt); } + bcf_update_filter(args->hdr_out,line,NULL,0); + bcf_update_filter(args->hdr_out,line,args->tmpi,rec->d.n_flt); + return 0; } static int setter_id(args_t *args, bcf1_t *line, annot_col_t *col, void *data) { @@ -404,13 +416,14 @@ static int setter_id(args_t *args, bcf1_t *line, annot_col_t *col, void *data) // IN ANNOT OUT ACHIEVED_BY // x y x -c +ID // x y y -c ID - // x y x,y /not supported/ + // x y x,y -c =ID // x . x -c +ID, ID // x . . -x ID // . y y -c +ID, -c ID // annot_line_t *tab = (annot_line_t*) data; if ( tab->cols[col->icol] && tab->cols[col->icol][0]=='.' && !tab->cols[col->icol][1] ) return 0; // don't replace with "." + if ( col->replace==SET_OR_APPEND ) return bcf_add_id(args->hdr_out,line,tab->cols[col->icol]); if ( col->replace!=REPLACE_MISSING ) return bcf_update_id(args->hdr_out,line,tab->cols[col->icol]); // running with +ID, only update missing ids @@ -422,6 +435,7 @@ static int vcf_setter_id(args_t *args, bcf1_t *line, annot_col_t *col, void *dat { bcf1_t *rec = (bcf1_t*) data; if ( rec->d.id && rec->d.id[0]=='.' && !rec->d.id[1] ) return 0; // don't replace with "." + if ( col->replace==SET_OR_APPEND ) return bcf_add_id(args->hdr_out,line,rec->d.id); if ( col->replace!=REPLACE_MISSING ) return bcf_update_id(args->hdr_out,line,rec->d.id); // running with +ID, only update missing ids @@ -1120,6 +1134,7 @@ static void init_columns(args_t *args) int replace = REPLACE_ALL; if ( *ss=='+' ) { replace = REPLACE_MISSING; ss++; } else if ( *ss=='-' ) { replace = REPLACE_EXISTING; ss++; } + else if ( *ss=='=' ) { replace = SET_OR_APPEND; ss++; } i++; str.l = 0; kputsn(ss, se-ss, &str); @@ -1132,7 +1147,7 @@ static void init_columns(args_t *args) else if ( !strcasecmp("ALT",str.s) ) args->alt_idx = i; else if ( !strcasecmp("ID",str.s) ) { - if ( replace==REPLACE_EXISTING ) error("todo: -ID\n"); + if ( replace==REPLACE_EXISTING ) error("Apologies, the -ID feature has not been implemented yet.\n"); args->ncols++; args->cols = (annot_col_t*) realloc(args->cols,sizeof(annot_col_t)*args->ncols); annot_col_t *col = &args->cols[args->ncols-1]; col->icol = i; @@ -1142,7 +1157,7 @@ static void init_columns(args_t *args) } else if ( !strcasecmp("FILTER",str.s) ) { - if ( replace==REPLACE_EXISTING ) error("todo: -FILTER\n"); + if ( replace==REPLACE_EXISTING ) error("Apologies, the -FILTER feature has not been implemented yet.\n"); args->ncols++; args->cols = (annot_col_t*) realloc(args->cols,sizeof(annot_col_t)*args->ncols); annot_col_t *col = &args->cols[args->ncols-1]; col->icol = i; @@ -1168,7 +1183,8 @@ static void init_columns(args_t *args) } else if ( !strcasecmp("QUAL",str.s) ) { - if ( replace==REPLACE_EXISTING ) error("todo: -QUAL\n"); + if ( replace==REPLACE_EXISTING ) error("Apologies, the -QUAL feature has not been implemented yet.\n"); + if ( replace==SET_OR_APPEND ) error("Apologies, the =QUAL feature has not been implemented yet.\n"); args->ncols++; args->cols = (annot_col_t*) realloc(args->cols,sizeof(annot_col_t)*args->ncols); annot_col_t *col = &args->cols[args->ncols-1]; col->icol = i; @@ -1178,7 +1194,8 @@ static void init_columns(args_t *args) } else if ( args->tgts_is_vcf && !strcasecmp("INFO",str.s) ) // All INFO fields { - if ( replace==REPLACE_EXISTING ) error("todo: -INFO/TAG\n"); + if ( replace==REPLACE_EXISTING ) error("Apologies, the -INFO/TAG feature has not been implemented yet.\n"); + if ( replace==SET_OR_APPEND ) error("Apologies, the =INFO/TAG feature has not been implemented yet.\n"); bcf_hdr_t *tgts_hdr = args->files->readers[1].header; int j; for (j=0; jnhrec; j++) @@ -1274,7 +1291,8 @@ static void init_columns(args_t *args) } else { - if ( replace==REPLACE_EXISTING ) error("todo: -INFO/TAG\n"); + if ( replace==REPLACE_EXISTING ) error("Apologies, the -INFO/TAG feature has not been implemented yet.\n"); + if ( replace==SET_OR_APPEND ) error("Apologies, the =INFO/TAG feature has not been implemented yet.\n"); if ( !strncasecmp("INFO/",str.s,5) ) { memmove(str.s,str.s+5,str.l-4); } int hdr_id = bcf_hdr_id2int(args->hdr_out, BCF_DT_ID, str.s); if ( !bcf_hdr_idinfo_exists(args->hdr_out,BCF_HL_INFO,hdr_id) ) @@ -1396,7 +1414,7 @@ static void init_data(args_t *args) if ( args->mark_sites ) { if ( !args->targets_fname ) error("The -a option not given\n"); - if ( args->tgts_is_vcf ) error("todo: -a is a VCF\n"); // very easy to add.. + if ( args->tgts_is_vcf ) error("Apologies, this has not been implemented yet: -a is a VCF\n"); // very easy to add.. bcf_hdr_printf(args->hdr_out,"##INFO=", args->mark_sites,args->mark_sites_logic==MARK_LISTED?"":"not ",args->mark_sites); } From b3257c19a208e66361f2edabdcc5b290b42bc1be Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Wed, 5 Aug 2015 16:04:28 +0100 Subject: [PATCH 054/211] update man docs after ef11927ac5fc6feca75279d93b56061cf3ae6e96 --- doc/bcftools.1 | 8 ++++---- doc/bcftools.html | 11 +++++++---- 2 files changed, 11 insertions(+), 8 deletions(-) diff --git a/doc/bcftools.1 b/doc/bcftools.1 index 4a428e327..ac2f16c68 100644 --- a/doc/bcftools.1 +++ b/doc/bcftools.1 @@ -2,12 +2,12 @@ .\" Title: bcftools .\" Author: [see the "AUTHORS" section] .\" Generator: DocBook XSL Stylesheets v1.76.1 -.\" Date: 2015-08-05 15:36 BST +.\" Date: 2015-08-05 16:03 BST .\" Manual: \ \& .\" Source: \ \& .\" Language: English .\" -.TH "BCFTOOLS" "1" "2015\-08\-05 15:36 BST" "\ \&" "\ \&" +.TH "BCFTOOLS" "1" "2015\-08\-05 16:03 BST" "\ \&" "\ \&" .\" ----------------------------------------------------------------- .\" * Define some portability stuff .\" ----------------------------------------------------------------- @@ -41,7 +41,7 @@ Most commands accept VCF, bgzipped VCF and BCF with filetype detected automatica BCFtools is designed to work on a stream\&. It regards an input file "\-" as the standard input (stdin) and outputs to the standard output (stdout)\&. Several commands can thus be combined with Unix pipes\&. .SS "VERSION" .sp -This manual page was last updated \fB2015\-08\-05 15:36 BST\fR and refers to bcftools git version \fB1\&.2\-104\-gf47097b+\fR\&. +This manual page was last updated \fB2015\-08\-05 16:03 BST\fR and refers to bcftools git version \fB1\&.2\-106\-gef11927+\fR\&. .SS "BCF1" .sp The BCF1 format output by versions of samtools <= 0\&.1\&.19 is \fBnot\fR compatible with this version of bcftools\&. To read BCF1 files one can use the view command from old versions of bcftools packaged with samtools versions <= 0\&.1\&.19 to convert to VCF, which can then be read by this version of bcftools\&. @@ -493,7 +493,7 @@ and Comma\-separated list of columns or tags to carry over from the annotation file (see also \fB\-a, \-\-annotations\fR)\&. If the annotation file is not a VCF/BCF, \fIlist\fR -describes the columns of the annotation file and must include CHROM, POS (or, alternatively, FROM and TO), and optionally REF and ALT\&. Unused columns which should be ignored can be indicated by "\-"\&. If the annotation file is a VCF/BCF, only the edited columns/tags must be present and their order does not matter\&. The columns ID, QUAL, FILTER, INFO and FORMAT can be edited, where INFO tags can be written both as "INFO/TAG" or simply "TAG", and FORMAT tags can be written as "FORMAT/TAG" or "FMT/TAG"\&. To carry over all INFO annotations, use "INFO"\&. To add all INFO annotations except "TAG", use "^INFO/TAG"\&. By default, existing values are replaced\&. To add values without overwriting existing annotations, use "+TAG" instead of "TAG"\&. To replace only existing values without modifying missing annotations, use "\-TAG"\&. If the annotation file is not a VCF/BCF, all new annotations must be defined via +describes the columns of the annotation file and must include CHROM, POS (or, alternatively, FROM and TO), and optionally REF and ALT\&. Unused columns which should be ignored can be indicated by "\-"\&. If the annotation file is a VCF/BCF, only the edited columns/tags must be present and their order does not matter\&. The columns ID, QUAL, FILTER, INFO and FORMAT can be edited, where INFO tags can be written both as "INFO/TAG" or simply "TAG", and FORMAT tags can be written as "FORMAT/TAG" or "FMT/TAG"\&. To carry over all INFO annotations, use "INFO"\&. To add all INFO annotations except "TAG", use "^INFO/TAG"\&. By default, existing values are replaced\&. To add annotations without overwriting existing values (that is, to add missing tags or add values to existing tags with missing values), use "+TAG" instead of "TAG"\&. To append to existing values (rather than replacing or leaving untouched), use "=TAG" (instead of "TAG" or "+TAG")\&. To replace only existing values without modifying missing annotations, use "\-TAG"\&. If the annotation file is not a VCF/BCF, all new annotations must be defined via \fB\-h, \-\-header\-lines\fR\&. .RE .PP diff --git a/doc/bcftools.html b/doc/bcftools.html index 1e85ce392..630794e1b 100644 --- a/doc/bcftools.html +++ b/doc/bcftools.html @@ -1,13 +1,13 @@ -bcftools

    Name

    bcftools — utilities for variant calling and manipulating VCFs and BCFs.

    Synopsis

    bcftools [--version|--version-only] [--help] [COMMAND] [OPTIONS]

    DESCRIPTION

    BCFtools is a set of utilities that manipulate variant calls in the Variant +bcftools

    Name

    bcftools — utilities for variant calling and manipulating VCFs and BCFs.

    Synopsis

    bcftools [--version|--version-only] [--help] [COMMAND] [OPTIONS]

    DESCRIPTION

    BCFtools is a set of utilities that manipulate variant calls in the Variant Call Format (VCF) and its binary counterpart BCF. All commands work transparently with both VCFs and BCFs, both uncompressed and BGZF-compressed.

    Most commands accept VCF, bgzipped VCF and BCF with filetype detected automatically even when streaming from a pipe. Indexed VCF and BCF will work in all situations. Un-indexed VCF and BCF and streams will work in most, but not all situations.

    BCFtools is designed to work on a stream. It regards an input file "-" as the standard input (stdin) and outputs to the standard output (stdout). Several -commands can thus be combined with Unix pipes.

    VERSION

    This manual page was last updated 2015-08-05 15:36 BST and refers to bcftools git version 1.2-104-gf47097b+.

    BCF1

    The BCF1 format output by versions of samtools <= 0.1.19 is not +commands can thus be combined with Unix pipes.

    VERSION

    This manual page was last updated 2015-08-05 16:03 BST and refers to bcftools git version 1.2-106-gef11927+.

    BCF1

    The BCF1 format output by versions of samtools <= 0.1.19 is not compatible with this version of bcftools. To read BCF1 files one can use the view command from old versions of bcftools packaged with samtools versions <= 0.1.19 to convert to VCF, which can then be read by @@ -217,8 +217,11 @@ can be edited, where INFO tags can be written both as "INFO/TAG" or simply "TAG", and FORMAT tags can be written as "FORMAT/TAG" or "FMT/TAG". To carry over all INFO annotations, use "INFO". To add all INFO annotations except - "TAG", use "^INFO/TAG". By default, existing values are replaced. To add - values without overwriting existing annotations, use "+TAG" instead of "TAG". + "TAG", use "^INFO/TAG". By default, existing values are replaced. + To add annotations without overwriting existing values (that is, to add missing tags or + add values to existing tags with missing values), use "+TAG" instead of "TAG". + To append to existing values (rather than replacing or leaving untouched), use "=TAG" + (instead of "TAG" or "+TAG"). To replace only existing values without modifying missing annotations, use "-TAG". If the annotation file is not a VCF/BCF, all new annotations must be defined via -h, --header-lines. From 90d0a6a123bcf8df6417e8e3fff07982a27142fd Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Thu, 30 Jul 2015 08:44:02 +0100 Subject: [PATCH 055/211] Proper ploidy initialization when the sexes are added explicitly. --- ploidy.c | 2 ++ 1 file changed, 2 insertions(+) diff --git a/ploidy.c b/ploidy.c index 3d3027aa2..8449d66a4 100644 --- a/ploidy.c +++ b/ploidy.c @@ -228,6 +228,8 @@ int ploidy_add_sex(ploidy_t *ploidy, const char *sex) ploidy->nsex++; hts_expand0(char*,ploidy->nsex,ploidy->msex,ploidy->id2sex); ploidy->id2sex[ploidy->nsex-1] = strdup(sex); + ploidy->sex2dflt = (int*) realloc(ploidy->sex2dflt,sizeof(int)*ploidy->nsex); + ploidy->sex2dflt[ploidy->nsex-1] = ploidy->dflt; return khash_str2int_inc(ploidy->sex2id, ploidy->id2sex[ploidy->nsex-1]); } From 3b0378f430ce1f14ff71edf593b943e5c9c0cb3c Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Fri, 31 Jul 2015 14:09:42 +0100 Subject: [PATCH 056/211] call -m fix: skip sites with too many alleles (>32) instead of silently overwriting internal data structures.. --- call.h | 4 ++-- mcall.c | 22 +++++++++++++++++++--- 2 files changed, 21 insertions(+), 5 deletions(-) diff --git a/call.h b/call.h index 72f6fd87c..cc5e6d7b0 100644 --- a/call.h +++ b/call.h @@ -100,8 +100,8 @@ typedef struct double pl2p[256]; // PL to 10^(-PL/10) table int32_t *PLs; // VCF PL likelihoods (rw) - int nPLs, mPLs; - int32_t *gts, ac[4]; // GTs and AC (w) + int nPLs, mPLs, nac; + int32_t *gts, *ac; // GTs and AC (w) double *pdg; // PLs converted to P(D|G) float *anno16; int n16; // see anno[16] in bam2bcf.h double theta; // prior diff --git a/mcall.c b/mcall.c index a6096d8ca..b37593c1b 100644 --- a/mcall.c +++ b/mcall.c @@ -311,6 +311,7 @@ void mcall_destroy(call_t *call) free(call->gts); free(call->cgts); free(call->ugts); free(call->pdg); free(call->als); + free(call->ac); return; } @@ -726,7 +727,7 @@ static void mcall_call_genotypes(call_t *call, bcf1_t *rec, int nals, int nout_a int nout_gts = nout_als*(nout_als+1)/2; hts_expand(float,nout_gts*nsmpl,call->nGPs,call->GPs); - for (i=0; i<4; i++) call->ac[i] = 0; + for (i=0; iac[i] = 0; call->nhets = 0; call->ndiploid = 0; @@ -1346,6 +1347,7 @@ int mcall(call_t *call, bcf1_t *rec) int nsmpl = bcf_hdr_nsamples(call->hdr); int nals = rec->n_allele; + hts_expand(int,nals,call->nac,call->ac); hts_expand(int,nals,call->nals_map,call->als_map); hts_expand(int,nals*(nals+1)/2,call->npl_map,call->pl_map); @@ -1391,7 +1393,13 @@ int mcall(call_t *call, bcf1_t *rec) #endif // Find the best combination of alleles - int out_als, nout = mcall_find_best_alleles(call, nals, &out_als); + int out_als, nout; + if ( nals > 8*sizeof(out_als) ) + { + fprintf(stderr,"Too many alleles at %s:%d, skipping.\n", bcf_seqname(call->hdr,rec),rec->pos+1); + return 0; + } + nout = mcall_find_best_alleles(call, nals, &out_als); // Make sure the REF allele is always present if ( !(out_als&1) ) @@ -1431,12 +1439,20 @@ int mcall(call_t *call, bcf1_t *rec) if ( !is_variant ) mcall_set_ref_genotypes(call,nals); // running with -A, prevent mcall_call_genotypes from putting some ALT back else if ( call->flag & CALL_CONSTR_TRIO ) + { + if ( nout>4 ) + { + fprintf(stderr,"Too many alleles at %s:%d, skipping.\n", bcf_seqname(call->hdr,rec),rec->pos+1); + return 0; + } mcall_call_trio_genotypes(call, rec, nals,nout,out_als); + } else mcall_call_genotypes(call,rec,nals,nout,out_als); // Skip the site if all samples are 0/0. This can happen occasionally. - nAC = call->ac[1] + call->ac[2] + call->ac[3]; + nAC = 0; + for (i=1; iac[i]; if ( !nAC && call->flag & CALL_VARONLY ) return 0; mcall_trim_PLs(call, rec, nals, nout, out_als); } From d4d42ca7615dcf3014e5746c284b2f14b3ade8c0 Mon Sep 17 00:00:00 2001 From: John Marshall Date: Fri, 7 Aug 2015 09:03:49 +0100 Subject: [PATCH 057/211] Check that opening chain and output files succeeded Fixes #302. --- consensus.c | 9 ++++++++- 1 file changed, 8 insertions(+), 1 deletion(-) diff --git a/consensus.c b/consensus.c index 08f3d7d63..732526a63 100644 --- a/consensus.c +++ b/consensus.c @@ -26,6 +26,8 @@ #include #include +#include +#include #include #include #include @@ -205,11 +207,16 @@ static void init_data(args_t *args) if ( args->chain_fname ) { args->fp_chain = fopen(args->chain_fname,"w"); + if ( ! args->fp_chain ) error("Failed to create %s: %s\n", args->chain_fname, strerror(errno)); args->chain_id = 0; } rbuf_init(&args->vcf_rbuf, 100); args->vcf_buf = (bcf1_t**) calloc(args->vcf_rbuf.m, sizeof(bcf1_t*)); - args->fp_out = args->output_fname ? fopen(args->output_fname,"w") : stdout; + if ( args->output_fname ) { + args->fp_out = fopen(args->output_fname,"w"); + if ( ! args->fp_out ) error("Failed to create %s: %s\n", args->output_fname, strerror(errno)); + } + else args->fp_out = stdout; } static void destroy_data(args_t *args) From 63dd6d11e751a26755f268939779c081c79a77c3 Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Tue, 1 Sep 2015 13:58:17 +0100 Subject: [PATCH 058/211] include missing call to set ploidy and add test mpileup.ploidy bed file has `*` lines commented out at the moment as the bed reader does not like those lines --- test/mpileup.X.out | 40 + test/mpileup.X.vcf | 4127 ++++++++++++++++++++++++++++++++++++++++++ test/mpileup.ped | 3 + test/mpileup.ploidy | 4 + test/mpileup.samples | 3 + test/test.pl | 3 + vcfcall.c | 21 + 7 files changed, 4201 insertions(+) create mode 100644 test/mpileup.X.out create mode 100644 test/mpileup.X.vcf create mode 100644 test/mpileup.ped create mode 100644 test/mpileup.ploidy create mode 100644 test/mpileup.samples diff --git a/test/mpileup.X.out b/test/mpileup.X.out new file mode 100644 index 000000000..9a9d427a6 --- /dev/null +++ b/test/mpileup.X.out @@ -0,0 +1,40 @@ +##fileformat=VCFv4.2 +##FILTER= +##samtoolsVersion=1.1-19-g6b249e2+htslib-1.1-74-g845c515 +##samtoolsCommand=samtools mpileup -uvDV -b xxx//mpileup.bam.list -f xxx//mpileup.ref.fa.gz +##reference=file://xxx//mpileup.ref.fa.gz +##contig= +##ALT= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +#CHROM POS ID REF ALT QUAL FILTER INFO FORMAT HG00100 HG00101 HG00102 +X 302 . T TA 481 . INDEL;IDV=7;IMF=1;DP=25;VDB=0.27613;SGB=-4.22417;MQSB=0.0443614;MQ0F=0;ICB=0.235294;HOB=0.18;AC=4;AN=5;DP4=2,4,8,11;MQ=49 GT:PL:DP:DV 0/1:167,0,96:11:6 1:157,9:7:6 1/1:201,21,0:7:7 +X 828 . T C 321 . DP=25;VDB=0.842082;SGB=-4.20907;RPB=0.950652;MQB=1;MQSB=1;BQB=0.929717;MQ0F=0;ICB=0.235294;HOB=0.18;AC=4;AN=5;DP4=2,4,8,11;MQ=60 GT:PL:DP:DV 0/1:211,0,35:12:10 1:116,91:9:5 1/1:120,12,0:4:4 +X 834 . G A 308 . DP=25;VDB=0.788006;SGB=-4.01214;RPB=0.999233;MQB=1;MQSB=1;BQB=0.821668;MQ0F=0;ICB=0.235294;HOB=0.18;AC=4;AN=5;DP4=2,3,7,10;MQ=60 GT:PL:DP:DV 0/1:185,0,46:11:9 1:128,59:8:5 1/1:89,9,0:3:3 +X 1665 . T C 3.10665 . DP=20;VDB=0.1;SGB=0.346553;RPB=0.222222;MQB=0.611111;MQSB=0.988166;BQB=0.944444;MQ0F=0;ICB=0.128205;HOB=0.0555556;AC=1;AN=6;DP4=7,11,1,1;MQ=55 GT:PL:DP:DV 0/0:0,21,185:7:0 0/0:0,27,222:9:0 0/1:35,0,51:4:2 +X 1869 . A T 138 . DP=24;VDB=0.928022;SGB=-11.9537;RPB=0.984127;MQB=0.96464;MQSB=0.931547;BQB=0.359155;MQ0F=0;ICB=0.8;HOB=0.222222;AC=4;AN=6;DP4=6,9,5,4;MQ=58 GT:PL:DP:DV 0/1:115,0,224:18:7 0/1:16,0,104:5:1 1/1:42,3,0:1:1 +X 2041 . G A 447 . DP=31;VDB=0.816435;SGB=-4.18892;RPB=0.88473;MQB=0.972375;MQSB=0.968257;BQB=0.311275;MQ0F=0;ICB=0.8;HOB=0.222222;AC=4;AN=6;DP4=6,5,12,7;MQ=58 GT:PL:DP:DV 0/1:229,0,212:21:11 0/1:32,0,24:2:1 1/1:223,21,0:7:7 +X 2220 . G A 303 . DP=21;VDB=0.532753;SGB=-3.51597;RPB=0.964198;MQB=0.898397;MQSB=0.875769;BQB=0.0354359;MQ0F=0;ICB=0.8;HOB=0.222222;AC=4;AN=6;DP4=6,2,1,11;MQ=58 GT:PL:DP:DV 0/1:139,0,130:12:6 0/1:69,0,46:4:2 1/1:131,12,0:4:4 +X 2564 . A G 233 . DP=15;VDB=0.690812;SGB=-3.20711;RPB=0.197899;MQB=1;MQSB=1;BQB=0.965069;MQ0F=0;ICB=0.8;HOB=0.222222;AC=4;AN=6;DP4=1,4,4,5;MQ=60 GT:PL:DP:DV 0/1:88,0,78:6:3 0/1:57,0,56:4:2 1/1:124,12,0:4:4 +X 3104 . C T 24.1975 . DP=25;VDB=0.8;SGB=0.346553;RPB=0.717391;MQB=0.956522;MQSB=0.962269;BQB=0.978261;MQ0F=0;ICB=0.235294;HOB=0.18;AC=1;AN=5;DP4=8,15,2,0;MQ=58 GT:PL:DP:DV 0/0:0,48,255:16:0 0:0,144:4:0 0/1:59,0,93:5:2 +X 3587 . G A 332 . DP=29;VDB=0.902044;SGB=-3.91326;RPB=0.800999;MQB=1;MQSB=1;BQB=0.156944;MQ0F=0;ICB=0.461538;HOB=0.02;AC=3;AN=5;DP4=4,7,10,6;MQ=60 GT:PL:DP:DV 0/1:161,0,184:14:7 0:22,118:5:1 1/1:212,24,0:8:8 +X 3936 . A G 412 . DP=37;VDB=0.0574114;SGB=-4.60123;RPB=0.741697;MQB=0.812605;MQSB=0.143788;BQB=0.883831;MQ0F=0;ICB=0.235294;HOB=0.18;AC=4;AN=5;DP4=5,6,6,17;MQ=56 GT:PL:DP:DV 0/1:233,0,206:20:11 1:77,58:6:4 1/1:196,24,0:8:8 diff --git a/test/mpileup.X.vcf b/test/mpileup.X.vcf new file mode 100644 index 000000000..ea2983a3b --- /dev/null +++ b/test/mpileup.X.vcf @@ -0,0 +1,4127 @@ +##fileformat=VCFv4.2 +##FILTER= +##samtoolsVersion=1.1-19-g6b249e2+htslib-1.1-74-g845c515 +##samtoolsCommand=samtools mpileup -uvDV -b xxx//mpileup.bam.list -f xxx//mpileup.ref.fa.gz +##reference=file://xxx//mpileup.ref.fa.gz +##contig= +##ALT= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##FORMAT= +##FORMAT= +##FORMAT= +#CHROM POS ID REF ALT QUAL FILTER INFO FORMAT HG00100 HG00101 HG00102 +X 1 . A <*> 0 . DP=11;I16=11,0,0,0,452,18594,0,0,319,9251,0,0,223,4959,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 +X 2 . A <*> 0 . DP=11;I16=11,0,0,0,439,17587,0,0,319,9251,0,0,226,5030,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 +X 3 . G <*> 0 . DP=11;I16=11,0,0,0,431,16971,0,0,319,9251,0,0,229,5111,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 +X 4 . C <*> 0 . DP=11;I16=11,0,0,0,423,16417,0,0,319,9251,0,0,232,5202,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,71:3:0 +X 5 . T <*> 0 . DP=11;I16=11,0,0,0,450,18520,0,0,319,9251,0,0,234,5252,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 +X 6 . T <*> 0 . DP=11;I16=11,0,0,0,403,14847,0,0,319,9251,0,0,236,5310,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 +X 7 . C <*> 0 . DP=11;I16=11,0,0,0,446,18114,0,0,319,9251,0,0,237,5327,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 +X 8 . T <*> 0 . DP=11;I16=11,0,0,0,465,19677,0,0,319,9251,0,0,238,5354,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 +X 9 . C <*> 0 . DP=11;I16=11,0,0,0,447,18205,0,0,319,9251,0,0,239,5391,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 +X 10 . A <*> 0 . DP=11;I16=11,0,0,0,426,16756,0,0,319,9251,0,0,240,5438,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,69:3:0 +X 11 . C <*> 0 . DP=11;I16=11,0,0,0,413,15603,0,0,319,9251,0,0,241,5495,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 +X 12 . C <*> 0 . DP=11;I16=11,0,0,0,438,17506,0,0,319,9251,0,0,242,5562,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 +X 13 . C <*> 0 . DP=11;I16=11,0,0,0,437,17463,0,0,319,9251,0,0,243,5639,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 +X 14 . T <*> 0 . DP=11;I16=11,0,0,0,453,18715,0,0,319,9251,0,0,242,5628,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 +X 15 . G <*> 0 . DP=11;I16=11,0,0,0,439,17599,0,0,319,9251,0,0,240,5580,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 +X 16 . T <*> 0 . DP=11;I16=11,0,0,0,426,16546,0,0,319,9251,0,0,238,5544,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 +X 17 . T <*> 0 . DP=11;I16=11,0,0,0,407,15195,0,0,319,9251,0,0,235,5469,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 +X 18 . C <*> 0 . DP=12;I16=12,0,0,0,450,17136,0,0,379,12851,0,0,231,5353,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,18,113:6:0 0,9,72:3:0 0,9,72:3:0 +X 19 . C <*> 0 . DP=13;I16=13,0,0,0,502,19652,0,0,439,16451,0,0,228,5246,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,18,112:6:0 0,12,89:4:0 0,9,72:3:0 +X 20 . T <*> 0 . DP=13;I16=13,0,0,0,532,21878,0,0,439,16451,0,0,226,5150,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,18,116:6:0 0,12,98:4:0 0,9,72:3:0 +X 21 . G <*> 0 . DP=13;I16=13,0,0,0,498,19254,0,0,439,16451,0,0,224,5066,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,18,117:6:0 0,12,94:4:0 0,9,72:3:0 +X 22 . C <*> 0 . DP=13;I16=13,0,0,0,511,20289,0,0,470,19210,0,0,223,4993,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,18,115:6:0 0,12,91:4:0 0,9,76:3:0 +X 23 . A <*> 0 . DP=14;I16=14,0,0,0,513,19399,0,0,530,22810,0,0,223,4931,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,133:7:0 0,12,82:4:0 0,9,82:3:0 +X 24 . T <*> 0 . DP=14;I16=14,0,0,0,534,20540,0,0,530,22810,0,0,224,4882,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,131:7:0 0,12,96:4:0 0,9,80:3:0 +X 25 . A <*> 0 . DP=15;I16=15,0,0,0,561,21133,0,0,590,26410,0,0,225,4847,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,140:8:0 0,12,96:4:0 0,9,81:3:0 +X 26 . G <*> 0 . DP=15;I16=15,0,0,0,591,23429,0,0,590,26410,0,0,227,4827,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,151:8:0 0,12,96:4:0 0,9,81:3:0 +X 27 . A <*> 0 . DP=15;I16=15,0,0,0,588,23120,0,0,590,26410,0,0,229,4823,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,146:8:0 0,12,98:4:0 0,9,83:3:0 +X 28 . T <*> 0 . DP=16;I16=16,0,0,0,605,23001,0,0,650,30010,0,0,231,4835,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,147:8:0 0,12,97:4:0 0,12,101:4:0 +X 29 . A <*> 0 . DP=17;I16=17,0,0,0,615,22533,0,0,710,33610,0,0,234,4864,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,146:8:0 0,15,102:5:0 0,12,104:4:0 +X 30 . A <*> 0 . DP=17;I16=17,0,0,0,660,25914,0,0,710,33610,0,0,238,4912,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,149:8:0 0,15,115:5:0 0,12,108:4:0 +X 31 . T <*> 0 . DP=17;I16=17,0,0,0,656,25392,0,0,710,33610,0,0,242,4980,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,150:8:0 0,15,113:5:0 0,12,105:4:0 +X 32 . T <*> 0 . DP=17;I16=17,0,0,0,605,21789,0,0,741,36369,0,0,247,5067,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,143:8:0 0,15,104:5:0 0,12,104:4:0 +X 33 . G <*> 0 . DP=17;I16=17,0,0,0,659,25757,0,0,741,36369,0,0,252,5124,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,158:8:0 0,15,118:5:0 0,12,105:4:0 +X 34 . C <*> 0 . DP=17;I16=17,0,0,0,658,25704,0,0,741,36369,0,0,257,5203,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,151:8:0 0,15,121:5:0 0,12,106:4:0 +X 35 . A <*> 0 . DP=18;I16=18,0,0,0,677,25881,0,0,801,39969,0,0,262,5304,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,152:8:0 0,15,109:5:0 0,15,121:5:0 +X 36 . T <*> 0 . DP=18;I16=18,0,0,0,678,25796,0,0,801,39969,0,0,268,5428,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,151:8:0 0,15,114:5:0 0,15,125:5:0 +X 37 . G <*> 0 . DP=18;I16=18,0,0,0,685,26291,0,0,801,39969,0,0,274,5576,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,157:8:0 0,15,116:5:0 0,15,126:5:0 +X 38 . A <*> 0 . DP=18;I16=18,0,0,0,697,27245,0,0,801,39969,0,0,280,5748,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,152:8:0 0,15,116:5:0 0,15,129:5:0 +X 39 . C <*> 0 . DP=16;I16=16,0,0,0,591,22311,0,0,743,38287,0,0,288,5942,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,148:7:0 0,12,94:4:0 0,15,123:5:0 +X 40 . A <*> 0 . DP=16;I16=16,0,0,0,630,24896,0,0,743,38287,0,0,295,6107,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,146:7:0 0,12,104:4:0 0,15,127:5:0 +X 41 . A <*> 0 . DP=17;I16=17,0,0,0,645,24685,0,0,803,41887,0,0,302,6294,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,151:8:0 0,12,104:4:0 0,15,131:5:0 +X 42 . T <*> 0 . DP=17;I16=17,0,0,0,618,23118,0,0,803,41887,0,0,310,6504,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,155:8:0 0,12,82:4:0 0,15,127:5:0 +X 43 . T <*> 0 . DP=17;I16=17,0,0,0,631,23689,0,0,803,41887,0,0,318,6738,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,151:8:0 0,12,101:4:0 0,15,129:5:0 +X 44 . G <*> 0 . DP=17;I16=17,0,0,0,664,26162,0,0,803,41887,0,0,324,6896,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,164:8:0 0,12,100:4:0 0,15,129:5:0 +X 45 . C <*> 0 . DP=17;I16=17,0,0,0,657,25525,0,0,803,41887,0,0,329,7027,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,163:8:0 0,12,108:4:0 0,15,125:5:0 +X 46 . C <*> 0 . DP=17;I16=17,0,0,0,646,25244,0,0,803,41887,0,0,334,7180,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,161:8:0 0,12,98:4:0 0,15,131:5:0 +X 47 . T <*> 0 . DP=17;I16=17,0,0,0,700,28998,0,0,803,41887,0,0,339,7355,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,165:8:0 0,12,110:4:0 0,15,136:5:0 +X 48 . T <*> 0 . DP=17;I16=17,0,0,0,648,25020,0,0,803,41887,0,0,343,7501,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,155:8:0 0,12,105:4:0 0,15,131:5:0 +X 49 . G <*> 0 . DP=18;I16=18,0,0,0,686,26674,0,0,832,42728,0,0,346,7616,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,158:8:0 0,15,119:5:0 0,15,128:5:0 +X 50 . T <*> 0 . DP=18;I16=17,0,0,0,650,24972,0,0,772,39128,0,0,332,7426,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,155:8:0 0,12,101:4:0 0,15,128:5:0 +X 51 . C <*> 0 . DP=18;I16=18,0,0,0,681,26529,0,0,832,42728,0,0,353,7853,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,167:8:0 0,15,99:5:0 0,15,127:5:0 +X 52 . C <*> 0 . DP=18;I16=17,0,0,0,645,24983,0,0,803,41887,0,0,353,7965,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,164:8:0 0,12,99:4:0 0,15,128:5:0 +X 53 . C <*> 0 . DP=18;I16=18,0,0,0,687,26735,0,0,832,42728,0,0,359,8113,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,164:8:0 0,15,113:5:0 0,15,132:5:0 +X 54 . T <*> 0 . DP=18;I16=18,0,0,0,736,30194,0,0,832,42728,0,0,361,8219,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,163:8:0 0,15,128:5:0 0,15,136:5:0 +X 55 . G <*> 0 . DP=18;I16=18,0,0,0,674,26082,0,0,832,42728,0,0,362,8290,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,168:8:0 0,15,112:5:0 0,15,122:5:0 +X 56 . C <*> 0 . DP=18;I16=18,0,0,0,701,27645,0,0,832,42728,0,0,363,8375,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,162:8:0 0,15,121:5:0 0,15,131:5:0 +X 57 . T <*> 0 . DP=18;I16=17,0,0,0,694,29118,0,0,803,41887,0,0,356,8410,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,163:8:0 0,12,117:4:0 0,15,138:5:0 +X 58 . G <*> 0 . DP=17;I16=16,0,0,0,616,24356,0,0,774,41046,0,0,356,8454,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,159:7:0 0,12,95:4:0 0,15,131:5:0 +X 59 . A <*> 0 . DP=17;I16=17,0,0,0,656,26038,0,0,803,41887,0,0,366,8606,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,155:7:0 0,15,116:5:0 0,15,134:5:0 +X 60 . A <*> 0 . DP=17;I16=17,0,0,0,663,26463,0,0,803,41887,0,0,367,8687,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,151:7:0 0,15,127:5:0 0,15,138:5:0 +X 61 . T <*> 0 . DP=17;I16=16,0,0,0,605,23215,0,0,774,41046,0,0,355,8583,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,152:7:0 0,12,101:4:0 0,15,131:5:0 +X 62 . G <*> 0 . DP=18;I16=17,0,0,0,646,24868,0,0,834,44646,0,0,353,8557,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,158:7:0 0,12,103:4:0 0,18,141:6:0 +X 63 . T <*> 0 . DP=18;I16=17,0,0,0,590,21682,0,0,803,41887,0,0,341,8111,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,148:7:0 0,12,80:4:0 0,18,144:6:0 +X 64 . G <*> 0 . DP=19;I16=19,0,0,0,696,26416,0,0,923,49087,0,0,366,8758,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,169:8:0 0,15,103:5:0 0,18,142:6:0 +X 65 . C <*> 0 . DP=18;I16=18,0,0,0,686,26512,0,0,894,48246,0,0,367,8743,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,163:7:0 0,15,116:5:0 0,18,147:6:0 +X 66 . T <*> 0 . DP=18;I16=17,0,0,0,691,28315,0,0,834,44646,0,0,342,8068,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,164:7:0 0,12,110:4:0 0,18,153:6:0 +X 67 . C <*> 0 . DP=17;I16=17,0,0,0,645,25313,0,0,834,44646,0,0,341,7983,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,163:7:0 0,12,94:4:0 0,18,147:6:0 +X 68 . T <*> 0 . DP=17;I16=17,0,0,0,691,28307,0,0,834,44646,0,0,339,7863,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,165:7:0 0,12,108:4:0 0,18,151:6:0 +X 69 . G <*> 0 . DP=17;I16=17,0,0,0,657,25721,0,0,865,47405,0,0,338,7758,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,172:8:0 0,9,93:3:0 0,18,142:6:0 +X 70 . G <*> 0 . DP=17;I16=16,0,0,0,575,21391,0,0,836,46564,0,0,317,7227,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,162:8:0 0,6,64:2:0 0,18,141:6:0 +X 71 . G <*> 0 . DP=17;I16=15,0,0,0,571,21975,0,0,776,42964,0,0,307,7029,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,170:8:0 0,6,72:2:0 0,15,130:5:0 +X 72 . G <*> 0 . DP=17;I16=15,0,0,0,572,22002,0,0,776,42964,0,0,305,6907,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,171:8:0 0,6,65:2:0 0,15,131:5:0 +X 73 . T <*> 0 . DP=18;I16=16,0,0,0,623,25301,0,0,836,46564,0,0,314,6918,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,158:8:0 0,6,94:2:0 0,18,143:6:0 +X 74 . C <*> 0 . DP=18;I16=17,0,0,0,674,28110,0,0,865,47405,0,0,338,7468,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,176:8:0 0,9,106:3:0 0,18,141:6:0 +X 75 . T <*> 0 . DP=18;I16=16,0,0,0,685,30675,0,0,836,46564,0,0,312,6782,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,175:8:0 0,6,90:2:0 0,18,150:6:0 +X 76 . C <*> 0 . DP=18;I16=17,0,0,0,683,29481,0,0,865,47405,0,0,336,7360,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,174:8:0 0,9,98:3:0 0,18,148:6:0 +X 77 . T <*> 0 . DP=18;I16=16,0,0,0,710,33072,0,0,836,46564,0,0,310,6702,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,179:8:0 0,6,92:2:0 0,18,154:6:0 +X 78 . G <*> 0 . DP=18;I16=16,0,0,0,692,31158,0,0,836,46564,0,0,309,6683,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,180:8:0 0,6,94:2:0 0,18,149:6:0 +X 79 . G <*> 0 . DP=18;I16=15,0,0,0,605,26629,0,0,776,42964,0,0,283,6053,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,168:8:0 0,3,60:1:0 0,18,149:6:0 +X 80 . G <*> 0 . DP=18;I16=17,0,0,0,688,30128,0,0,865,47405,0,0,332,7312,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,173:8:0 0,9,106:3:0 0,18,151:6:0 +X 81 . G <*> 0 . DP=18;I16=16,0,0,0,631,27429,0,0,836,46564,0,0,326,7310,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,165:7:0 0,9,97:3:0 0,18,145:6:0 +X 82 . T <*> 0 . DP=18;I16=15,0,0,0,559,22735,0,0,776,42964,0,0,280,6122,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,154:8:0 0,3,60:1:0 0,18,131:6:0 +X 83 . C <*> 0 . DP=18;I16=16,0,0,0,622,27146,0,0,836,46564,0,0,304,6798,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,170:8:0 0,6,75:2:0 0,18,145:6:0 +X 84 . T <*> 0 . DP=18;I16=17,0,0,0,705,32445,0,0,865,47405,0,0,328,7488,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,181:8:0 0,9,85:3:0 0,18,154:6:0 +X 85 . C <*> 0 . DP=18;I16=17,0,0,0,708,31222,0,0,865,47405,0,0,327,7567,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,181:8:0 0,9,108:3:0 0,18,153:6:0 +X 86 . A <*> 0 . DP=18;I16=17,0,0,0,692,29540,0,0,865,47405,0,0,326,7660,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,169:8:0 0,9,111:3:0 0,18,149:6:0 +X 87 . C <*> 0 . DP=18;I16=17,0,0,0,683,29493,0,0,896,50164,0,0,326,7766,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,174:8:0 0,9,103:3:0 0,18,148:6:0 +X 88 . C <*> 0 . DP=18;I16=17,0,0,0,703,31005,0,0,896,50164,0,0,326,7834,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,174:8:0 0,9,113:3:0 0,18,153:6:0 +X 89 . C <*> 0 . DP=18;I16=17,0,0,0,697,30875,0,0,896,50164,0,0,326,7914,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,176:8:0 0,9,103:3:0 0,18,154:6:0 +X 90 . A <*> 0 . DP=17;I16=16,0,0,0,668,29732,0,0,867,49323,0,0,326,7954,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,173:8:0 0,9,114:3:0 0,15,138:5:0 +X 91 . C <*> 0 . DP=16;I16=15,0,0,0,613,26409,0,0,838,48482,0,0,327,8001,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,170:7:0 0,9,113:3:0 0,15,133:5:0 +X 92 . G <*> 0 . DP=16;I16=15,0,0,0,499,18731,0,0,838,48482,0,0,328,8054,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,143:7:0 0,9,100:3:0 0,15,96:5:0 +X 93 . A <*> 0 . DP=16;I16=15,0,0,0,635,28655,0,0,869,51241,0,0,329,8063,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,167:7:0 0,9,108:3:0 0,15,145:5:0 +X 94 . C <*> 0 . DP=16;I16=15,0,0,0,607,25893,0,0,869,51241,0,0,331,8079,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,166:7:0 0,9,105:3:0 0,15,135:5:0 +X 95 . C <*> 0 . DP=17;I16=15,0,0,0,615,26761,0,0,900,54000,0,0,306,7378,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,178:8:0 0,6,91:2:0 0,15,135:5:0 +X 96 . A <*> 0 . DP=17;I16=16,0,0,0,625,26705,0,0,929,54841,0,0,332,7936,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,172:8:0 0,9,99:3:0 0,15,134:5:0 +X 97 . A <*> 0 . DP=18;I16=17,0,0,0,675,29017,0,0,958,55682,0,0,333,7879,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,179:9:0 0,9,104:3:0 0,15,145:5:0 +X 98 . C <*> 0 . DP=18;I16=17,0,0,0,655,27231,0,0,958,55682,0,0,333,7735,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,179:9:0 0,9,105:3:0 0,15,131:5:0 +X 99 . T <*> 0 . DP=18;I16=17,0,0,0,720,32840,0,0,958,55682,0,0,333,7607,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,186:9:0 0,9,115:3:0 0,15,153:5:0 +X 100 . C <*> 0 . DP=18;I16=17,0,0,0,688,29762,0,0,958,55682,0,0,332,7446,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,189:9:0 0,9,108:3:0 0,15,134:5:0 +X 101 . C <*> 0 . DP=18;I16=17,0,0,0,650,27530,0,0,958,55682,0,0,331,7303,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,182:9:0 0,9,99:3:0 0,15,132:5:0 +X 102 . C <*> 0 . DP=18;I16=17,0,0,0,695,30453,0,0,958,55682,0,0,330,7178,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,188:9:0 0,9,111:3:0 0,15,139:5:0 +X 103 . T <*> 0 . DP=18;I16=16,0,0,0,692,31998,0,0,929,54841,0,0,323,7035,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,189:8:0 0,9,108:3:0 0,15,147:5:0 +X 104 . G <*> 0 . DP=18;I16=15,0,0,0,611,26723,0,0,900,54000,0,0,295,6259,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,178:8:0 0,6,89:2:0 0,15,133:5:0 +X 105 . G <*> 0 . DP=19;I16=17,0,0,0,604,23936,0,0,989,58441,0,0,317,6751,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,170:9:0 0,9,97:3:0 0,15,125:5:0 +X 106 . G <*> 0 . DP=19;I16=17,0,0,0,644,26574,0,0,989,58441,0,0,299,6093,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,30,190:10:0 0,6,85:2:0 0,15,124:5:0 +X 107 . C <*> 0 . DP=19;I16=17,0,0,0,694,30064,0,0,989,58441,0,0,313,6543,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,192:9:0 0,9,108:3:0 0,15,136:5:0 +X 108 . C <*> 0 . DP=19;I16=17,0,0,0,692,30148,0,0,989,58441,0,0,310,6420,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,190:9:0 0,9,108:3:0 0,15,135:5:0 +X 109 . T <*> 0 . DP=19;I16=17,0,0,0,741,34273,0,0,989,58441,0,0,307,6319,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,195:9:0 0,9,110:3:0 0,15,150:5:0 +X 110 . G <*> 0 . DP=19;I16=17,0,0,0,704,31276,0,0,989,58441,0,0,304,6240,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,194:9:0 0,9,104:3:0 0,15,136:5:0 +X 111 . G <*> 0 . DP=19;I16=16,0,0,0,584,24362,0,0,929,54841,0,0,272,5416,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,30,167:10:0 0,6,88:2:0 0,12,118:4:0 +X 112 . C <*> 0 . DP=19;I16=17,0,0,0,680,29854,0,0,989,58441,0,0,296,6052,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,191:9:0 0,9,95:3:0 0,15,135:5:0 +X 113 . A <*> 0 . DP=19;I16=16,0,0,0,645,28035,0,0,960,57600,0,0,266,5318,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,176:9:0 0,6,87:2:0 0,15,139:5:0 +X 114 . C <*> 0 . DP=19;I16=17,0,0,0,674,28788,0,0,989,58441,0,0,286,5856,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,182:9:0 0,9,103:3:0 0,15,133:5:0 +X 115 . C <*> 0 . DP=21;I16=18,0,0,0,708,30546,0,0,1049,62041,0,0,274,5490,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,30,189:10:0 0,6,89:2:0 0,18,147:6:0 +X 116 . A <*> 0 . DP=21;I16=17,1,0,0,727,31755,0,0,1049,62041,0,0,253,5079,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,183:9:0 0,6,90:2:0 0,21,175:7:0 +X 117 . G <*> 0 . DP=21;I16=17,1,0,0,723,31221,0,0,1049,62041,0,0,249,5019,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,186:9:0 0,6,86:2:0 0,21,177:7:0 +X 118 . G <*> 0 . DP=20;I16=16,1,0,0,636,26574,0,0,958,55682,0,0,266,5426,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,175:9:0 0,3,60:1:0 0,21,162:7:0 +X 119 . G <*> 0 . DP=19;I16=16,1,0,0,629,26439,0,0,958,55682,0,0,267,5553,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,175:8:0 0,6,73:2:0 0,21,160:7:0 +X 120 . A <*> 0 . DP=19;I16=16,1,0,0,672,29188,0,0,958,55682,0,0,264,5518,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,175:8:0 0,6,83:2:0 0,21,171:7:0 +X 121 . G <*> 0 . DP=19;I16=16,1,0,0,662,28460,0,0,958,55682,0,0,260,5454,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,181:8:0 0,6,80:2:0 0,21,168:7:0 +X 122 . C <*> 0 . DP=20;I16=17,1,0,0,716,31224,0,0,1018,59282,0,0,256,5410,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,181:8:0 0,9,99:3:0 0,21,178:7:0 +X 123 . T <*> 0 . DP=18;I16=15,1,0,0,661,29997,0,0,898,52082,0,0,255,5385,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,167:7:0 0,9,112:3:0 0,18,166:6:0 +X 124 . T <*> 0 . DP=19;I16=17,1,0,0,626,24802,0,0,987,56523,0,0,279,6003,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,154:9:0 0,9,104:3:0 0,18,154:6:0 +X 125 . A <*> 0 . DP=18;I16=15,1,0,0,611,25689,0,0,898,52082,0,0,254,5340,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,154:7:0 0,9,104:3:0 0,18,162:6:0 +X 126 . A <*> 0 . DP=18;I16=16,1,0,0,648,27366,0,0,927,52923,0,0,279,5947,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,162:8:0 0,9,107:3:0 0,18,174:6:0 +X 127 . C <*> 0 . DP=18;I16=16,1,0,0,646,26972,0,0,927,52923,0,0,279,5949,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,163:8:0 0,9,109:3:0 0,18,160:6:0 +X 128 . A <*> 0 . DP=18;I16=16,1,0,0,673,28797,0,0,927,52923,0,0,279,5971,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,169:8:0 0,9,111:3:0 0,18,162:6:0 +X 129 . A <*> 0 . DP=17;I16=15,1,0,0,645,27891,0,0,867,49323,0,0,280,6012,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,168:8:0 0,9,113:3:0 0,15,159:5:0 +X 130 . A <*> 0 . DP=17;I16=15,1,0,0,641,27295,0,0,867,49323,0,0,281,6071,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,169:8:0 0,9,113:3:0 0,15,152:5:0 +X 131 . C <*> 0 . DP=16;I16=14,1,0,0,606,25732,0,0,838,48482,0,0,256,5472,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,167:7:0 0,9,110:3:0 0,15,147:5:0 +X 132 . A <*> 0 . DP=16;I16=14,1,0,0,627,27579,0,0,838,48482,0,0,256,5514,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,169:7:0 0,9,110:3:0 0,15,151:5:0 +X 133 . T <*> 0 . DP=15;I16=13,2,0,0,584,22816,0,0,838,48482,0,0,282,6196,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL:DP:DV 0,21,163:7:0 0,9,105:3:0 0,15,150:5:0 +X 134 . C <*> 0 . DP=15;I16=13,2,0,0,607,24653,0,0,838,48482,0,0,283,6267,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL:DP:DV 0,21,177:7:0 0,9,105:3:0 0,15,152:5:0 +X 135 . T <*> 0 . DP=15;I16=13,2,0,0,600,24178,0,0,838,48482,0,0,284,6352,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL:DP:DV 0,21,173:7:0 0,9,106:3:0 0,15,156:5:0 +X 136 . G <*> 0 . DP=15;I16=13,2,0,0,574,22258,0,0,838,48482,0,0,286,6450,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL:DP:DV 0,21,172:7:0 0,9,105:3:0 0,15,134:5:0 +X 137 . T <*> 0 . DP=15;I16=13,2,0,0,563,21377,0,0,838,48482,0,0,289,6561,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL:DP:DV 0,21,160:7:0 0,9,104:3:0 0,15,139:5:0 +X 138 . C <*> 0 . DP=15;I16=13,2,0,0,584,23088,0,0,838,48482,0,0,291,6637,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL:DP:DV 0,21,172:7:0 0,9,108:3:0 0,15,142:5:0 +X 139 . C <*> 0 . DP=15;I16=13,2,0,0,554,20790,0,0,838,48482,0,0,292,6680,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL:DP:DV 0,21,161:7:0 0,9,106:3:0 0,15,143:5:0 +X 140 . A <*> 0 . DP=15;I16=13,2,0,0,583,22789,0,0,838,48482,0,0,292,6690,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL:DP:DV 0,21,163:7:0 0,9,107:3:0 0,15,153:5:0 +X 141 . G <*> 0 . DP=14;I16=12,2,0,0,534,20750,0,0,778,44882,0,0,292,6664,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL:DP:DV 0,18,158:6:0 0,9,108:3:0 0,15,142:5:0 +X 142 . C <*> 0 . DP=14;I16=12,2,0,0,503,18593,0,0,778,44882,0,0,292,6650,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL:DP:DV 0,18,157:6:0 0,9,97:3:0 0,15,129:5:0 +X 143 . G <*> 0 . DP=14;I16=11,2,0,0,415,13657,0,0,718,41282,0,0,285,6599,0,0;QS=3,0;MQSB=0.590909;MQ0F=0 PL:DP:DV 0,18,128:6:0 0,9,95:3:0 0,12,97:4:0 +X 144 . A <*> 0 . DP=14;I16=12,2,0,0,519,19725,0,0,778,44882,0,0,291,6609,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL:DP:DV 0,18,152:6:0 0,9,105:3:0 0,15,129:5:0 +X 145 . A <*> 0 . DP=14;I16=12,2,0,0,527,20289,0,0,778,44882,0,0,290,6584,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL:DP:DV 0,18,153:6:0 0,9,106:3:0 0,15,138:5:0 +X 146 . T <*> 0 . DP=14;I16=12,2,0,0,514,19484,0,0,778,44882,0,0,289,6573,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL:DP:DV 0,18,152:6:0 0,9,103:3:0 0,15,128:5:0 +X 147 . A <*> 0 . DP=14;I16=12,2,0,0,515,19213,0,0,778,44882,0,0,288,6576,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL:DP:DV 0,18,150:6:0 0,9,99:3:0 0,15,140:5:0 +X 148 . C <*> 0 . DP=14;I16=12,2,0,0,541,21019,0,0,778,44882,0,0,286,6542,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL:DP:DV 0,18,157:6:0 0,9,106:3:0 0,15,146:5:0 +X 149 . C <*> 0 . DP=14;I16=12,2,0,0,512,19326,0,0,778,44882,0,0,283,6471,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL:DP:DV 0,18,148:6:0 0,9,109:3:0 0,15,140:5:0 +X 150 . T <*> 0 . DP=13;I16=11,2,0,0,511,20251,0,0,749,44041,0,0,280,6362,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,18,153:6:0 0,6,84:2:0 0,15,152:5:0 +X 151 . G <*> 0 . DP=13;I16=11,2,0,0,506,19826,0,0,749,44041,0,0,277,6263,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,18,157:6:0 0,6,84:2:0 0,15,144:5:0 +X 152 . C <*> 0 . DP=14;I16=12,2,0,0,543,21283,0,0,809,47641,0,0,274,6174,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,21,168:7:0 0,6,84:2:0 0,15,146:5:0 +X 153 . A <*> 0 . DP=14;I16=12,2,0,0,536,20594,0,0,809,47641,0,0,272,6096,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,21,156:7:0 0,6,81:2:0 0,15,153:5:0 +X 154 . T <*> 0 . DP=14;I16=12,2,0,0,523,20051,0,0,809,47641,0,0,270,6030,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,21,159:7:0 0,6,83:2:0 0,15,139:5:0 +X 155 . C <*> 0 . DP=14;I16=12,2,0,0,542,21254,0,0,809,47641,0,0,268,5976,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,21,172:7:0 0,6,85:2:0 0,15,139:5:0 +X 156 . C <*> 0 . DP=14;I16=12,2,0,0,536,20884,0,0,809,47641,0,0,266,5934,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,21,163:7:0 0,6,84:2:0 0,15,150:5:0 +X 157 . C <*> 0 . DP=14;I16=12,2,0,0,555,22081,0,0,809,47641,0,0,264,5904,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,21,169:7:0 0,6,85:2:0 0,15,149:5:0 +X 158 . T <*> 0 . DP=14;I16=12,2,0,0,568,23154,0,0,809,47641,0,0,262,5886,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,21,170:7:0 0,6,84:2:0 0,15,159:5:0 +X 159 . A <*> 0 . DP=15;I16=12,2,0,0,519,19467,0,0,809,47641,0,0,260,5880,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,21,157:7:0 0,6,83:2:0 0,15,135:5:0 +X 160 . G <*> 0 . DP=15;I16=13,2,0,0,547,20633,0,0,869,51241,0,0,259,5887,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,21,165:7:0 0,6,85:2:0 0,18,139:6:0 +X 161 . A <*> 0 . DP=15;I16=13,2,0,0,568,21610,0,0,869,51241,0,0,258,5908,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,21,157:7:0 0,6,83:2:0 0,18,162:6:0 +X 162 . A <*> 0 . DP=15;I16=13,2,0,0,557,21139,0,0,869,51241,0,0,255,5843,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,21,147:7:0 0,6,87:2:0 0,18,167:6:0 +X 163 . G <*> 0 . DP=14;I16=12,2,0,0,503,18645,0,0,809,47641,0,0,253,5791,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,21,153:7:0 0,6,79:2:0 0,15,138:5:0 +X 164 . T <*> 0 . DP=14;I16=12,2,0,0,460,15968,0,0,809,47641,0,0,252,5750,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,18,131:6:0 0,6,79:2:0 0,18,136:6:0 +X 165 . G <*> 0 . DP=14;I16=10,2,0,0,456,17460,0,0,689,40441,0,0,226,5094,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,18,149:6:0 0,6,80:2:0 0,12,122:4:0 +X 166 . A <*> 0 . DP=14;I16=11,2,0,0,496,19138,0,0,749,44041,0,0,227,5077,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,18,145:6:0 0,6,82:2:0 0,15,148:5:0 +X 167 . A <*> 0 . DP=14;I16=11,2,0,0,477,17851,0,0,749,44041,0,0,227,5071,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,18,132:6:0 0,6,86:2:0 0,15,147:5:0 +X 168 . G <*> 0 . DP=14;I16=12,2,0,0,481,18015,0,0,809,47641,0,0,252,5702,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,18,145:6:0 0,6,82:2:0 0,18,140:6:0 +X 169 . C <*> 0 . DP=13;I16=10,2,0,0,402,14224,0,0,689,40441,0,0,227,5045,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,15,106:5:0 0,6,76:2:0 0,15,145:5:0 +X 170 . C <*> 0 . DP=13;I16=11,2,0,0,447,16383,0,0,749,44041,0,0,251,5601,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,15,128:5:0 0,6,80:2:0 0,18,143:6:0 +X 171 . A <*> 0 . DP=13;I16=11,2,0,0,500,19366,0,0,749,44041,0,0,250,5546,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,15,134:5:0 0,6,81:2:0 0,18,166:6:0 +X 172 . C <*> 0 . DP=13;I16=10,2,0,0,439,16395,0,0,689,40441,0,0,241,5441,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,15,138:5:0 0,6,75:2:0 0,15,129:5:0 +X 173 . C <*> 0 . DP=13;I16=11,2,0,0,435,15225,0,0,749,44041,0,0,248,5478,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,15,121:5:0 0,6,76:2:0 0,18,146:6:0 +X 174 . G <*> 0 . DP=13;I16=11,1,0,0,351,10685,0,0,689,40441,0,0,238,5364,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,15,111:5:0 0,3,27:1:0 0,18,117:6:0 +X 175 . C <*> 0 . DP=14;I16=13,1,0,0,511,19161,0,0,809,47641,0,0,249,5463,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,143:6:0 0,3,41:1:0 0,21,175:7:0 +X 176 . C <*> 0 . DP=14;I16=13,1,0,0,489,17733,0,0,809,47641,0,0,251,5477,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,146:6:0 0,3,44:1:0 0,21,152:7:0 +X 177 . C <*> 0 . DP=14;I16=13,1,0,0,488,17328,0,0,809,47641,0,0,253,5507,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,138:6:0 0,3,44:1:0 0,21,158:7:0 +X 178 . A <*> 0 . DP=14;I16=13,1,0,0,519,19485,0,0,809,47641,0,0,254,5502,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,147:6:0 0,3,42:1:0 0,21,172:7:0 +X 179 . A <*> 0 . DP=14;I16=13,1,0,0,478,17278,0,0,809,47641,0,0,255,5511,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,134:6:0 0,3,44:1:0 0,21,170:7:0 +X 180 . A <*> 0 . DP=14;I16=12,1,0,0,425,14653,0,0,749,44041,0,0,250,5498,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,126:6:0 0,3,43:1:0 0,18,148:6:0 +X 181 . G <*> 0 . DP=14;I16=11,1,0,0,450,17152,0,0,689,40441,0,0,233,5233,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,156:6:0 0,3,41:1:0 0,15,138:5:0 +X 182 . A <*> 0 . DP=15;I16=14,1,0,0,515,18235,0,0,869,51241,0,0,258,5622,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,150:7:0 0,3,43:1:0 0,21,159:7:0 +X 183 . C <*> 0 . DP=15;I16=13,1,0,0,483,17419,0,0,809,47641,0,0,235,5063,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,159:7:0 0,3,40:1:0 0,18,139:6:0 +X 184 . A <*> 0 . DP=15;I16=14,1,0,0,535,19667,0,0,869,51241,0,0,262,5770,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,158:7:0 0,3,41:1:0 0,21,163:7:0 +X 185 . C <*> 0 . DP=15;I16=13,1,0,0,487,17295,0,0,809,47641,0,0,238,5192,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,150:7:0 0,3,38:1:0 0,18,160:6:0 +X 186 . G <*> 0 . DP=15;I16=12,1,0,0,381,11429,0,0,749,44041,0,0,239,5253,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,117:6:0 0,3,32:1:0 0,18,124:6:0 +X 187 . C <*> 0 . DP=14;I16=13,1,0,0,511,18979,0,0,809,47641,0,0,266,5952,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,147:6:0 0,3,38:1:0 0,21,172:7:0 +X 188 . C <*> 0 . DP=14;I16=13,1,0,0,496,18042,0,0,809,47641,0,0,267,5989,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,147:6:0 0,3,37:1:0 0,21,162:7:0 +X 189 . C <*> 0 . DP=15;I16=13,2,0,0,552,20504,0,0,838,48482,0,0,268,6040,0,0;QS=3,0;MQSB=0;MQ0F=0 PL:DP:DV 0,18,152:6:0 0,6,67:2:0 0,21,167:7:0 +X 190 . A <*> 0 . DP=15;I16=12,2,0,0,500,18230,0,0,778,44882,0,0,243,5381,0,0;QS=3,0;MQSB=0;MQ0F=0 PL:DP:DV 0,18,138:6:0 0,6,68:2:0 0,18,159:6:0 +X 191 . T <*> 0 . DP=15;I16=13,2,0,0,534,19276,0,0,838,48482,0,0,267,5939,0,0;QS=3,0;MQSB=0;MQ0F=0 PL:DP:DV 0,18,143:6:0 0,6,67:2:0 0,21,169:7:0 +X 192 . G <*> 0 . DP=15;I16=13,2,0,0,499,17439,0,0,838,48482,0,0,266,5890,0,0;QS=3,0;MQSB=0;MQ0F=0 PL:DP:DV 0,18,143:6:0 0,6,67:2:0 0,21,151:7:0 +X 193 . T <*> 0 . DP=15;I16=13,2,0,0,505,17811,0,0,838,48482,0,0,265,5859,0,0;QS=3,0;MQSB=0;MQ0F=0 PL:DP:DV 0,18,140:6:0 0,6,63:2:0 0,21,157:7:0 +X 194 . C <*> 0 . DP=14;I16=12,2,0,0,467,16569,0,0,778,44882,0,0,265,5845,0,0;QS=3,0;MQSB=0;MQ0F=0 PL:DP:DV 0,18,142:6:0 0,6,67:2:0 0,18,145:6:0 +X 195 . C <*> 0 . DP=14;I16=11,3,0,0,503,18647,0,0,747,42123,0,0,266,5846,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:DV 0,18,159:6:0 0,6,71:2:0 0,18,160:6:0 +X 196 . A <*> 0 . DP=14;I16=11,3,0,0,482,17400,0,0,747,42123,0,0,268,5862,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:DV 0,18,166:6:0 0,6,69:2:0 0,18,138:6:0 +X 197 . G <*> 0 . DP=14;I16=11,3,0,0,481,17391,0,0,747,42123,0,0,270,5894,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:DV 0,18,164:6:0 0,6,68:2:0 0,18,134:6:0 +X 198 . C <*> 0 . DP=14;I16=11,3,0,0,539,20957,0,0,747,42123,0,0,271,5893,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:DV 0,18,172:6:0 0,6,70:2:0 0,18,164:6:0 +X 199 . T <*> 0 . DP=14;I16=11,3,0,0,505,19197,0,0,747,42123,0,0,271,5861,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:DV 0,18,162:6:0 0,6,73:2:0 0,18,154:6:0 +X 200 . T <*> 0 . DP=15;I16=11,4,0,0,544,19918,0,0,776,42964,0,0,270,5798,0,0;QS=3,0;MQSB=0.0161635;MQ0F=0 PL:DP:DV 0,18,161:6:0 0,9,89:3:0 0,18,154:6:0 +X 201 . A <*> 0 . DP=16;I16=12,4,0,0,568,20416,0,0,836,46564,0,0,269,5703,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,171:7:0 0,9,89:3:0 0,18,157:6:0 +X 202 . A <*> 0 . DP=16;I16=12,4,0,0,566,20590,0,0,836,46564,0,0,269,5627,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,178:7:0 0,9,84:3:0 0,18,163:6:0 +X 203 . C <*> 0 . DP=16;I16=12,4,0,0,557,20119,0,0,836,46564,0,0,269,5571,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,166:7:0 0,9,90:3:0 0,18,153:6:0 +X 204 . C <*> 0 . DP=16;I16=12,4,0,0,591,22379,0,0,836,46564,0,0,269,5535,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,173:7:0 0,9,91:3:0 0,18,163:6:0 +X 205 . T <*> 0 . DP=16;I16=12,4,0,0,635,25281,0,0,836,46564,0,0,269,5519,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,188:7:0 0,9,95:3:0 0,18,173:6:0 +X 206 . G <*> 0 . DP=16;I16=12,4,0,0,577,21337,0,0,836,46564,0,0,269,5523,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,180:7:0 0,9,89:3:0 0,18,143:6:0 +X 207 . C <*> 0 . DP=16;I16=12,4,0,0,574,21076,0,0,836,46564,0,0,269,5547,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,179:7:0 0,9,93:3:0 0,18,151:6:0 +X 208 . A <*> 0 . DP=16;I16=12,4,0,0,576,21486,0,0,836,46564,0,0,268,5540,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,184:7:0 0,9,93:3:0 0,18,154:6:0 +X 209 . T <*> 0 . DP=16;I16=12,4,0,0,567,20475,0,0,836,46564,0,0,267,5551,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,173:7:0 0,9,91:3:0 0,18,146:6:0 +X 210 . C <*> 0 . DP=16;I16=12,4,0,0,577,21109,0,0,836,46564,0,0,266,5580,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,185:7:0 0,9,92:3:0 0,18,151:6:0 +X 211 . C <*> 0 . DP=16;I16=12,4,0,0,563,20227,0,0,836,46564,0,0,265,5627,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,172:7:0 0,9,92:3:0 0,18,153:6:0 +X 212 . C <*> 0 . DP=16;I16=12,4,0,0,589,22179,0,0,836,46564,0,0,263,5643,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,181:7:0 0,9,92:3:0 0,18,152:6:0 +X 213 . T <*> 0 . DP=16;I16=12,4,0,0,598,22838,0,0,836,46564,0,0,262,5678,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,181:7:0 0,9,95:3:0 0,18,165:6:0 +X 214 . A <*> 0 . DP=16;I16=11,4,0,0,529,19401,0,0,776,42964,0,0,240,5248,0,0;QS=3,0;MQSB=0.0161635;MQ0F=0 PL:DP:DV 0,21,176:7:0 0,9,92:3:0 0,15,118:5:0 +X 215 . G <*> 0 . DP=15;I16=12,3,0,0,521,19073,0,0,807,45723,0,0,262,5754,0,0;QS=3,0;MQSB=0.0342181;MQ0F=0 PL:DP:DV 0,21,185:7:0 0,9,90:3:0 0,15,105:5:0 +X 216 . A <*> 0 . DP=14;I16=10,3,0,0,464,16900,0,0,687,38523,0,0,238,5166,0,0;QS=3,0;MQSB=0.040184;MQ0F=0 PL:DP:DV 0,21,173:7:0 0,9,92:3:0 0,9,81:3:0 +X 217 . A <*> 0 . DP=14;I16=11,3,0,0,515,19433,0,0,747,42123,0,0,264,5842,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:DV 0,21,181:7:0 0,9,90:3:0 0,12,97:4:0 +X 218 . G <*> 0 . DP=14;I16=11,3,0,0,507,18957,0,0,747,42123,0,0,265,5907,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:DV 0,21,178:7:0 0,9,90:3:0 0,12,110:4:0 +X 219 . T <*> 0 . DP=14;I16=11,3,0,0,470,16286,0,0,747,42123,0,0,266,5986,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:DV 0,21,173:7:0 0,9,88:3:0 0,12,89:4:0 +X 220 . G <*> 0 . DP=14;I16=10,3,0,0,485,18307,0,0,687,38523,0,0,242,5454,0,0;QS=3,0;MQSB=0.040184;MQ0F=0 PL:DP:DV 0,21,188:7:0 0,9,88:3:0 0,9,80:3:0 +X 221 . A <*> 0 . DP=14;I16=11,3,0,0,487,17615,0,0,747,42123,0,0,267,6135,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:DV 0,21,176:7:0 0,9,88:3:0 0,12,101:4:0 +X 222 . A <*> 0 . DP=14;I16=10,3,0,0,465,17367,0,0,687,38523,0,0,242,5578,0,0;QS=3,0;MQSB=0.040184;MQ0F=0 PL:DP:DV 0,21,186:7:0 0,9,85:3:0 0,9,69:3:0 +X 223 . G <*> 0 . DP=13;I16=9,3,0,0,405,14327,0,0,627,34923,0,0,243,5657,0,0;QS=3,0;MQSB=0.0443614;MQ0F=0 PL:DP:DV 0,18,168:6:0 0,6,53:2:0 0,12,81:4:0 +X 224 . G <*> 0 . DP=12;I16=9,3,0,0,379,12759,0,0,627,34923,0,0,270,6370,0,0;QS=3,0;MQSB=0.0443614;MQ0F=0 PL:DP:DV 0,18,168:6:0 0,6,50:2:0 0,12,70:4:0 +X 225 . C <*> 0 . DP=12;I16=8,3,0,0,382,13896,0,0,567,31323,0,0,261,6345,0,0;QS=3,0;MQSB=0.0497871;MQ0F=0 PL:DP:DV 0,18,165:6:0 0,6,48:2:0 0,9,83:3:0 +X 226 . A <*> 0 . DP=13;I16=8,3,0,0,381,13669,0,0,567,31323,0,0,248,5894,0,0;QS=3,0;MQSB=0.0497871;MQ0F=0 PL:DP:DV 0,18,166:6:0 0,6,53:2:0 0,9,84:3:0 +X 227 . C <*> 0 . DP=13;I16=8,4,0,0,406,14306,0,0,596,32164,0,0,267,6253,0,0;QS=3,0;MQSB=0.0249144;MQ0F=0 PL:DP:DV 0,21,190:7:0 0,6,53:2:0 0,9,73:3:0 +X 228 . C <*> 0 . DP=13;I16=9,4,0,0,417,14381,0,0,656,35764,0,0,292,6884,0,0;QS=3,0;MQSB=0.0211283;MQ0F=0 PL:DP:DV 0,21,187:7:0 0,6,45:2:0 0,12,96:4:0 +X 229 . G <*> 0 . DP=13;I16=9,3,0,0,358,11424,0,0,627,34923,0,0,270,6414,0,0;QS=3,0;MQSB=0.0443614;MQ0F=0 PL:DP:DV 0,18,136:6:0 0,6,53:2:0 0,12,70:4:0 +X 230 . C <*> 0 . DP=13;I16=9,4,0,0,461,16861,0,0,656,35764,0,0,292,6920,0,0;QS=3,0;MQSB=0.0211283;MQ0F=0 PL:DP:DV 0,21,186:7:0 0,6,53:2:0 0,12,100:4:0 +X 231 . C <*> 0 . DP=13;I16=7,4,0,0,414,15832,0,0,536,28564,0,0,247,5925,0,0;QS=3,0;MQSB=0.0401934;MQ0F=0 PL:DP:DV 0,18,184:6:0 0,6,53:2:0 0,9,82:3:0 +X 232 . C <*> 0 . DP=14;I16=9,4,0,0,471,17371,0,0,656,35764,0,0,267,6363,0,0;QS=3,0;MQSB=0.0211283;MQ0F=0 PL:DP:DV 0,21,198:7:0 0,6,53:2:0 0,12,101:4:0 +X 233 . A <*> 0 . DP=14;I16=10,4,0,0,496,18142,0,0,716,39364,0,0,292,6984,0,0;QS=3,0;MQSB=0.0183156;MQ0F=0 PL:DP:DV 0,21,192:7:0 0,6,53:2:0 0,15,119:5:0 +X 234 . A <*> 0 . DP=14;I16=10,4,0,0,502,18390,0,0,716,39364,0,0,292,6988,0,0;QS=3,0;MQSB=0.0183156;MQ0F=0 PL:DP:DV 0,21,185:7:0 0,6,53:2:0 0,15,123:5:0 +X 235 . A <*> 0 . DP=14;I16=9,4,0,0,476,17652,0,0,656,35764,0,0,267,6375,0,0;QS=3,0;MQSB=0.0211283;MQ0F=0 PL:DP:DV 0,21,186:7:0 0,6,53:2:0 0,12,111:4:0 +X 236 . G <*> 0 . DP=15;I16=11,4,0,0,501,17481,0,0,776,42964,0,0,290,6924,0,0;QS=3,0;MQSB=0.0161635;MQ0F=0 PL:DP:DV 0,24,206:8:0 0,6,53:2:0 0,15,103:5:0 +X 237 . A <*> 0 . DP=14;I16=9,4,0,0,465,16877,0,0,656,35764,0,0,266,6282,0,0;QS=3,0;MQSB=0.0211283;MQ0F=0 PL:DP:DV 0,24,206:8:0 0,6,53:2:0 0,9,92:3:0 +X 238 . C <*> 0 . DP=14;I16=10,4,0,0,482,17238,0,0,716,39364,0,0,292,6900,0,0;QS=3,0;MQSB=0.0183156;MQ0F=0 PL:DP:DV 0,24,211:8:0 0,6,53:2:0 0,12,82:4:0 +X 239 . A <*> 0 . DP=15;I16=10,5,0,0,525,19155,0,0,776,42964,0,0,292,6852,0,0;QS=3,0;MQSB=0.0497871;MQ0F=0 PL:DP:DV 0,27,223:9:0 0,6,50:2:0 0,12,108:4:0 +X 240 . C <*> 0 . DP=15;I16=10,5,0,0,512,17930,0,0,776,42964,0,0,292,6764,0,0;QS=3,0;MQSB=0.0497871;MQ0F=0 PL:DP:DV 0,27,220:9:0 0,6,53:2:0 0,12,106:4:0 +X 241 . G <*> 0 . DP=15;I16=9,5,0,0,444,14636,0,0,716,39364,0,0,269,6159,0,0;QS=3,0;MQSB=0.0561348;MQ0F=0 PL:DP:DV 0,27,203:9:0 0,6,53:2:0 0,9,59:3:0 +X 242 . C <*> 0 . DP=15;I16=10,5,0,0,555,21177,0,0,776,42964,0,0,292,6624,0,0;QS=3,0;MQSB=0.0497871;MQ0F=0 PL:DP:DV 0,27,242:9:0 0,6,53:2:0 0,12,94:4:0 +X 243 . C <*> 0 . DP=16;I16=9,5,0,0,523,19737,0,0,716,39364,0,0,284,6508,0,0;QS=3,0;MQSB=0.0561348;MQ0F=0 PL:DP:DV 0,24,220:8:0 0,6,53:2:0 0,12,104:4:0 +X 244 . C <*> 0 . DP=16;I16=10,6,0,0,620,24272,0,0,805,43805,0,0,298,6568,0,0;QS=3,0;MQSB=0.0253122;MQ0F=0 PL:DP:DV 0,27,245:9:0 0,9,72:3:0 0,12,106:4:0 +X 245 . A <*> 0 . DP=17;I16=10,7,0,0,649,24843,0,0,865,47405,0,0,299,6553,0,0;QS=3,0;MQSB=0.0509867;MQ0F=0 PL:DP:DV 0,27,236:9:0 0,12,93:4:0 0,12,115:4:0 +X 246 . T <*> 0 . DP=18;I16=10,8,0,0,649,23833,0,0,894,48246,0,0,301,6553,0,0;QS=3,0;MQSB=0.0286491;MQ0F=0 PL:DP:DV 0,30,247:10:0 0,12,94:4:0 0,12,98:4:0 +X 247 . G <*> 0 . DP=18;I16=10,8,0,0,642,23610,0,0,894,48246,0,0,304,6570,0,0;QS=3,0;MQSB=0.0286491;MQ0F=0 PL:DP:DV 0,30,252:10:0 0,12,83:4:0 0,12,103:4:0 +X 248 . T <*> 0 . DP=18;I16=10,8,0,0,636,22944,0,0,894,48246,0,0,307,6605,0,0;QS=3,0;MQSB=0.0286491;MQ0F=0 PL:DP:DV 0,30,234:10:0 0,12,86:4:0 0,12,114:4:0 +X 249 . C <*> 0 . DP=18;I16=10,8,0,0,656,24846,0,0,894,48246,0,0,310,6658,0,0;QS=3,0;MQSB=0.0286491;MQ0F=0 PL:DP:DV 0,30,253:10:0 0,12,79:4:0 0,12,112:4:0 +X 250 . C <*> 0 . DP=19;I16=10,9,0,0,694,26160,0,0,923,49087,0,0,311,6631,0,0;QS=3,0;MQSB=0.0168512;MQ0F=0 PL:DP:DV 0,30,248:10:0 0,12,89:4:0 0,15,142:5:0 +X 251 . A <*> 0 . DP=19;I16=9,9,0,0,688,26506,0,0,863,45487,0,0,313,6627,0,0;QS=3,0;MQSB=0.0208913;MQ0F=0 PL:DP:DV 0,27,233:9:0 0,12,97:4:0 0,15,148:5:0 +X 252 . G <*> 0 . DP=18;I16=8,9,0,0,641,24631,0,0,803,41887,0,0,304,6502,0,0;QS=3,0;MQSB=0.026526;MQ0F=0 PL:DP:DV 0,27,243:9:0 0,12,91:4:0 0,12,121:4:0 +X 253 . C <*> 0 . DP=19;I16=9,10,0,0,705,26921,0,0,892,46328,0,0,319,6687,0,0;QS=3,0;MQSB=0.0132999;MQ0F=0 PL:DP:DV 0,27,247:9:0 0,12,86:4:0 0,18,155:6:0 +X 254 . T <*> 0 . DP=20;I16=10,9,0,0,719,27517,0,0,892,46328,0,0,314,6670,0,0;QS=3,0;MQSB=0.00482795;MQ0F=0 PL:DP:DV 0,30,254:10:0 0,9,72:3:0 0,18,164:6:0 +X 255 . T <*> 0 . DP=21;I16=11,10,0,0,750,27076,0,0,1012,53528,0,0,328,6840,0,0;QS=3,0;MQSB=0.00822975;MQ0F=0 PL:DP:DV 0,33,241:11:0 0,12,95:4:0 0,18,161:6:0 +X 256 . A <*> 0 . DP=22;I16=11,11,0,0,811,30063,0,0,1049,54897,0,0,334,6956,0,0;QS=3,0;MQSB=0.00507916;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,110:5:0 0,18,166:6:0 +X 257 . T <*> 0 . DP=22;I16=11,11,0,0,814,30420,0,0,1049,54897,0,0,341,7101,0,0;QS=3,0;MQSB=0.00507916;MQ0F=0 PL:DP:DV 0,33,247:11:0 0,15,113:5:0 0,18,168:6:0 +X 258 . T <*> 0 . DP=22;I16=11,11,0,0,791,28943,0,0,1049,54897,0,0,347,7225,0,0;QS=3,0;MQSB=0.00507916;MQ0F=0 PL:DP:DV 0,33,254:11:0 0,15,116:5:0 0,18,155:6:0 +X 259 . C <*> 0 . DP=22;I16=11,10,0,0,785,29809,0,0,1020,54056,0,0,332,6936,0,0;QS=3,0;MQSB=0.00822975;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,90:4:0 0,18,170:6:0 +X 260 . T <*> 0 . DP=21;I16=10,11,0,0,829,32899,0,0,989,51297,0,0,360,7556,0,0;QS=3,0;MQSB=0.00660016;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,118:5:0 0,15,156:5:0 +X 261 . G <*> 0 . DP=21;I16=10,11,0,0,735,27379,0,0,989,51297,0,0,367,7761,0,0;QS=3,0;MQSB=0.00660016;MQ0F=0 PL:DP:DV 0,33,254:11:0 0,15,111:5:0 0,15,122:5:0 +X 262 . C <*> 0 . DP=22;I16=10,12,0,0,806,30278,0,0,1049,54897,0,0,373,7941,0,0;QS=3,0;MQSB=0.0122507;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,99:5:0 0,18,164:6:0 +X 263 . C <*> 0 . DP=22;I16=10,12,0,0,799,29717,0,0,1049,54897,0,0,380,8146,0,0;QS=3,0;MQSB=0.0122507;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,98:5:0 0,18,168:6:0 +X 264 . C <*> 0 . DP=22;I16=10,12,0,0,821,31325,0,0,1049,54897,0,0,386,8326,0,0;QS=3,0;MQSB=0.0122507;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,104:5:0 0,18,172:6:0 +X 265 . A <*> 0 . DP=21;I16=9,12,0,0,800,31906,0,0,989,51297,0,0,390,8380,0,0;QS=3,0;MQSB=0.0158903;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,114:5:0 0,15,129:5:0 +X 266 . G <*> 0 . DP=21;I16=9,11,0,0,747,28155,0,0,960,50456,0,0,369,7833,0,0;QS=3,0;MQSB=0.0237479;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,97:4:0 0,15,138:5:0 +X 267 . T <*> 0 . DP=21;I16=9,11,0,0,739,27465,0,0,960,50456,0,0,373,7935,0,0;QS=3,0;MQSB=0.0237479;MQ0F=0 PL:DP:DV 0,33,254:11:0 0,12,101:4:0 0,15,149:5:0 +X 268 . T <*> 0 . DP=21;I16=9,12,0,0,748,27708,0,0,989,51297,0,0,402,8686,0,0;QS=3,0;MQSB=0.0158903;MQ0F=0 PL:DP:DV 0,33,238:11:0 0,15,110:5:0 0,15,156:5:0 +X 269 . C <*> 0 . DP=22;I16=9,12,0,0,764,28632,0,0,989,51297,0,0,381,8211,0,0;QS=3,0;MQSB=0.0158903;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,91:4:0 0,15,154:5:0 +X 270 . C <*> 0 . DP=22;I16=9,12,0,0,758,28146,0,0,989,51297,0,0,385,8337,0,0;QS=3,0;MQSB=0.0158903;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,96:4:0 0,15,143:5:0 +X 271 . T <*> 0 . DP=22;I16=9,13,0,0,847,32935,0,0,1018,52138,0,0,413,9065,0,0;QS=3,0;MQSB=0.0109431;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,113:5:0 0,15,152:5:0 +X 272 . C <*> 0 . DP=22;I16=9,12,0,0,809,31413,0,0,989,51297,0,0,390,8518,0,0;QS=3,0;MQSB=0.0158903;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,96:4:0 0,15,149:5:0 +X 273 . T <*> 0 . DP=22;I16=9,12,0,0,798,30664,0,0,989,51297,0,0,392,8620,0,0;QS=3,0;MQSB=0.0158903;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,95:4:0 0,15,161:5:0 +X 274 . C <*> 0 . DP=22;I16=9,12,0,0,763,28177,0,0,989,51297,0,0,394,8746,0,0;QS=3,0;MQSB=0.0158903;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,101:4:0 0,15,144:5:0 +X 275 . C <*> 0 . DP=20;I16=7,13,0,0,768,29994,0,0,898,44938,0,0,423,9519,0,0;QS=3,0;MQSB=0.0213617;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,114:5:0 0,12,122:4:0 +X 276 . A <*> 0 . DP=20;I16=7,13,0,0,805,32931,0,0,898,44938,0,0,424,9538,0,0;QS=3,0;MQSB=0.0213617;MQ0F=0 PL:DP:DV 0,33,253:11:0 0,15,122:5:0 0,12,124:4:0 +X 277 . G <*> 0 . DP=20;I16=7,13,0,0,764,29732,0,0,898,44938,0,0,425,9579,0,0;QS=3,0;MQSB=0.0213617;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,114:5:0 0,12,121:4:0 +X 278 . A <*> 0 . DP=21;I16=6,14,0,0,722,26452,0,0,867,42179,0,0,415,9521,0,0;QS=3,0;MQSB=0.0246228;MQ0F=0 PL:DP:DV 0,30,238:10:0 0,18,123:6:0 0,12,121:4:0 +X 279 . A <*> 0 . DP=22;I16=7,15,0,0,786,28694,0,0,956,46620,0,0,427,9677,0,0;QS=3,0;MQSB=0.0124927;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,123:6:0 0,12,122:4:0 +X 280 . A <*> 0 . DP=22;I16=7,15,0,0,815,31561,0,0,956,46620,0,0,428,9684,0,0;QS=3,0;MQSB=0.0124927;MQ0F=0 PL:DP:DV 0,36,253:12:0 0,18,130:6:0 0,12,129:4:0 +X 281 . G <*> 0 . DP=22;I16=7,15,0,0,820,31416,0,0,956,46620,0,0,428,9662,0,0;QS=3,0;MQSB=0.0124927;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,122:6:0 0,12,123:4:0 +X 282 . G <*> 0 . DP=22;I16=7,15,0,0,806,30420,0,0,956,46620,0,0,427,9609,0,0;QS=3,0;MQSB=0.0124927;MQ0F=0 PL:DP:DV 0,36,253:12:0 0,18,124:6:0 0,12,119:4:0 +X 283 . C <*> 0 . DP=23;I16=7,15,0,0,827,31785,0,0,956,46620,0,0,426,9574,0,0;QS=3,0;MQSB=0.0124927;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,125:6:0 0,12,122:4:0 +X 284 . T <*> 0 . DP=23;I16=7,16,0,0,901,35479,0,0,1016,50220,0,0,431,9593,0,0;QS=3,0;MQSB=0.0194969;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,126:6:0 0,15,144:5:0 +X 285 . G <*> 0 . DP=23;I16=7,16,0,0,860,32856,0,0,1016,50220,0,0,431,9607,0,0;QS=3,0;MQSB=0.0194969;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,119:6:0 0,15,132:5:0 +X 286 . C <*> 0 . DP=24;I16=8,16,0,0,875,32883,0,0,1076,53820,0,0,431,9641,0,0;QS=3,0;MQSB=0.0132999;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,150:7:0 0,15,134:5:0 +X 287 . A <*> 0 . DP=25;I16=9,16,0,0,895,32957,0,0,1136,57420,0,0,432,9696,0,0;QS=3,0;MQSB=0.00934348;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,178:8:0 0,15,133:5:0 +X 288 . T <*> 0 . DP=25;I16=9,16,0,0,931,35011,0,0,1136,57420,0,0,432,9674,0,0;QS=3,0;MQSB=0.00934348;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,184:8:0 0,15,146:5:0 +X 289 . G <*> 0 . DP=25;I16=9,16,0,0,939,36117,0,0,1136,57420,0,0,432,9676,0,0;QS=3,0;MQSB=0.00934348;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,185:8:0 0,15,136:5:0 +X 290 . G <*> 0 . DP=23;I16=8,15,0,0,805,29157,0,0,1047,52979,0,0,433,9651,0,0;QS=3,0;MQSB=0.0177152;MQ0F=0 PL:DP:DV 0,33,240:11:0 0,21,164:7:0 0,15,126:5:0 +X 291 . T <*> 0 . DP=24;I16=8,15,0,0,840,31616,0,0,1047,52979,0,0,421,9479,0,0;QS=3,0;MQSB=0.0177152;MQ0F=0 PL:DP:DV 0,33,244:11:0 0,21,168:7:0 0,15,136:5:0 +X 292 . T <*> 0 . DP=25;I16=9,16,0,0,888,32274,0,0,1167,60179,0,0,436,9668,0,0;QS=3,0;MQSB=0.0197089;MQ0F=0 PL:DP:DV 0,33,253:11:0 0,24,181:8:0 0,18,156:6:0 +X 293 . G <*> 0 . DP=26;I16=10,15,0,0,934,35232,0,0,1167,60179,0,0,424,9488,0,0;QS=3,0;MQSB=0.0095249;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,196:8:0 0,15,145:5:0 +X 294 . A <*> 0 . DP=26;I16=10,16,0,0,931,33937,0,0,1227,63779,0,0,443,9785,0,0;QS=3,0;MQSB=0.0149748;MQ0F=0 PL:DP:DV 0,36,252:12:0 0,24,201:8:0 0,18,161:6:0 +X 295 . C <*> 0 . DP=25;I16=10,14,0,0,897,33973,0,0,1169,62097,0,0,430,9544,0,0;QS=3,0;MQSB=0.0310726;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,180:7:0 0,18,159:6:0 +X 296 . A <*> 0 . DP=25;I16=10,15,0,0,874,31846,0,0,1198,62938,0,0,451,9905,0,0;QS=3,0;MQSB=0.0213617;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,169:8:0 0,18,169:6:0 +X 297 . C <*> 0 . DP=25;I16=9,15,0,0,901,34305,0,0,1138,59338,0,0,445,9901,0,0;QS=3,0;MQSB=0.0273237;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,174:7:0 0,18,161:6:0 +X 298 . A <*> 0 . DP=26;I16=11,15,0,0,936,34652,0,0,1258,66538,0,0,459,10121,0,0;QS=3,0;MQSB=0.017008;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,184:8:0 0,21,191:7:0 +X 299 . C <*> 0 . DP=27;I16=11,15,0,0,971,36863,0,0,1258,66538,0,0,464,10266,0,0;QS=3,0;MQSB=0.017008;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,193:8:0 0,21,189:7:0 +X 300 . A <*> 0 . DP=27;I16=11,15,0,0,1001,39455,0,0,1258,66538,0,0,469,10437,0,0;QS=3,0;MQSB=0.017008;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,204:8:0 0,21,210:7:0 +X 301 . G <*> 0 . DP=25;I16=10,14,0,0,928,36116,0,0,1169,62097,0,0,476,10632,0,0;QS=3,0;MQSB=0.0310726;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,195:7:0 0,21,196:7:0 +X 302 . T <*> 0 . DP=25;I16=10,14,0,0,879,32885,0,0,1169,62097,0,0,483,10849,0,0;QS=3,0;MQSB=0.0310726;MQ0F=0 PL:DP:DV 0,30,231:10:0 0,21,172:7:0 0,21,202:7:0 +X 302 . T TA 0 . INDEL;IDV=7;IMF=1;DP=25;I16=2,4,8,11,214,7674,793,33369,236,10564,993,55133,109,2229,377,8629;QS=0.511212,2.48879;VDB=0.27613;SGB=-4.22417;MQSB=0.0443614;MQ0F=0 PL:DP:DV 167,0,96:11:6 157,0,9:7:6 201,21,0:7:7 +X 303 . G <*> 0 . DP=25;I16=10,15,0,0,976,38516,0,0,1229,65697,0,0,497,11181,0,0;QS=3,0;MQSB=0.0443614;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,197:7:0 0,21,195:7:0 +X 304 . C <*> 0 . DP=27;I16=11,16,0,0,991,37005,0,0,1318,70138,0,0,503,11359,0,0;QS=3,0;MQSB=0.129164;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,206:8:0 0,24,200:8:0 +X 305 . C <*> 0 . DP=27;I16=11,16,0,0,1057,41761,0,0,1318,70138,0,0,510,11508,0,0;QS=3,0;MQSB=0.129164;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,213:8:0 0,24,211:8:0 +X 306 . T <*> 0 . DP=27;I16=11,16,0,0,1033,40253,0,0,1318,70138,0,0,517,11679,0,0;QS=3,0;MQSB=0.129164;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,207:8:0 0,24,217:8:0 +X 307 . G <*> 0 . DP=27;I16=11,15,0,0,984,37886,0,0,1289,69297,0,0,498,11198,0,0;QS=3,0;MQSB=0.174566;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,189:7:0 0,24,203:8:0 +X 308 . C <*> 0 . DP=27;I16=11,16,0,0,892,30810,0,0,1318,70138,0,0,529,11991,0,0;QS=3,0;MQSB=0.129164;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,178:8:0 0,24,185:8:0 +X 309 . G <*> 0 . DP=27;I16=11,16,0,0,951,34599,0,0,1318,70138,0,0,535,12183,0,0;QS=3,0;MQSB=0.129164;MQ0F=0 PL:DP:DV 0,33,243:11:0 0,24,183:8:0 0,24,205:8:0 +X 310 . A <*> 0 . DP=27;I16=11,16,0,0,1001,38063,0,0,1318,70138,0,0,540,12350,0,0;QS=3,0;MQSB=0.129164;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,200:8:0 0,24,217:8:0 +X 311 . C <*> 0 . DP=27;I16=11,16,0,0,1037,40263,0,0,1318,70138,0,0,544,12492,0,0;QS=3,0;MQSB=0.129164;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,215:8:0 0,24,210:8:0 +X 312 . A <*> 0 . DP=26;I16=10,16,0,0,985,38043,0,0,1258,66538,0,0,549,12657,0,0;QS=3,0;MQSB=0.157183;MQ0F=0 PL:DP:DV 0,30,237:10:0 0,24,215:8:0 0,24,218:8:0 +X 313 . A <*> 0 . DP=26;I16=10,16,0,0,983,37969,0,0,1258,66538,0,0,551,12695,0,0;QS=3,0;MQSB=0.157183;MQ0F=0 PL:DP:DV 0,30,235:10:0 0,24,219:8:0 0,24,215:8:0 +X 314 . A <*> 0 . DP=27;I16=10,17,0,0,1050,41798,0,0,1318,70138,0,0,553,12757,0,0;QS=3,0;MQSB=0.195223;MQ0F=0 PL:DP:DV 0,33,250:11:0 0,24,217:8:0 0,24,227:8:0 +X 315 . G <*> 0 . DP=26;I16=10,16,0,0,1025,40941,0,0,1289,69297,0,0,557,12843,0,0;QS=3,0;MQSB=0.252051;MQ0F=0 PL:DP:DV 0,30,252:10:0 0,24,216:8:0 0,24,225:8:0 +X 316 . C <*> 0 . DP=27;I16=10,15,0,0,983,39393,0,0,1252,67928,0,0,535,12277,0,0;QS=3,0;MQSB=0.312403;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,183:7:0 0,24,224:8:0 +X 317 . T <*> 0 . DP=27;I16=10,16,0,0,1028,41392,0,0,1320,72056,0,0,547,12557,0,0;QS=3,0;MQSB=0.377061;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,24,230:8:0 0,24,206:8:0 +X 318 . G <*> 0 . DP=27;I16=10,17,0,0,1038,40546,0,0,1349,72897,0,0,570,13018,0,0;QS=3,0;MQSB=0.297797;MQ0F=0 PL:DP:DV 0,30,249:10:0 0,27,235:9:0 0,24,208:8:0 +X 319 . A <*> 0 . DP=27;I16=9,17,0,0,994,38654,0,0,1289,69297,0,0,560,12906,0,0;QS=3,0;MQSB=0.346864;MQ0F=0 PL:DP:DV 0,30,249:10:0 0,27,228:9:0 0,21,185:7:0 +X 320 . A <*> 0 . DP=27;I16=10,17,0,0,1022,39418,0,0,1349,72897,0,0,573,13053,0,0;QS=3,0;MQSB=0.297797;MQ0F=0 PL:DP:DV 0,30,247:10:0 0,27,230:9:0 0,24,211:8:0 +X 321 . T <*> 0 . DP=27;I16=10,17,0,0,1026,39772,0,0,1349,72897,0,0,573,13029,0,0;QS=3,0;MQSB=0.297797;MQ0F=0 PL:DP:DV 0,30,253:10:0 0,27,214:9:0 0,24,218:8:0 +X 322 . G <*> 0 . DP=28;I16=10,18,0,0,1091,43151,0,0,1409,76497,0,0,573,13029,0,0;QS=3,0;MQSB=0.343265;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,27,226:9:0 0,27,223:9:0 +X 323 . C <*> 0 . DP=28;I16=9,18,0,0,1067,42619,0,0,1349,72897,0,0,565,12939,0,0;QS=3,0;MQSB=0.394987;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,27,225:9:0 0,24,198:8:0 +X 324 . T <*> 0 . DP=30;I16=12,18,0,0,1145,44221,0,0,1529,83697,0,0,573,13001,0,0;QS=3,0;MQSB=0.264959;MQ0F=0 PL:DP:DV 0,30,253:10:0 0,27,237:9:0 0,33,255:11:0 +X 325 . A <*> 0 . DP=31;I16=13,18,0,0,1132,42058,0,0,1589,87297,0,0,573,12925,0,0;QS=3,0;MQSB=0.235201;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,208:9:0 0,33,255:11:0 +X 326 . T <*> 0 . DP=31;I16=13,18,0,0,1157,44193,0,0,1589,87297,0,0,574,12878,0,0;QS=3,0;MQSB=0.235201;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,216:9:0 0,33,255:11:0 +X 327 . C <*> 0 . DP=31;I16=13,18,0,0,1147,43895,0,0,1589,87297,0,0,575,12861,0,0;QS=3,0;MQSB=0.235201;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,198:9:0 0,33,255:11:0 +X 328 . A <*> 0 . DP=31;I16=13,18,0,0,1167,44531,0,0,1589,87297,0,0,574,12776,0,0;QS=3,0;MQSB=0.235201;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,226:9:0 0,33,255:11:0 +X 329 . T <*> 0 . DP=31;I16=13,18,0,0,1210,47742,0,0,1589,87297,0,0,572,12676,0,0;QS=3,0;MQSB=0.235201;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,237:9:0 0,33,255:11:0 +X 330 . T <*> 0 . DP=31;I16=13,18,0,0,1185,45839,0,0,1589,87297,0,0,568,12510,0,0;QS=3,0;MQSB=0.235201;MQ0F=0 PL:DP:DV 0,33,254:11:0 0,27,231:9:0 0,33,255:11:0 +X 331 . T <*> 0 . DP=32;I16=14,18,0,0,1154,42510,0,0,1649,90897,0,0,563,12327,0,0;QS=3,0;MQSB=0.210122;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,222:9:0 0,36,255:12:0 +X 332 . A <*> 0 . DP=32;I16=14,18,0,0,1156,42666,0,0,1649,90897,0,0,560,12178,0,0;QS=3,0;MQSB=0.210122;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,214:9:0 0,33,255:11:0 +X 333 . A <*> 0 . DP=32;I16=14,18,0,0,1141,41987,0,0,1649,90897,0,0,558,12064,0,0;QS=3,0;MQSB=0.210122;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,223:9:0 0,33,255:11:0 +X 334 . A <*> 0 . DP=32;I16=14,18,0,0,1162,43328,0,0,1649,90897,0,0,556,11986,0,0;QS=3,0;MQSB=0.210122;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,221:9:0 0,33,255:11:0 +X 335 . A <*> 0 . DP=32;I16=12,18,0,0,1077,40287,0,0,1529,83697,0,0,552,11934,0,0;QS=3,0;MQSB=0.264959;MQ0F=0 PL:DP:DV 0,30,250:10:0 0,27,219:9:0 0,33,251:11:0 +X 336 . A <*> 0 . DP=32;I16=14,17,0,0,1088,39758,0,0,1612,89528,0,0,536,11574,0,0;QS=3,0;MQSB=0.274662;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,211:8:0 0,36,255:12:0 +X 337 . C <*> 0 . DP=32;I16=13,17,0,0,1115,42381,0,0,1552,85928,0,0,531,11565,0,0;QS=3,0;MQSB=0.301511;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,24,202:8:0 0,36,255:12:0 +X 338 . T <*> 0 . DP=30;I16=14,16,0,0,1191,47979,0,0,1560,86456,0,0,554,11878,0,0;QS=3,0;MQSB=0.242376;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,24,226:8:0 0,36,255:12:0 +X 339 . C <*> 0 . DP=31;I16=14,17,0,0,1130,43210,0,0,1589,87297,0,0,554,11874,0,0;QS=3,0;MQSB=0.175471;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,185:8:0 0,36,255:12:0 +X 340 . C <*> 0 . DP=31;I16=14,17,0,0,1196,47044,0,0,1589,87297,0,0,554,11852,0,0;QS=3,0;MQSB=0.175471;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,221:8:0 0,36,255:12:0 +X 341 . T <*> 0 . DP=31;I16=14,17,0,0,1227,48995,0,0,1589,87297,0,0,554,11862,0,0;QS=3,0;MQSB=0.175471;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,216:8:0 0,36,255:12:0 +X 342 . T <*> 0 . DP=31;I16=14,17,0,0,1162,43942,0,0,1589,87297,0,0,554,11904,0,0;QS=3,0;MQSB=0.175471;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,210:8:0 0,36,255:12:0 +X 343 . G <*> 0 . DP=32;I16=14,17,0,0,1150,43702,0,0,1620,90056,0,0,550,11962,0,0;QS=3,0;MQSB=0.283511;MQ0F=0 PL:DP:DV 0,30,249:10:0 0,27,218:9:0 0,36,255:12:0 +X 344 . C <*> 0 . DP=32;I16=14,18,0,0,1181,45169,0,0,1649,90897,0,0,554,12036,0,0;QS=3,0;MQSB=0.210122;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,217:9:0 0,36,255:12:0 +X 345 . T <*> 0 . DP=31;I16=14,17,0,0,1205,47259,0,0,1589,87297,0,0,555,12129,0,0;QS=3,0;MQSB=0.175471;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,221:8:0 0,36,255:12:0 +X 346 . G <*> 0 . DP=31;I16=15,16,0,0,1147,43597,0,0,1620,90056,0,0,557,12255,0,0;QS=3,0;MQSB=0.220358;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,212:8:0 0,36,255:12:0 +X 347 . G <*> 0 . DP=31;I16=14,16,0,0,1119,42227,0,0,1560,86456,0,0,545,12189,0,0;QS=3,0;MQSB=0.242376;MQ0F=0 PL:DP:DV 0,30,251:10:0 0,24,207:8:0 0,36,255:12:0 +X 348 . T <*> 0 . DP=32;I16=15,16,0,0,1145,43007,0,0,1620,90056,0,0,546,12300,0,0;QS=3,0;MQSB=0.220358;MQ0F=0 PL:DP:DV 0,30,243:10:0 0,27,228:9:0 0,36,255:12:0 +X 349 . T <*> 0 . DP=32;I16=16,16,0,0,1194,45350,0,0,1680,93656,0,0,565,12731,0,0;QS=3,0;MQSB=0.201402;MQ0F=0 PL:DP:DV 0,33,246:11:0 0,27,230:9:0 0,36,255:12:0 +X 350 . T <*> 0 . DP=31;I16=16,15,0,0,1142,43072,0,0,1651,92815,0,0,567,12837,0,0;QS=3,0;MQSB=0.286505;MQ0F=0 PL:DP:DV 0,33,249:11:0 0,27,230:9:0 0,33,255:11:0 +X 351 . G <*> 0 . DP=31;I16=16,15,0,0,1146,43750,0,0,1651,92815,0,0,568,12920,0,0;QS=3,0;MQSB=0.286505;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,212:9:0 0,33,255:11:0 +X 352 . A <*> 0 . DP=31;I16=16,14,0,0,1150,45520,0,0,1591,89215,0,0,544,12404,0,0;QS=3,0;MQSB=0.242376;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,224:8:0 0,33,255:11:0 +X 353 . G <*> 0 . DP=29;I16=15,14,0,0,1109,43095,0,0,1562,88374,0,0,570,13064,0,0;QS=3,0;MQSB=0.424373;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,27,231:9:0 0,30,255:10:0 +X 354 . A <*> 0 . DP=28;I16=14,14,0,0,1078,42938,0,0,1502,84774,0,0,571,13075,0,0;QS=3,0;MQSB=0.450096;MQ0F=0 PL:DP:DV 0,27,225:9:0 0,27,244:9:0 0,30,255:10:0 +X 355 . G T,<*> 0 . DP=28;I16=14,13,0,1,1001,37907,41,1681,1442,81174,60,3600,547,12487,25,625;QS=2.875,0.125,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.450096;BQB=1;MQ0F=0 PL:DP:DV 14,0,200,38,203,231:9:1 0,27,222,27,222,222:9:0 0,30,255,30,255,255:10:0 +X 356 . G <*> 0 . DP=27;I16=14,13,0,0,993,37481,0,0,1465,83405,0,0,574,13174,0,0;QS=3,0;MQSB=0.580277;MQ0F=0 PL:DP:DV 0,27,228:9:0 0,24,201:8:0 0,30,255:10:0 +X 357 . C <*> 0 . DP=28;I16=14,13,0,0,1021,39471,0,0,1465,83405,0,0,550,12584,0,0;QS=3,0;MQSB=0.580277;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,24,205:8:0 0,27,251:9:0 +X 358 . A <*> 0 . DP=28;I16=15,13,0,0,1050,40518,0,0,1525,87005,0,0,576,13216,0,0;QS=3,0;MQSB=0.556581;MQ0F=0 PL:DP:DV 0,30,254:10:0 0,24,197:8:0 0,30,255:10:0 +X 359 . G <*> 0 . DP=29;I16=15,13,0,0,1085,42761,0,0,1525,87005,0,0,552,12620,0,0;QS=3,0;MQSB=0.556581;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,187:7:0 0,33,255:11:0 +X 360 . A <*> 0 . DP=29;I16=15,14,0,0,1111,43259,0,0,1585,90605,0,0,579,13297,0,0;QS=3,0;MQSB=0.604224;MQ0F=0 PL:DP:DV 0,30,252:10:0 0,24,220:8:0 0,33,255:11:0 +X 361 . A <*> 0 . DP=29;I16=15,14,0,0,1116,43442,0,0,1585,90605,0,0,579,13273,0,0;QS=3,0;MQSB=0.604224;MQ0F=0 PL:DP:DV 0,30,252:10:0 0,24,219:8:0 0,33,255:11:0 +X 362 . A <*> 0 . DP=29;I16=16,13,0,0,1104,42700,0,0,1585,90605,0,0,580,13272,0,0;QS=3,0;MQSB=0.535133;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,218:8:0 0,30,255:10:0 +X 363 . A <*> 0 . DP=29;I16=16,13,0,0,1087,41437,0,0,1585,90605,0,0,581,13245,0,0;QS=3,0;MQSB=0.535133;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,213:8:0 0,30,255:10:0 +X 364 . T <*> 0 . DP=29;I16=16,13,0,0,1032,37960,0,0,1585,90605,0,0,582,13244,0,0;QS=3,0;MQSB=0.535133;MQ0F=0 PL:DP:DV 0,33,250:11:0 0,24,205:8:0 0,30,255:10:0 +X 365 . G <*> 0 . DP=29;I16=16,13,0,0,1105,43079,0,0,1585,90605,0,0,582,13218,0,0;QS=3,0;MQSB=0.535133;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,211:8:0 0,30,255:10:0 +X 366 . A <*> 0 . DP=29;I16=16,13,0,0,1090,41562,0,0,1585,90605,0,0,581,13167,0,0;QS=3,0;MQSB=0.535133;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,211:8:0 0,30,255:10:0 +X 367 . T <*> 0 . DP=29;I16=16,13,0,0,1055,39149,0,0,1585,90605,0,0,579,13093,0,0;QS=3,0;MQSB=0.535133;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,204:8:0 0,30,255:10:0 +X 368 . A <*> 0 . DP=29;I16=16,13,0,0,1054,39632,0,0,1585,90605,0,0,576,12998,0,0;QS=3,0;MQSB=0.535133;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,208:8:0 0,30,255:10:0 +X 369 . T <*> 0 . DP=28;I16=16,11,0,0,1037,40275,0,0,1496,86164,0,0,548,12256,0,0;QS=3,0;MQSB=0.659218;MQ0F=0 PL:DP:DV 0,30,250:10:0 0,21,196:7:0 0,30,255:10:0 +X 370 . C <*> 0 . DP=28;I16=16,12,0,0,1045,40219,0,0,1556,89764,0,0,570,12790,0,0;QS=3,0;MQSB=0.705296;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,24,201:8:0 0,30,255:10:0 +X 371 . T <*> 0 . DP=29;I16=16,13,0,0,1155,46591,0,0,1616,93364,0,0,567,12725,0,0;QS=3,0;MQSB=0.744925;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,24,227:8:0 0,33,255:11:0 +X 372 . C <*> 0 . DP=30;I16=16,14,0,0,1139,44019,0,0,1676,96964,0,0,564,12636,0,0;QS=3,0;MQSB=0.779025;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,215:8:0 0,33,255:11:0 +X 373 . A <*> 0 . DP=30;I16=16,14,0,0,1142,44118,0,0,1676,96964,0,0,561,12525,0,0;QS=3,0;MQSB=0.779025;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,220:8:0 0,33,255:11:0 +X 374 . T <*> 0 . DP=30;I16=16,14,0,0,1098,41180,0,0,1676,96964,0,0,556,12344,0,0;QS=3,0;MQSB=0.779025;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,221:8:0 0,33,255:11:0 +X 375 . A T,<*> 0 . DP=31;I16=17,13,0,1,1138,43798,14,196,1676,96964,60,3600,547,12177,4,16;QS=2.9661,0.0338983,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.763662;BQB=1;MQ0F=0 PL:DP:DV 0,36,255,36,255,255:12:0 0,24,218,24,218,218:8:0 0,18,255,30,255,255:11:1 +X 376 . G <*> 0 . DP=31;I16=17,14,0,0,1131,42581,0,0,1736,100564,0,0,547,12073,0,0;QS=3,0;MQSB=0.763662;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,220:8:0 0,33,255:11:0 +X 377 . T <*> 0 . DP=31;I16=16,14,0,0,1105,41629,0,0,1676,96964,0,0,518,11360,0,0;QS=3,0;MQSB=0.779025;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,211:8:0 0,33,255:11:0 +X 378 . T <*> 0 . DP=30;I16=18,12,0,0,1098,41066,0,0,1707,99723,0,0,541,11927,0,0;QS=3,0;MQSB=0.878946;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,186:7:0 0,30,255:10:0 +X 379 . G <*> 0 . DP=29;I16=18,10,0,0,1053,40181,0,0,1618,95282,0,0,534,11848,0,0;QS=3,0;MQSB=0.981777;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,187:7:0 0,30,255:10:0 +X 380 . C <*> 0 . DP=29;I16=18,10,0,0,1087,42743,0,0,1618,95282,0,0,514,11172,0,0;QS=3,0;MQSB=0.981777;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,177:6:0 0,30,255:10:0 +X 381 . T <*> 0 . DP=29;I16=18,11,0,0,1168,47412,0,0,1678,98882,0,0,537,11729,0,0;QS=3,0;MQSB=0.987702;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,212:7:0 0,30,255:10:0 +X 382 . T <*> 0 . DP=29;I16=17,11,0,0,1054,40450,0,0,1618,95282,0,0,510,11068,0,0;QS=3,0;MQSB=0.990092;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,182:7:0 0,30,255:10:0 +X 383 . T <*> 0 . DP=29;I16=18,10,0,0,1052,39798,0,0,1618,95282,0,0,507,11013,0,0;QS=3,0;MQSB=0.981777;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,165:6:0 0,30,255:10:0 +X 384 . A <*> 0 . DP=31;I16=19,11,0,0,1077,39885,0,0,1738,102482,0,0,504,10988,0,0;QS=3,0;MQSB=0.985292;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,176:7:0 0,30,255:10:0 +X 385 . C <*> 0 . DP=31;I16=19,12,0,0,1118,41180,0,0,1798,106082,0,0,527,11569,0,0;QS=3,0;MQSB=0.989977;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,24,186:8:0 0,30,255:10:0 +X 386 . T <*> 0 . DP=30;I16=18,12,0,0,1158,45592,0,0,1738,102482,0,0,526,11556,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,191:7:0 0,30,255:10:0 +X 387 . T <*> 0 . DP=30;I16=18,12,0,0,1105,41821,0,0,1738,102482,0,0,525,11573,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,187:7:0 0,30,255:10:0 +X 388 . T <*> 0 . DP=29;I16=17,12,0,0,1089,41577,0,0,1678,98882,0,0,523,11519,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,180:6:0 0,30,255:10:0 +X 389 . G <*> 0 . DP=29;I16=17,12,0,0,1067,40095,0,0,1678,98882,0,0,520,11444,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,171:6:0 0,30,255:10:0 +X 390 . C <*> 0 . DP=29;I16=17,12,0,0,1071,40423,0,0,1678,98882,0,0,517,11399,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,162:6:0 0,30,255:10:0 +X 391 . A <*> 0 . DP=29;I16=18,11,0,0,1091,41603,0,0,1647,96123,0,0,515,11383,0,0;QS=3,0;MQSB=0.995968;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,163:6:0 0,30,255:10:0 +X 392 . T <*> 0 . DP=29;I16=18,11,0,0,1046,38838,0,0,1647,96123,0,0,515,11395,0,0;QS=3,0;MQSB=0.995968;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,153:5:0 0,33,255:11:0 +X 393 . A <*> 0 . DP=28;I16=17,11,0,0,1014,37582,0,0,1587,92523,0,0,517,11435,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,133:5:0 0,33,255:11:0 +X 394 . T <*> 0 . DP=28;I16=17,11,0,0,1022,38342,0,0,1587,92523,0,0,519,11503,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,141:5:0 0,33,255:11:0 +X 395 . T <*> 0 . DP=28;I16=17,11,0,0,1060,40596,0,0,1587,92523,0,0,521,11599,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,164:5:0 0,33,255:11:0 +X 396 . T <*> 0 . DP=28;I16=17,11,0,0,1032,39228,0,0,1587,92523,0,0,523,11723,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,158:5:0 0,33,255:11:0 +X 397 . T <*> 0 . DP=28;I16=17,11,0,0,1046,39510,0,0,1587,92523,0,0,524,11824,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,149:5:0 0,33,255:11:0 +X 398 . A <*> 0 . DP=28;I16=17,11,0,0,1021,38105,0,0,1587,92523,0,0,524,11850,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,144:5:0 0,30,255:10:0 +X 399 . A <*> 0 . DP=28;I16=17,11,0,0,1015,38469,0,0,1587,92523,0,0,526,11900,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,140:5:0 0,30,255:10:0 +X 400 . A <*> 0 . DP=29;I16=17,12,0,0,1056,39702,0,0,1647,96123,0,0,526,11828,0,0;QS=3,0;MQSB=0.988062;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,159:5:0 0,33,255:11:0 +X 401 . A <*> 0 . DP=29;I16=17,11,0,0,1052,40302,0,0,1587,92523,0,0,501,11113,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,160:5:0 0,30,255:10:0 +X 402 . T <*> 0 . DP=29;I16=17,12,0,0,1082,41232,0,0,1647,96123,0,0,526,11680,0,0;QS=3,0;MQSB=0.988062;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,149:5:0 0,33,255:11:0 +X 403 . T <*> 0 . DP=29;I16=17,12,0,0,1085,40985,0,0,1647,96123,0,0,526,11654,0,0;QS=3,0;MQSB=0.988062;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,148:5:0 0,33,255:11:0 +X 404 . G <*> 0 . DP=29;I16=17,12,0,0,1074,40524,0,0,1647,96123,0,0,525,11609,0,0;QS=3,0;MQSB=0.988062;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,131:5:0 0,33,255:11:0 +X 405 . T <*> 0 . DP=27;I16=16,10,0,0,988,37870,0,0,1498,88082,0,0,519,11543,0,0;QS=3,0;MQSB=0.987578;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,103:3:0 0,30,255:10:0 +X 406 . G <*> 0 . DP=27;I16=16,11,0,0,976,36752,0,0,1558,91682,0,0,527,11601,0,0;QS=3,0;MQSB=0.992419;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,125:4:0 0,30,247:10:0 +X 407 . A <*> 0 . DP=27;I16=16,11,0,0,1007,38355,0,0,1558,91682,0,0,526,11538,0,0;QS=3,0;MQSB=0.992419;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,125:4:0 0,30,255:10:0 +X 408 . C <*> 0 . DP=28;I16=16,11,0,0,1006,38136,0,0,1558,91682,0,0,521,11489,0,0;QS=3,0;MQSB=0.992419;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,110:3:0 0,30,244:10:0 +X 409 . T <*> 0 . DP=29;I16=17,12,0,0,1100,42734,0,0,1678,98882,0,0,525,11503,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,131:4:0 0,33,255:11:0 +X 410 . T <*> 0 . DP=29;I16=17,12,0,0,1035,38325,0,0,1678,98882,0,0,524,11432,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,125:4:0 0,33,255:11:0 +X 411 . T <*> 0 . DP=29;I16=17,10,0,0,1003,37747,0,0,1558,91682,0,0,496,10716,0,0;QS=3,0;MQSB=0.984677;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,104:3:0 0,30,255:10:0 +X 412 . C T,<*> 0 . DP=30;I16=17,12,1,0,1094,42458,14,196,1678,98882,60,3600,495,10659,25,625;QS=2.97455,0.0254545,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.991968;BQB=1;MQ0F=0 PL:DP:DV 0,30,255,42,255,255:15:1 0,12,124,12,124,124:4:0 0,33,255,33,255,255:11:0 +X 413 . A <*> 0 . DP=31;I16=18,13,0,0,1189,45985,0,0,1798,106082,0,0,520,11258,0,0;QS=3,0;MQSB=0.995005;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,9,102:3:0 0,33,255:11:0 +X 414 . T <*> 0 . DP=30;I16=18,12,0,0,1151,44355,0,0,1738,102482,0,0,523,11265,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,109:3:0 0,33,255:11:0 +X 415 . G <*> 0 . DP=30;I16=18,12,0,0,1131,43175,0,0,1738,102482,0,0,526,11306,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,110:3:0 0,33,255:11:0 +X 416 . G <*> 0 . DP=30;I16=17,12,0,0,1083,41273,0,0,1678,98882,0,0,514,11156,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,114:3:0 0,30,253:10:0 +X 417 . C <*> 0 . DP=30;I16=18,12,0,0,1114,42244,0,0,1738,102482,0,0,531,11439,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,108:3:0 0,33,255:11:0 +X 418 . A <*> 0 . DP=30;I16=18,12,0,0,1146,44248,0,0,1738,102482,0,0,532,11478,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,111:3:0 0,33,255:11:0 +X 419 . T <*> 0 . DP=30;I16=18,12,0,0,1117,42327,0,0,1738,102482,0,0,532,11498,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,112:3:0 0,33,255:11:0 +X 420 . A <*> 0 . DP=31;I16=18,13,0,0,1117,41011,0,0,1798,106082,0,0,532,11550,0,0;QS=3,0;MQSB=0.995005;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,108:3:0 0,36,255:12:0 +X 421 . A <*> 0 . DP=33;I16=19,14,0,0,1208,45398,0,0,1887,110523,0,0,533,11635,0,0;QS=3,0;MQSB=0.986656;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,113:3:0 0,42,255:14:0 +X 422 . A <*> 0 . DP=33;I16=19,13,0,0,1205,46441,0,0,1827,106923,0,0,510,11082,0,0;QS=3,0;MQSB=0.991023;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,116:3:0 0,39,255:13:0 +X 423 . T <*> 0 . DP=32;I16=19,13,0,0,1202,45416,0,0,1827,106923,0,0,538,11818,0,0;QS=3,0;MQSB=0.991023;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,110:3:0 0,39,255:13:0 +X 424 . A <*> 0 . DP=32;I16=19,13,0,0,1147,41685,0,0,1827,106923,0,0,539,11867,0,0;QS=3,0;MQSB=0.991023;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,106:3:0 0,39,255:13:0 +X 425 . A <*> 0 . DP=29;I16=16,13,0,0,1070,40616,0,0,1647,96123,0,0,542,11900,0,0;QS=3,0;MQSB=0.976248;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,111:3:0 0,33,249:11:0 +X 426 . T <*> 0 . DP=29;I16=16,12,0,0,997,36561,0,0,1587,92523,0,0,519,11287,0,0;QS=3,0;MQSB=0.982906;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,105:3:0 0,30,225:10:0 +X 427 . A <*> 0 . DP=29;I16=16,13,0,0,1024,37266,0,0,1647,96123,0,0,546,11952,0,0;QS=3,0;MQSB=0.976248;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,111:3:0 0,33,242:11:0 +X 428 . C <*> 0 . DP=29;I16=16,13,0,0,1064,39706,0,0,1647,96123,0,0,548,12020,0,0;QS=3,0;MQSB=0.976248;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,111:3:0 0,33,254:11:0 +X 429 . T <*> 0 . DP=30;I16=16,14,0,0,1150,44918,0,0,1707,99723,0,0,549,12067,0,0;QS=3,0;MQSB=0.969373;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,115:3:0 0,33,255:11:0 +X 430 . G <*> 0 . DP=30;I16=16,14,0,0,1113,42443,0,0,1707,99723,0,0,551,12145,0,0;QS=3,0;MQSB=0.969373;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,112:3:0 0,33,246:11:0 +X 431 . G <*> 0 . DP=30;I16=14,14,0,0,1003,36953,0,0,1587,92523,0,0,553,12255,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,101:3:0 0,30,225:10:0 +X 432 . T <*> 0 . DP=28;I16=14,14,0,0,1049,39621,0,0,1587,92523,0,0,556,12346,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,114:3:0 0,30,255:10:0 +X 433 . T <*> 0 . DP=28;I16=14,12,0,0,949,35443,0,0,1467,85323,0,0,509,11217,0,0;QS=3,0;MQSB=0.967472;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,112:3:0 0,27,227:9:0 +X 434 . T <*> 0 . DP=29;I16=15,14,0,0,1036,37654,0,0,1647,96123,0,0,561,12567,0,0;QS=3,0;MQSB=0.960561;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,98:3:0 0,30,243:10:0 +X 435 . A <*> 0 . DP=29;I16=15,13,0,0,1024,37970,0,0,1587,92523,0,0,556,12560,0,0;QS=3,0;MQSB=0.968414;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,103:3:0 0,30,237:10:0 +X 436 . T <*> 0 . DP=28;I16=14,14,0,0,998,36220,0,0,1587,92523,0,0,564,12654,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,110:3:0 0,27,223:9:0 +X 437 . T <*> 0 . DP=28;I16=13,14,0,0,990,36832,0,0,1558,91682,0,0,549,12435,0,0;QS=3,0;MQSB=0.999706;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,109:3:0 0,24,207:8:0 +X 438 . A <*> 0 . DP=28;I16=14,13,0,0,972,35640,0,0,1527,88923,0,0,540,12082,0,0;QS=3,0;MQSB=0.9585;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,107:3:0 0,24,216:8:0 +X 439 . C <*> 0 . DP=28;I16=14,14,0,0,1055,40273,0,0,1587,92523,0,0,563,12649,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,107:3:0 0,27,224:9:0 +X 440 . A <*> 0 . DP=28;I16=14,14,0,0,1095,43251,0,0,1587,92523,0,0,561,12615,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,115:3:0 0,27,247:9:0 +X 441 . G <*> 0 . DP=29;I16=15,14,0,0,1068,40344,0,0,1647,96123,0,0,559,12605,0,0;QS=3,0;MQSB=0.960561;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,9,104:3:0 0,27,198:9:0 +X 442 . A <*> 0 . DP=29;I16=15,14,0,0,1091,41507,0,0,1647,96123,0,0,558,12620,0,0;QS=3,0;MQSB=0.960561;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,9,112:3:0 0,27,233:9:0 +X 443 . A <*> 0 . DP=30;I16=15,14,0,0,1173,49439,0,0,1647,96123,0,0,557,12661,0,0;QS=3,0;MQSB=0.960561;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,9,129:3:0 0,27,246:9:0 +X 444 . G <*> 0 . DP=29;I16=15,13,0,0,1095,44661,0,0,1587,92523,0,0,557,12727,0,0;QS=3,0;MQSB=0.968414;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,91:2:0 0,27,227:9:0 +X 445 . C <*> 0 . DP=30;I16=16,13,0,0,1100,43706,0,0,1647,96123,0,0,557,12817,0,0;QS=3,0;MQSB=0.976248;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,9,111:3:0 0,27,219:9:0 +X 446 . A <*> 0 . DP=30;I16=16,13,0,0,1107,44265,0,0,1647,96123,0,0,557,12881,0,0;QS=3,0;MQSB=0.976248;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,9,115:3:0 0,27,232:9:0 +X 447 . C <*> 0 . DP=29;I16=16,12,0,0,1108,45364,0,0,1618,95282,0,0,555,12817,0,0;QS=3,0;MQSB=0.856268;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,114:3:0 0,27,235:9:0 +X 448 . T <*> 0 . DP=29;I16=16,12,0,0,1125,47237,0,0,1618,95282,0,0,553,12773,0,0;QS=3,0;MQSB=0.856268;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,118:3:0 0,27,240:9:0 +X 449 . A <*> 0 . DP=28;I16=15,12,0,0,1091,45981,0,0,1558,91682,0,0,552,12748,0,0;QS=3,0;MQSB=0.84246;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,90:2:0 0,27,245:9:0 +X 450 . G <*> 0 . DP=28;I16=15,12,0,0,1069,44603,0,0,1558,91682,0,0,551,12741,0,0;QS=3,0;MQSB=0.84246;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,91:2:0 0,27,233:9:0 +X 451 . A <*> 0 . DP=28;I16=15,12,0,0,1021,41371,0,0,1558,91682,0,0,550,12752,0,0;QS=3,0;MQSB=0.84246;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,93:2:0 0,27,244:9:0 +X 452 . A <*> 0 . DP=31;I16=18,11,0,0,1079,43353,0,0,1678,98882,0,0,530,12420,0,0;QS=3,0;MQSB=0.884952;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,9,110:3:0 0,24,225:8:0 +X 453 . A <*> 0 . DP=31;I16=17,11,0,0,1037,41069,0,0,1649,98041,0,0,508,11882,0,0;QS=3,0;MQSB=0.967085;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,9,111:3:0 0,21,221:7:0 +X 454 . A <*> 0 . DP=31;I16=18,12,0,0,1158,47028,0,0,1738,102482,0,0,554,12904,0,0;QS=3,0;MQSB=0.878946;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,9,113:3:0 0,30,255:10:0 +X 455 . T <*> 0 . DP=32;I16=17,13,0,0,1148,46574,0,0,1715,100251,0,0,550,12864,0,0;QS=3,0;MQSB=0.973855;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,113:3:0 0,33,255:11:0 +X 456 . G <*> 0 . DP=32;I16=17,13,0,0,1161,47287,0,0,1746,103010,0,0,534,12296,0,0;QS=3,0;MQSB=0.998031;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,9,116:3:0 0,30,245:10:0 +X 457 . C <*> 0 . DP=33;I16=19,13,0,0,1218,48642,0,0,1835,107451,0,0,563,12967,0,0;QS=3,0;MQSB=0.985204;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,9,118:3:0 0,33,255:11:0 +X 458 . A <*> 0 . DP=33;I16=19,13,0,0,1226,49034,0,0,1835,107451,0,0,568,12990,0,0;QS=3,0;MQSB=0.985204;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,9,111:3:0 0,33,255:11:0 +X 459 . T <*> 0 . DP=33;I16=18,13,0,0,1167,46981,0,0,1775,103851,0,0,565,12945,0,0;QS=3,0;MQSB=0.980167;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,92:2:0 0,33,255:11:0 +X 460 . G <*> 0 . DP=32;I16=19,12,0,0,1219,50105,0,0,1775,103851,0,0,575,12929,0,0;QS=3,0;MQSB=0.989977;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,9,116:3:0 0,30,255:10:0 +X 461 . T <*> 0 . DP=32;I16=19,12,0,0,1213,49819,0,0,1775,103851,0,0,577,12845,0,0;QS=3,0;MQSB=0.989977;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,9,115:3:0 0,30,255:10:0 +X 462 . G <*> 0 . DP=32;I16=19,12,0,0,1190,48962,0,0,1775,103851,0,0,580,12792,0,0;QS=3,0;MQSB=0.989977;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,119:4:0 0,30,241:10:0 +X 463 . G <*> 0 . DP=32;I16=19,12,0,0,1114,44214,0,0,1775,103851,0,0,584,12770,0,0;QS=3,0;MQSB=0.989977;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,114:4:0 0,30,221:10:0 +X 464 . A <*> 0 . DP=32;I16=18,11,0,0,1100,43908,0,0,1686,99410,0,0,556,12106,0,0;QS=3,0;MQSB=0.99095;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,133:4:0 0,24,213:8:0 +X 465 . C <*> 0 . DP=33;I16=20,11,0,0,1191,48085,0,0,1775,103851,0,0,586,12786,0,0;QS=3,0;MQSB=0.996597;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,140:5:0 0,27,231:9:0 +X 466 . A <*> 0 . DP=34;I16=21,12,0,0,1293,53311,0,0,1895,111051,0,0,597,12897,0,0;QS=3,0;MQSB=0.995633;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,154:5:0 0,30,255:10:0 +X 467 . A <*> 0 . DP=34;I16=21,11,0,0,1256,51450,0,0,1835,107451,0,0,597,12891,0,0;QS=3,0;MQSB=0.998231;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,157:5:0 0,27,248:9:0 +X 468 . A <*> 0 . DP=35;I16=22,12,0,0,1274,51268,0,0,1955,114651,0,0,604,12904,0,0;QS=3,0;MQSB=0.997406;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,154:5:0 0,30,251:10:0 +X 469 . A <*> 0 . DP=35;I16=22,12,0,0,1285,52989,0,0,1955,114651,0,0,608,12940,0,0;QS=3,0;MQSB=0.997406;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,146:5:0 0,30,255:10:0 +X 470 . G <*> 0 . DP=35;I16=22,12,0,0,1281,51055,0,0,1955,114651,0,0,612,13016,0,0;QS=3,0;MQSB=0.997406;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,148:5:0 0,30,238:10:0 +X 471 . T <*> 0 . DP=36;I16=22,11,0,0,1239,49021,0,0,1918,113282,0,0,599,12825,0,0;QS=3,0;MQSB=0.915545;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,150:5:0 0,27,232:9:0 +X 472 . T <*> 0 . DP=35;I16=21,12,0,0,1245,48915,0,0,1926,113810,0,0,595,12559,0,0;QS=3,0;MQSB=0.988858;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,153:5:0 0,27,237:9:0 +X 473 . G <*> 0 . DP=35;I16=21,12,0,0,1307,53473,0,0,1926,113810,0,0,599,12651,0,0;QS=3,0;MQSB=0.988858;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,141:5:0 0,27,249:9:0 +X 474 . G <*> 0 . DP=36;I16=22,12,0,0,1284,51708,0,0,1986,117410,0,0,602,12734,0,0;QS=3,0;MQSB=0.986937;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,131:5:0 0,30,255:10:0 +X 475 . G <*> 0 . DP=36;I16=23,12,0,0,1311,51609,0,0,2015,118251,0,0,631,13485,0,0;QS=3,0;MQSB=0.998642;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,141:5:0 0,33,252:11:0 +X 476 . A <*> 0 . DP=36;I16=23,12,0,0,1312,52078,0,0,2015,118251,0,0,634,13606,0,0;QS=3,0;MQSB=0.998642;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,157:5:0 0,33,255:11:0 +X 477 . T <*> 0 . DP=36;I16=23,12,0,0,1318,52668,0,0,2015,118251,0,0,637,13773,0,0;QS=3,0;MQSB=0.998642;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,148:5:0 0,33,255:11:0 +X 478 . T <*> 0 . DP=38;I16=25,12,0,0,1338,51774,0,0,2135,125451,0,0,637,13833,0,0;QS=3,0;MQSB=0.999868;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,18,154:6:0 0,33,255:11:0 +X 479 . A <*> 0 . DP=38;I16=25,12,0,0,1420,57788,0,0,2135,125451,0,0,639,13935,0,0;QS=3,0;MQSB=0.999868;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,18,163:6:0 0,33,255:11:0 +X 480 . G <*> 0 . DP=37;I16=25,11,0,0,1438,60172,0,0,2075,121851,0,0,641,14029,0,0;QS=3,0;MQSB=0.999853;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,165:6:0 0,33,255:11:0 +X 481 . G <*> 0 . DP=37;I16=25,11,0,0,1392,55824,0,0,2075,121851,0,0,642,14112,0,0;QS=3,0;MQSB=0.999853;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,165:6:0 0,33,255:11:0 +X 482 . A <*> 0 . DP=37;I16=24,11,0,0,1352,55134,0,0,2015,118251,0,0,618,13608,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,143:5:0 0,33,255:11:0 +X 483 . G <*> 0 . DP=37;I16=24,12,0,0,1417,57747,0,0,2075,121851,0,0,642,14240,0,0;QS=3,0;MQSB=0.999437;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,165:6:0 0,33,255:11:0 +X 484 . A <*> 0 . DP=36;I16=24,11,0,0,1340,53992,0,0,2015,118251,0,0,643,14281,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,168:6:0 0,33,255:11:0 +X 485 . G <*> 0 . DP=35;I16=23,12,0,0,1329,51411,0,0,2015,118251,0,0,669,14931,0,0;QS=3,0;MQSB=0.998642;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,160:6:0 0,33,255:11:0 +X 486 . A <*> 0 . DP=34;I16=22,12,0,0,1311,51523,0,0,1955,114651,0,0,671,14989,0,0;QS=3,0;MQSB=0.997406;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,173:6:0 0,33,255:11:0 +X 487 . G <*> 0 . DP=34;I16=22,12,0,0,1306,50760,0,0,1955,114651,0,0,672,15030,0,0;QS=3,0;MQSB=0.997406;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,169:6:0 0,33,255:11:0 +X 488 . A <*> 0 . DP=35;I16=22,12,0,0,1274,48140,0,0,1986,117410,0,0,646,14380,0,0;QS=3,0;MQSB=0.986937;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,177:6:0 0,30,255:10:0 +X 489 . A <*> 0 . DP=35;I16=23,12,0,0,1264,46916,0,0,2015,118251,0,0,671,15015,0,0;QS=3,0;MQSB=0.998642;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,175:6:0 0,33,255:11:0 +X 490 . A <*> 0 . DP=36;I16=24,12,0,0,1332,50280,0,0,2075,121851,0,0,671,15061,0,0;QS=3,0;MQSB=0.999437;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,188:7:0 0,33,255:11:0 +X 491 . T <*> 0 . DP=36;I16=24,12,0,0,1284,46802,0,0,2075,121851,0,0,671,15093,0,0;QS=3,0;MQSB=0.999437;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,178:7:0 0,33,255:11:0 +X 492 . G <*> 0 . DP=35;I16=21,12,0,0,1252,48326,0,0,1926,113810,0,0,621,13859,0,0;QS=3,0;MQSB=0.988858;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,172:6:0 0,30,251:10:0 +X 493 . A <*> 0 . DP=34;I16=22,11,0,0,1273,49481,0,0,1926,113810,0,0,650,14672,0,0;QS=3,0;MQSB=0.981935;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,186:7:0 0,24,240:8:0 +X 494 . A <*> 0 . DP=34;I16=22,12,0,0,1326,52604,0,0,1986,117410,0,0,672,15182,0,0;QS=3,0;MQSB=0.986937;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,196:7:0 0,27,255:9:0 +X 495 . G <*> 0 . DP=34;I16=21,12,0,0,1255,48577,0,0,1926,113810,0,0,647,14611,0,0;QS=3,0;MQSB=0.988858;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,168:6:0 0,27,244:9:0 +X 496 . A <*> 0 . DP=34;I16=22,12,0,0,1250,46926,0,0,1986,117410,0,0,670,15220,0,0;QS=3,0;MQSB=0.986937;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,186:7:0 0,27,249:9:0 +X 497 . C <*> 0 . DP=34;I16=22,12,0,0,1250,47006,0,0,1986,117410,0,0,665,15087,0,0;QS=3,0;MQSB=0.986937;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,164:7:0 0,27,239:9:0 +X 498 . A <*> 0 . DP=34;I16=22,12,0,0,1286,49158,0,0,1986,117410,0,0,661,14987,0,0;QS=3,0;MQSB=0.986937;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,185:7:0 0,27,252:9:0 +X 499 . T <*> 0 . DP=34;I16=23,11,0,0,1224,45284,0,0,1986,117410,0,0,659,14919,0,0;QS=3,0;MQSB=0.979712;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,183:7:0 0,30,255:10:0 +X 500 . A <*> 0 . DP=34;I16=23,11,0,0,1230,45152,0,0,1986,117410,0,0,657,14833,0,0;QS=3,0;MQSB=0.979712;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,179:7:0 0,30,255:10:0 +X 501 . T <*> 0 . DP=33;I16=23,10,0,0,1241,47167,0,0,1926,113810,0,0,656,14778,0,0;QS=3,0;MQSB=0.972757;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,186:7:0 0,27,241:9:0 +X 502 . G <*> 0 . DP=33;I16=23,10,0,0,1215,45829,0,0,1926,113810,0,0,655,14753,0,0;QS=3,0;MQSB=0.972757;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,183:7:0 0,27,235:9:0 +X 503 . T <*> 0 . DP=34;I16=23,11,0,0,1194,43366,0,0,1986,117410,0,0,654,14758,0,0;QS=3,0;MQSB=0.979712;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,177:7:0 0,27,234:9:0 +X 504 . C <*> 0 . DP=34;I16=23,11,0,0,1218,45552,0,0,1986,117410,0,0,651,14643,0,0;QS=3,0;MQSB=0.979712;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,183:7:0 0,27,219:9:0 +X 505 . C <*> 0 . DP=35;I16=23,11,0,0,1207,44321,0,0,1986,117410,0,0,641,14509,0,0;QS=3,0;MQSB=0.979712;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,189:7:0 0,27,221:9:0 +X 506 . A <*> 0 . DP=35;I16=24,11,0,0,1266,46776,0,0,2046,121010,0,0,646,14504,0,0;QS=3,0;MQSB=0.977529;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,188:7:0 0,27,231:9:0 +X 507 . C <*> 0 . DP=35;I16=23,11,0,0,1220,45016,0,0,1986,117410,0,0,635,14401,0,0;QS=3,0;MQSB=0.979712;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,183:7:0 0,27,226:9:0 +X 508 . A <*> 0 . DP=34;I16=24,10,0,0,1204,44542,0,0,1986,117410,0,0,643,14491,0,0;QS=3,0;MQSB=0.970272;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,189:7:0 0,27,220:9:0 +X 509 . C <*> 0 . DP=34;I16=24,10,0,0,1272,48272,0,0,1986,117410,0,0,640,14430,0,0;QS=3,0;MQSB=0.970272;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,186:7:0 0,27,241:9:0 +X 510 . A <*> 0 . DP=34;I16=22,11,0,0,1194,44196,0,0,1926,113810,0,0,613,13773,0,0;QS=3,0;MQSB=0.981935;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,187:7:0 0,24,221:8:0 +X 511 . A <*> 0 . DP=34;I16=23,11,0,0,1222,45562,0,0,1986,117410,0,0,637,14395,0,0;QS=3,0;MQSB=0.979712;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,195:7:0 0,24,233:8:0 +X 512 . A C,<*> 0 . DP=33;I16=22,10,0,1,1121,40793,13,169,1866,110210,60,3600,628,14340,9,81;QS=2.97719,0.022807,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.981935;BQB=1;MQ0F=0 PL:DP:DV 0,39,255,51,255,255:18:1 0,21,183,21,183,183:7:0 0,24,231,24,231,231:8:0 +X 513 . A <*> 0 . DP=32;I16=20,10,0,0,1115,42183,0,0,1746,103010,0,0,598,13624,0,0;QS=3,0;MQSB=0.980594;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,175:6:0 0,24,233:8:0 +X 514 . A T,<*> 0 . DP=32;I16=20,9,0,1,1066,40004,16,256,1686,99410,60,3600,586,13500,11,121;QS=2.97075,0.0292505,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.980594;BQB=1;MQ0F=0 PL:DP:DV 0,31,255,45,255,255:16:1 0,18,171,18,171,171:6:0 0,24,235,24,235,235:8:0 +X 515 . C <*> 0 . DP=32;I16=18,10,0,0,1010,37294,0,0,1626,95810,0,0,561,12915,0,0;QS=3,0;MQSB=0.986018;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,167:6:0 0,24,211:8:0 +X 516 . C <*> 0 . DP=32;I16=21,10,0,0,1100,40570,0,0,1806,106610,0,0,612,13954,0,0;QS=3,0;MQSB=0.977926;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,187:7:0 0,24,215:8:0 +X 517 . T <*> 0 . DP=33;I16=23,10,0,0,1269,49995,0,0,1926,113810,0,0,636,14626,0,0;QS=3,0;MQSB=0.972757;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,201:7:0 0,24,242:8:0 +X 518 . G <*> 0 . DP=34;I16=24,10,0,0,1247,46839,0,0,1986,117410,0,0,636,14696,0,0;QS=3,0;MQSB=0.970272;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,182:7:0 0,24,220:8:0 +X 519 . T <*> 0 . DP=36;I16=25,11,0,0,1283,46693,0,0,2106,124610,0,0,636,14742,0,0;QS=3,0;MQSB=0.975394;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,21,177:7:0 0,24,224:8:0 +X 520 . T <*> 0 . DP=36;I16=24,11,0,0,1238,44894,0,0,2046,121010,0,0,613,14193,0,0;QS=3,0;MQSB=0.977529;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,21,180:7:0 0,24,223:8:0 +X 521 . C <*> 0 . DP=34;I16=25,9,0,0,1280,49454,0,0,1986,117410,0,0,641,14875,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,21,191:7:0 0,21,204:7:0 +X 522 . A <*> 0 . DP=32;I16=24,8,0,0,1158,43228,0,0,1897,112969,0,0,646,14960,0,0;QS=3,0;MQSB=0.872525;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,21,185:7:0 0,15,170:5:0 +X 523 . T G,<*> 0 . DP=32;I16=23,8,1,0,1184,45708,15,225,1837,109369,60,3600,626,14446,25,625;QS=2.9794,0.0206044,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.872525;BQB=1;MQ0F=0 PL:DP:DV 0,44,255,57,255,255:20:1 0,21,191,21,191,191:7:0 0,15,166,15,166,166:5:0 +X 524 . T <*> 0 . DP=32;I16=24,7,0,0,1084,39474,0,0,1837,109369,0,0,629,14483,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,21,194:7:0 0,12,140:4:0 +X 525 . G <*> 0 . DP=32;I16=24,7,0,0,1181,45669,0,0,1837,109369,0,0,631,14495,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,21,188:7:0 0,12,129:4:0 +X 526 . C <*> 0 . DP=32;I16=24,7,0,0,1146,43950,0,0,1860,111600,0,0,633,14531,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,21,185:7:0 0,12,131:4:0 +X 527 . A <*> 0 . DP=33;I16=24,8,0,0,1209,46265,0,0,1897,112969,0,0,636,14634,0,0;QS=3,0;MQSB=0.872525;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,194:7:0 0,18,181:6:0 +X 528 . G <*> 0 . DP=33;I16=24,8,0,0,1256,49824,0,0,1897,112969,0,0,634,14484,0,0;QS=3,0;MQSB=0.872525;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,18,169:6:0 0,18,193:6:0 +X 529 . C <*> 0 . DP=32;I16=24,7,0,0,1148,44362,0,0,1837,109369,0,0,633,14357,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,187:7:0 0,18,184:6:0 +X 530 . T <*> 0 . DP=32;I16=25,7,0,0,1244,49168,0,0,1897,112969,0,0,657,14883,0,0;QS=3,0;MQSB=0.850154;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,196:7:0 0,18,202:6:0 +X 531 . T <*> 0 . DP=32;I16=25,7,0,0,1177,44171,0,0,1897,112969,0,0,654,14714,0,0;QS=3,0;MQSB=0.850154;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,181:7:0 0,18,193:6:0 +X 532 . T <*> 0 . DP=32;I16=24,7,0,0,1153,43543,0,0,1837,109369,0,0,630,14116,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,181:7:0 0,18,192:6:0 +X 533 . C <*> 0 . DP=32;I16=24,7,0,0,1142,43940,0,0,1837,109369,0,0,619,13649,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,178:7:0 0,18,180:6:0 +X 534 . T <*> 0 . DP=31;I16=24,6,0,0,1212,49426,0,0,1777,105769,0,0,615,13479,0,0;QS=3,0;MQSB=0.82403;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,205:7:0 0,18,205:6:0 +X 535 . A <*> 0 . DP=31;I16=24,6,0,0,1080,39870,0,0,1777,105769,0,0,611,13341,0,0;QS=3,0;MQSB=0.82403;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,194:7:0 0,18,189:6:0 +X 536 . C <*> 0 . DP=31;I16=24,7,0,0,1097,40707,0,0,1837,109369,0,0,631,13809,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,184:7:0 0,18,157:6:0 +X 537 . C <*> 0 . DP=31;I16=22,7,0,0,1034,38564,0,0,1717,102169,0,0,587,12861,0,0;QS=3,0;MQSB=0.854582;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,172:7:0 0,18,183:6:0 +X 538 . A <*> 0 . DP=31;I16=24,7,0,0,1138,42478,0,0,1837,109369,0,0,620,13536,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,189:7:0 0,18,181:6:0 +X 539 . T <*> 0 . DP=31;I16=24,7,0,0,1134,42070,0,0,1837,109369,0,0,614,13422,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,178:7:0 0,18,181:6:0 +X 540 . C <*> 0 . DP=31;I16=24,7,0,0,1148,43768,0,0,1837,109369,0,0,608,13340,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,177:7:0 0,18,178:6:0 +X 541 . A <*> 0 . DP=32;I16=24,6,0,0,1083,40483,0,0,1777,105769,0,0,551,11991,0,0;QS=3,0;MQSB=0.82403;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,180:8:0 0,15,150:5:0 +X 542 . C <*> 0 . DP=33;I16=25,6,0,0,1123,41759,0,0,1837,109369,0,0,570,12552,0,0;QS=3,0;MQSB=0.822578;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,172:8:0 0,18,174:6:0 +X 543 . C <*> 0 . DP=34;I16=25,9,0,0,1219,45959,0,0,1986,117410,0,0,601,13245,0,0;QS=3,0;MQSB=0.621145;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,27,194:9:0 0,18,188:6:0 +X 544 . A <*> 0 . DP=33;I16=24,8,0,0,1170,43898,0,0,1866,110210,0,0,570,12506,0,0;QS=3,0;MQSB=0.579578;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,24,192:8:0 0,18,180:6:0 +X 545 . A <*> 0 . DP=33;I16=25,8,0,0,1174,43602,0,0,1926,113810,0,0,587,12951,0,0;QS=3,0;MQSB=0.576102;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,24,190:8:0 0,18,184:6:0 +X 546 . A <*> 0 . DP=32;I16=24,8,0,0,1126,41444,0,0,1866,110210,0,0,580,12802,0,0;QS=3,0;MQSB=0.579578;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,166:7:0 0,18,193:6:0 +X 547 . A <*> 0 . DP=32;I16=24,7,0,0,1129,42381,0,0,1806,106610,0,0,547,12009,0,0;QS=3,0;MQSB=0.525788;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,180:7:0 0,18,195:6:0 +X 548 . A <*> 0 . DP=33;I16=23,9,0,0,1153,42673,0,0,1866,110210,0,0,561,12489,0,0;QS=3,0;MQSB=0.628357;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,181:7:0 0,21,211:7:0 +X 549 . T G,<*> 0 . DP=32;I16=22,8,0,1,1101,40987,20,400,1746,103010,60,3600,530,11716,25,625;QS=2.96748,0.0325203,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.632337;BQB=1;MQ0F=0 PL:DP:DV 0,31,255,48,255,255:17:1 0,21,168,21,168,168:7:0 0,21,208,21,208,208:7:0 +X 550 . T <*> 0 . DP=32;I16=22,9,0,0,1052,37298,0,0,1806,106610,0,0,548,12176,0,0;QS=3,0;MQSB=0.632337;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,150:7:0 0,21,220:7:0 +X 551 . G <*> 0 . DP=31;I16=22,9,0,0,1121,41639,0,0,1806,106610,0,0,541,12045,0,0;QS=3,0;MQSB=0.632337;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,172:7:0 0,21,208:7:0 +X 552 . C <*> 0 . DP=30;I16=21,9,0,0,1093,41365,0,0,1746,103010,0,0,535,11947,0,0;QS=3,0;MQSB=0.636601;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,167:7:0 0,21,208:7:0 +X 553 . A <*> 0 . DP=30;I16=20,8,0,0,981,35387,0,0,1626,95810,0,0,485,10831,0,0;QS=3,0;MQSB=0.596163;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,150:6:0 0,21,194:7:0 +X 554 . A <*> 0 . DP=30;I16=19,9,0,0,975,35601,0,0,1626,95810,0,0,488,10906,0,0;QS=3,0;MQSB=0.646113;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,139:5:0 0,24,211:8:0 +X 555 . A <*> 0 . DP=30;I16=20,10,0,0,1024,36526,0,0,1746,103010,0,0,514,11392,0,0;QS=3,0;MQSB=0.679025;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,150:6:0 0,21,211:7:0 +X 556 . C <*> 0 . DP=29;I16=20,9,0,0,1055,39195,0,0,1709,101641,0,0,509,11219,0,0;QS=3,0;MQSB=0.894839;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,158:6:0 0,18,186:6:0 +X 557 . A <*> 0 . DP=27;I16=18,9,0,0,987,36749,0,0,1589,94441,0,0,506,11074,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,157:6:0 0,18,186:6:0 +X 558 . A <*> 0 . DP=27;I16=18,8,0,0,948,35808,0,0,1560,93600,0,0,477,10281,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,143:5:0 0,18,177:6:0 +X 559 . C A,<*> 0 . DP=27;I16=17,8,0,1,908,33726,14,196,1500,90000,29,841,448,9516,25,625;QS=2.92708,0.0729167,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.90038;BQB=1;MQ0F=0 PL:DP:DV 0,42,255,42,255,255:14:0 0,4,116,15,119,123:6:1 0,18,169,18,169,169:6:0 +X 560 . C <*> 0 . DP=28;I16=19,9,0,0,992,36552,0,0,1649,98041,0,0,494,10654,0,0;QS=3,0;MQSB=0.896555;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,160:6:0 0,21,181:7:0 +X 561 . A <*> 0 . DP=28;I16=18,9,0,0,963,35455,0,0,1589,94441,0,0,466,9946,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,158:6:0 0,21,194:7:0 +X 562 . C <*> 0 . DP=28;I16=18,9,0,0,1006,38392,0,0,1589,94441,0,0,463,9893,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,153:6:0 0,21,187:7:0 +X 563 . A <*> 0 . DP=27;I16=17,9,0,0,893,32413,0,0,1529,90841,0,0,460,9820,0,0;QS=3,0;MQSB=0.90038;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,149:5:0 0,21,179:7:0 +X 564 . C <*> 0 . DP=27;I16=18,9,0,0,859,28747,0,0,1589,94441,0,0,482,10402,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,121:5:0 0,21,182:7:0 +X 565 . G <*> 0 . DP=30;I16=17,9,0,0,818,26928,0,0,1560,93600,0,0,454,9764,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,96:4:0 0,21,154:7:0 +X 566 . C <*> 0 . DP=29;I16=15,11,0,0,903,33405,0,0,1529,90841,0,0,424,9084,0,0;QS=3,0;MQSB=0.927041;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,155:5:0 0,18,167:6:0 +X 567 . C <*> 0 . DP=30;I16=15,12,0,0,932,33774,0,0,1589,94441,0,0,462,10178,0,0;QS=3,0;MQSB=0.935229;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,155:5:0 0,21,196:7:0 +X 568 . C <*> 0 . DP=29;I16=15,13,0,0,1057,40817,0,0,1649,98041,0,0,482,10438,0,0;QS=3,0;MQSB=0.942064;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,183:6:0 0,18,189:6:0 +X 569 . T <*> 0 . DP=30;I16=16,12,0,0,1056,41296,0,0,1649,98041,0,0,493,10655,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,190:6:0 0,21,213:7:0 +X 570 . T <*> 0 . DP=30;I16=16,12,0,0,954,34972,0,0,1680,100800,0,0,472,10086,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,157:5:0 0,21,195:7:0 +X 571 . C <*> 0 . DP=31;I16=17,12,0,0,1061,40675,0,0,1740,104400,0,0,472,10158,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,155:5:0 0,21,193:7:0 +X 572 . A <*> 0 . DP=31;I16=18,12,0,0,1102,42642,0,0,1769,105241,0,0,499,10887,0,0;QS=3,0;MQSB=0.929991;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,203:7:0 0,18,175:6:0 +X 573 . A <*> 0 . DP=31;I16=18,12,0,0,1057,38473,0,0,1769,105241,0,0,501,10975,0,0;QS=3,0;MQSB=0.929991;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,199:7:0 0,18,178:6:0 +X 574 . C A,<*> 0 . DP=31;I16=18,11,0,1,1088,41328,15,225,1740,104400,29,841,478,10422,25,625;QS=2.94071,0.0592885,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.929991;BQB=1;MQ0F=0 PL:DP:DV 0,48,255,48,255,255:16:0 0,9,170,21,173,177:8:1 0,18,173,18,173,173:6:0 +X 575 . T <*> 0 . DP=30;I16=16,10,0,0,1024,41260,0,0,1560,93600,0,0,448,9842,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,21,209:7:0 0,15,163:5:0 +X 576 . G <*> 0 . DP=30;I16=17,12,0,0,1047,40077,0,0,1709,101641,0,0,507,11087,0,0;QS=3,0;MQSB=0.931617;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,208:8:0 0,15,151:5:0 +X 577 . G <*> 0 . DP=30;I16=16,12,0,0,999,37747,0,0,1649,98041,0,0,489,10755,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,24,204:8:0 0,15,146:5:0 +X 578 . G <*> 0 . DP=29;I16=16,13,0,0,975,34803,0,0,1709,101641,0,0,520,11286,0,0;QS=3,0;MQSB=0.940317;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,198:8:0 0,15,151:5:0 +X 579 . G <*> 0 . DP=30;I16=15,13,0,0,1028,38752,0,0,1649,98041,0,0,484,10514,0,0;QS=3,0;MQSB=0.942064;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,224:8:0 0,12,145:4:0 +X 580 . A C,<*> 0 . DP=30;I16=15,14,1,0,1060,39178,16,256,1709,101641,60,3600,510,11078,17,289;QS=2.97338,0.0266223,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.946202;BQB=1;MQ0F=0 PL:DP:DV 0,34,255,48,255,255:17:1 0,24,221,24,221,221:8:0 0,15,155,15,155,155:5:0 +X 581 . A <*> 0 . DP=31;I16=16,15,0,0,1083,39215,0,0,1829,108841,0,0,530,11384,0,0;QS=3,0;MQSB=0.951229;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,24,223:8:0 0,15,153:5:0 +X 582 . C <*> 0 . DP=31;I16=15,15,0,0,1080,39870,0,0,1769,105241,0,0,519,11211,0,0;QS=3,0;MQSB=0.952765;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,207:8:0 0,15,151:5:0 +X 583 . T <*> 0 . DP=30;I16=16,14,0,0,1136,43996,0,0,1769,105241,0,0,539,11523,0,0;QS=3,0;MQSB=0.946202;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,238:8:0 0,15,163:5:0 +X 584 . C <*> 0 . DP=31;I16=16,13,0,0,1051,39351,0,0,1709,101641,0,0,499,10619,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,207:7:0 0,15,157:5:0 +X 585 . A <*> 0 . DP=31;I16=17,14,0,0,1096,39866,0,0,1798,106082,0,0,549,11751,0,0;QS=3,0;MQSB=0.998229;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,24,211:8:0 0,15,157:5:0 +X 586 . T <*> 0 . DP=31;I16=16,14,0,0,1081,39839,0,0,1738,102482,0,0,546,11796,0,0;QS=3,0;MQSB=0.999136;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,212:8:0 0,15,156:5:0 +X 587 . C <*> 0 . DP=31;I16=17,13,0,0,1070,39402,0,0,1769,105241,0,0,532,11350,0,0;QS=3,0;MQSB=0.963674;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,201:7:0 0,15,155:5:0 +X 588 . A <*> 0 . DP=31;I16=17,14,0,0,1126,41642,0,0,1798,106082,0,0,562,12140,0,0;QS=3,0;MQSB=0.998229;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,24,222:8:0 0,15,164:5:0 +X 589 . A <*> 0 . DP=31;I16=17,14,0,0,1157,43973,0,0,1798,106082,0,0,568,12340,0,0;QS=3,0;MQSB=0.998229;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,24,236:8:0 0,15,165:5:0 +X 590 . C <*> 0 . DP=32;I16=16,14,0,0,1094,41302,0,0,1769,105241,0,0,549,11951,0,0;QS=3,0;MQSB=0.958545;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,192:6:0 0,18,175:6:0 +X 591 . A <*> 0 . DP=31;I16=16,15,0,0,1165,44163,0,0,1798,106082,0,0,579,12695,0,0;QS=3,0;MQSB=0.999805;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,209:7:0 0,18,188:6:0 +X 592 . A <*> 0 . DP=31;I16=15,15,0,0,1114,42144,0,0,1738,102482,0,0,571,12651,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,215:7:0 0,18,182:6:0 +X 593 . C <*> 0 . DP=31;I16=15,14,0,0,1065,39889,0,0,1709,101641,0,0,550,12132,0,0;QS=3,0;MQSB=0.954405;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,191:6:0 0,18,174:6:0 +X 594 . A <*> 0 . DP=33;I16=16,16,0,0,1163,42917,0,0,1858,109682,0,0,572,12672,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,205:7:0 0,24,212:8:0 +X 595 . A <*> 0 . DP=33;I16=17,16,0,0,1130,39996,0,0,1918,113282,0,0,589,12905,0,0;QS=3,0;MQSB=0.999838;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,198:7:0 0,24,213:8:0 +X 596 . A <*> 0 . DP=33;I16=16,16,0,0,1059,37039,0,0,1858,109682,0,0,590,12952,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,169:7:0 0,24,230:8:0 +X 597 . C <*> 0 . DP=33;I16=17,16,0,0,1196,44890,0,0,1918,113282,0,0,592,12990,0,0;QS=3,0;MQSB=0.999838;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,204:7:0 0,24,220:8:0 +X 598 . T <*> 0 . DP=33;I16=16,16,0,0,1214,47104,0,0,1858,109682,0,0,593,13013,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,217:7:0 0,24,239:8:0 +X 599 . T <*> 0 . DP=33;I16=16,17,0,0,1183,43669,0,0,1918,113282,0,0,599,13095,0,0;QS=3,0;MQSB=0.999838;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,197:7:0 0,27,247:9:0 +X 600 . G <*> 0 . DP=32;I16=15,17,0,0,1174,44066,0,0,1858,109682,0,0,601,13145,0,0;QS=3,0;MQSB=0.999287;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,194:7:0 0,24,232:8:0 +X 601 . T <*> 0 . DP=32;I16=15,17,0,0,1114,39954,0,0,1858,109682,0,0,603,13227,0,0;QS=3,0;MQSB=0.999287;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,188:7:0 0,24,235:8:0 +X 602 . G <*> 0 . DP=32;I16=15,15,0,0,1090,40326,0,0,1769,105241,0,0,555,12091,0,0;QS=3,0;MQSB=0.952765;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,185:6:0 0,24,229:8:0 +X 603 . G <*> 0 . DP=31;I16=15,16,0,0,1052,37460,0,0,1798,106082,0,0,607,13437,0,0;QS=3,0;MQSB=0.999805;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,186:7:0 0,24,219:8:0 +X 604 . T <*> 0 . DP=31;I16=14,16,0,0,1009,35893,0,0,1769,105241,0,0,564,12540,0,0;QS=3,0;MQSB=0.958545;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,24,195:8:0 0,21,212:7:0 +X 605 . T <*> 0 . DP=31;I16=12,15,0,0,1001,37741,0,0,1589,94441,0,0,514,11258,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,200:7:0 0,21,214:7:0 +X 606 . T <*> 0 . DP=31;I16=13,16,0,0,992,35202,0,0,1709,101641,0,0,587,13125,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,21,189:7:0 0,24,217:8:0 +X 607 . A <*> 0 . DP=31;I16=14,16,0,0,1027,36129,0,0,1738,102482,0,0,607,13577,0,0;QS=3,0;MQSB=0.999136;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,176:7:0 0,24,222:8:0 +X 608 . C <*> 0 . DP=32;I16=15,15,0,0,983,33775,0,0,1769,105241,0,0,564,12564,0,0;QS=3,0;MQSB=0.952765;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,21,178:7:0 0,27,214:9:0 +X 609 . C <*> 0 . DP=32;I16=14,17,0,0,1074,38220,0,0,1798,106082,0,0,606,13678,0,0;QS=3,0;MQSB=0.998229;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,190:7:0 0,27,238:9:0 +X 610 . C <*> 0 . DP=32;I16=15,16,0,0,1158,44218,0,0,1829,108841,0,0,594,13444,0,0;QS=3,0;MQSB=0.951229;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,211:8:0 0,27,246:9:0 +X 611 . A <*> 0 . DP=32;I16=15,16,0,0,1080,39204,0,0,1798,106082,0,0,590,13260,0,0;QS=3,0;MQSB=0.999805;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,27,220:9:0 0,27,246:9:0 +X 612 . C <*> 0 . DP=33;I16=16,17,0,0,1175,43305,0,0,1918,113282,0,0,617,13993,0,0;QS=3,0;MQSB=0.999838;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,27,214:9:0 0,27,250:9:0 +X 613 . A <*> 0 . DP=34;I16=16,17,0,0,1131,40011,0,0,1949,116041,0,0,604,13874,0,0;QS=3,0;MQSB=0.954207;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,27,223:9:0 0,27,239:9:0 +X 614 . C <*> 0 . DP=34;I16=16,17,0,0,1183,43743,0,0,1949,116041,0,0,608,14022,0,0;QS=3,0;MQSB=0.954207;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,27,223:9:0 0,27,245:9:0 +X 615 . A <*> 0 . DP=34;I16=16,18,0,0,1199,43809,0,0,1978,116882,0,0,626,14394,0,0;QS=3,0;MQSB=0.999405;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,30,240:10:0 0,27,254:9:0 +X 616 . A <*> 0 . DP=34;I16=16,17,0,0,1190,44024,0,0,1949,116041,0,0,615,14351,0,0;QS=3,0;MQSB=0.954207;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,27,247:9:0 0,27,255:9:0 +X 617 . T <*> 0 . DP=33;I16=15,18,0,0,1170,43066,0,0,1918,113282,0,0,630,14624,0,0;QS=3,0;MQSB=0.998531;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,30,241:10:0 0,27,255:9:0 +X 618 . G <*> 0 . DP=34;I16=15,19,0,0,1166,41452,0,0,1978,116882,0,0,632,14706,0,0;QS=3,0;MQSB=0.997597;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,30,248:10:0 0,27,240:9:0 +X 619 . G <*> 0 . DP=32;I16=14,18,0,0,1153,42591,0,0,1858,109682,0,0,638,14816,0,0;QS=3,0;MQSB=0.997118;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,30,254:10:0 0,27,247:9:0 +X 620 . A <*> 0 . DP=32;I16=14,17,0,0,1083,39757,0,0,1798,106082,0,0,616,14176,0,0;QS=3,0;MQSB=0.998229;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,30,248:10:0 0,27,255:9:0 +X 621 . A <*> 0 . DP=32;I16=13,18,0,0,1170,45248,0,0,1798,106082,0,0,627,14519,0,0;QS=3,0;MQSB=0.995005;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,27,255:9:0 0,27,255:9:0 +X 622 . G <*> 0 . DP=32;I16=12,18,0,0,1060,39160,0,0,1769,105241,0,0,604,13888,0,0;QS=3,0;MQSB=0.968257;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,236:9:0 0,27,249:9:0 +X 623 . A T,<*> 0 . DP=32;I16=10,18,1,0,1010,37414,15,225,1649,98041,60,3600,563,12953,25,625;QS=2.96144,0.0385604,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.969907;BQB=1;MQ0F=0 PL:DP:DV 0,20,241,33,244,246:12:1 0,24,213,24,213,213:8:0 0,27,255,27,255,255:9:0 +X 624 . C <*> 0 . DP=32;I16=13,17,0,0,1034,37292,0,0,1738,102482,0,0,607,13887,0,0;QS=3,0;MQSB=0.996503;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,220:9:0 0,27,242:9:0 +X 625 . C <*> 0 . DP=32;I16=13,18,0,0,1108,41138,0,0,1798,106082,0,0,632,14470,0,0;QS=3,0;MQSB=0.995005;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,27,234:9:0 0,27,249:9:0 +X 626 . A <*> 0 . DP=32;I16=13,17,0,0,1090,40718,0,0,1738,102482,0,0,607,13827,0,0;QS=3,0;MQSB=0.996503;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,237:9:0 0,27,247:9:0 +X 627 . C <*> 0 . DP=32;I16=12,18,0,0,1146,44452,0,0,1769,105241,0,0,607,13833,0,0;QS=3,0;MQSB=0.968257;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,244:9:0 0,27,255:9:0 +X 628 . T <*> 0 . DP=32;I16=11,19,0,0,1124,43114,0,0,1769,105241,0,0,608,13862,0,0;QS=3,0;MQSB=0.972375;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,27,249:9:0 0,24,249:8:0 +X 629 . T <*> 0 . DP=32;I16=12,19,0,0,1114,41138,0,0,1798,106082,0,0,634,14490,0,0;QS=3,0;MQSB=0.989977;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,247:9:0 0,24,226:8:0 +X 630 . A <*> 0 . DP=31;I16=11,18,0,0,1101,42885,0,0,1740,104400,0,0,610,13844,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,24,242:8:0 0,24,235:8:0 +X 631 . G <*> 0 . DP=31;I16=12,18,0,0,1083,40525,0,0,1769,105241,0,0,636,14474,0,0;QS=3,0;MQSB=0.929991;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,233:8:0 0,24,223:8:0 +X 632 . C <*> 0 . DP=31;I16=11,18,0,0,1105,42665,0,0,1740,104400,0,0,612,13880,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,24,233:8:0 0,24,224:8:0 +X 633 . A <*> 0 . DP=31;I16=12,18,0,0,1056,38190,0,0,1769,105241,0,0,638,14562,0,0;QS=3,0;MQSB=0.929991;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,218:8:0 0,24,214:8:0 +X 634 . A <*> 0 . DP=31;I16=12,18,0,0,1110,42208,0,0,1769,105241,0,0,638,14594,0,0;QS=3,0;MQSB=0.929991;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,238:8:0 0,24,229:8:0 +X 635 . C <*> 0 . DP=31;I16=11,18,0,0,1031,37871,0,0,1740,104400,0,0,613,14025,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,24,220:8:0 0,24,229:8:0 +X 636 . A <*> 0 . DP=31;I16=11,18,0,0,1115,43327,0,0,1740,104400,0,0,611,14005,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,24,228:8:0 0,24,243:8:0 +X 637 . A <*> 0 . DP=31;I16=12,18,0,0,1152,44602,0,0,1769,105241,0,0,634,14634,0,0;QS=3,0;MQSB=0.929991;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,238:8:0 0,24,242:8:0 +X 638 . A <*> 0 . DP=31;I16=12,18,0,0,1118,42406,0,0,1769,105241,0,0,631,14611,0,0;QS=3,0;MQSB=0.929991;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,235:8:0 0,24,238:8:0 +X 639 . A <*> 0 . DP=30;I16=11,18,0,0,1037,38233,0,0,1709,101641,0,0,602,13934,0,0;QS=3,0;MQSB=0.921439;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,24,230:8:0 0,24,227:8:0 +X 640 . A <*> 0 . DP=31;I16=11,19,0,0,1154,45368,0,0,1769,105241,0,0,596,13804,0,0;QS=3,0;MQSB=0.91982;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,242:8:0 0,24,240:8:0 +X 641 . G <*> 0 . DP=31;I16=11,19,0,0,1018,36496,0,0,1769,105241,0,0,590,13650,0,0;QS=3,0;MQSB=0.91982;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,214:8:0 0,24,218:8:0 +X 642 . G <*> 0 . DP=30;I16=11,19,0,0,1057,38459,0,0,1769,105241,0,0,610,14148,0,0;QS=3,0;MQSB=0.91982;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,187:7:0 0,24,221:8:0 +X 643 . A <*> 0 . DP=29;I16=11,17,0,0,969,35477,0,0,1649,98041,0,0,585,13605,0,0;QS=3,0;MQSB=0.923174;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,199:7:0 0,24,237:8:0 +X 644 . C A,<*> 0 . DP=29;I16=9,18,1,0,898,30864,17,289,1620,97200,60,3600,549,12567,25,625;QS=2.95685,0.0431472,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=1;BQB=1;MQ0F=0 PL:DP:DV 0,22,236,36,239,243:13:1 0,21,195,21,195,195:7:0 0,24,204,24,204,204:8:0 +X 645 . C <*> 0 . DP=30;I16=10,19,0,0,1067,40337,0,0,1709,101641,0,0,584,13274,0,0;QS=3,0;MQSB=0.909373;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,21,198:7:0 0,24,226:8:0 +X 646 . A T,<*> 0 . DP=31;I16=9,20,1,0,1044,38174,14,196,1740,104400,60,3600,553,12499,25,625;QS=2.97113,0.028866,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=1;BQB=1;MQ0F=0 PL:DP:DV 0,27,255,39,255,255:14:1 0,21,197,21,197,197:7:0 0,27,229,27,229,229:9:0 +X 647 . A <*> 0 . DP=33;I16=10,21,0,0,1041,35883,0,0,1829,108841,0,0,573,12999,0,0;QS=3,0;MQSB=0.906252;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,21,189:7:0 0,30,213:10:0 +X 648 . A <*> 0 . DP=33;I16=11,22,0,0,1030,34122,0,0,1949,116041,0,0,594,13478,0,0;QS=3,0;MQSB=0.915545;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,188:7:0 0,30,194:10:0 +X 649 . C <*> 0 . DP=32;I16=10,21,0,0,1099,39879,0,0,1860,111600,0,0,566,12738,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,188:7:0 0,27,217:9:0 +X 650 . T <*> 0 . DP=31;I16=11,18,0,0,1006,37114,0,0,1709,101641,0,0,549,12407,0,0;QS=3,0;MQSB=0.921439;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,187:6:0 0,24,226:8:0 +X 651 . C <*> 0 . DP=32;I16=11,20,0,0,1117,41181,0,0,1829,108841,0,0,581,13107,0,0;QS=3,0;MQSB=0.918304;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,186:6:0 0,27,229:9:0 +X 652 . C <*> 0 . DP=32;I16=9,21,0,0,1126,43084,0,0,1769,105241,0,0,557,12423,0,0;QS=3,0;MQSB=0.893237;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,196:6:0 0,24,213:8:0 +X 653 . T <*> 0 . DP=33;I16=9,23,0,0,1141,42631,0,0,1889,112441,0,0,556,12382,0,0;QS=3,0;MQSB=0.890331;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,198:6:0 0,24,225:8:0 +X 654 . G <*> 0 . DP=33;I16=10,23,0,0,1171,43025,0,0,1949,116041,0,0,578,12798,0,0;QS=3,0;MQSB=0.903508;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,191:6:0 0,24,223:8:0 +X 655 . G <*> 0 . DP=32;I16=10,22,0,0,1118,40202,0,0,1889,112441,0,0,575,12573,0,0;QS=3,0;MQSB=0.904837;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,181:6:0 0,24,213:8:0 +X 656 . T <*> 0 . DP=32;I16=10,22,0,0,1090,38566,0,0,1889,112441,0,0,571,12333,0,0;QS=3,0;MQSB=0.904837;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,185:6:0 0,24,213:8:0 +X 657 . A <*> 0 . DP=32;I16=10,21,0,0,1100,40006,0,0,1829,108841,0,0,557,12029,0,0;QS=3,0;MQSB=0.906252;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,183:6:0 0,24,191:8:0 +X 658 . C <*> 0 . DP=32;I16=10,21,0,0,1115,41039,0,0,1829,108841,0,0,542,11520,0,0;QS=3,0;MQSB=0.906252;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,168:5:0 0,24,211:8:0 +X 659 . A <*> 0 . DP=32;I16=10,21,0,0,1141,42897,0,0,1829,108841,0,0,547,11685,0,0;QS=3,0;MQSB=0.906252;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,191:6:0 0,24,216:8:0 +X 660 . T <*> 0 . DP=33;I16=10,22,0,0,1139,41887,0,0,1889,112441,0,0,553,11659,0,0;QS=3,0;MQSB=0.904837;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,186:6:0 0,24,214:8:0 +X 661 . G <*> 0 . DP=32;I16=9,22,0,0,1107,41531,0,0,1829,108841,0,0,549,11549,0,0;QS=3,0;MQSB=0.891738;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,191:6:0 0,21,188:7:0 +X 662 . C <*> 0 . DP=32;I16=8,22,0,0,1087,40811,0,0,1800,108000,0,0,523,10991,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,192:6:0 0,21,187:7:0 +X 663 . A <*> 0 . DP=32;I16=9,22,0,0,1036,36816,0,0,1829,108841,0,0,540,11388,0,0;QS=3,0;MQSB=0.891738;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,192:6:0 0,21,186:7:0 +X 664 . A <*> 0 . DP=32;I16=9,23,0,0,1125,40759,0,0,1889,112441,0,0,552,11628,0,0;QS=3,0;MQSB=0.890331;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,188:6:0 0,21,184:7:0 +X 665 . C <*> 0 . DP=30;I16=9,21,0,0,1075,39697,0,0,1769,105241,0,0,550,11650,0,0;QS=3,0;MQSB=0.893237;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,186:6:0 0,21,184:7:0 +X 666 . T <*> 0 . DP=29;I16=9,20,0,0,1096,41946,0,0,1709,101641,0,0,547,11607,0,0;QS=3,0;MQSB=0.894839;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,171:5:0 0,21,194:7:0 +X 667 . G <*> 0 . DP=31;I16=11,19,0,0,1037,37627,0,0,1769,105241,0,0,524,11198,0,0;QS=3,0;MQSB=0.91982;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,189:6:0 0,21,188:7:0 +X 668 . A <*> 0 . DP=31;I16=11,20,0,0,1102,39980,0,0,1829,108841,0,0,543,11625,0,0;QS=3,0;MQSB=0.918304;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,190:6:0 0,21,187:7:0 +X 669 . C <*> 0 . DP=30;I16=10,19,0,0,1051,38869,0,0,1740,104400,0,0,528,11464,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,182:6:0 0,21,189:7:0 +X 670 . A <*> 0 . DP=30;I16=11,19,0,0,1121,43423,0,0,1769,105241,0,0,540,11642,0,0;QS=3,0;MQSB=0.91982;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,194:6:0 0,21,205:7:0 +X 671 . G <*> 0 . DP=30;I16=11,19,0,0,1101,41035,0,0,1769,105241,0,0,537,11637,0,0;QS=3,0;MQSB=0.91982;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,181:6:0 0,21,191:7:0 +X 672 . A <*> 0 . DP=30;I16=10,19,0,0,1031,37795,0,0,1740,104400,0,0,521,11479,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,185:6:0 0,21,185:7:0 +X 673 . T <*> 0 . DP=29;I16=8,19,0,0,954,34984,0,0,1589,94441,0,0,497,10885,0,0;QS=3,0;MQSB=0.880529;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,126:4:0 0,21,192:7:0 +X 674 . G <*> 0 . DP=29;I16=10,18,0,0,974,35736,0,0,1649,98041,0,0,497,10827,0,0;QS=3,0;MQSB=0.911099;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,146:5:0 0,21,185:7:0 +X 675 . A <*> 0 . DP=28;I16=9,19,0,0,996,36338,0,0,1649,98041,0,0,517,11389,0,0;QS=3,0;MQSB=0.896555;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,124:4:0 0,21,189:7:0 +X 676 . A <*> 0 . DP=29;I16=8,19,0,0,988,36578,0,0,1589,94441,0,0,462,10106,0,0;QS=3,0;MQSB=0.880529;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,128:4:0 0,21,186:7:0 +X 677 . T <*> 0 . DP=29;I16=9,20,0,0,1006,36126,0,0,1709,101641,0,0,507,11303,0,0;QS=3,0;MQSB=0.894839;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,12,120:4:0 0,21,192:7:0 +X 678 . C <*> 0 . DP=29;I16=9,20,0,0,1020,36984,0,0,1709,101641,0,0,502,11280,0,0;QS=3,0;MQSB=0.894839;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,12,117:4:0 0,21,191:7:0 +X 679 . T <*> 0 . DP=27;I16=6,19,0,0,902,33612,0,0,1469,87241,0,0,460,10414,0,0;QS=3,0;MQSB=0.833024;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,96:3:0 0,21,195:7:0 +X 680 . C <*> 0 . DP=26;I16=7,18,0,0,879,32295,0,0,1469,87241,0,0,468,10482,0,0;QS=3,0;MQSB=0.862128;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,98:3:0 0,21,181:7:0 +X 681 . A <*> 0 . DP=27;I16=7,17,0,0,844,30190,0,0,1409,83641,0,0,465,10425,0,0;QS=3,0;MQSB=0.864405;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,106:3:0 0,21,174:7:0 +X 682 . A <*> 0 . DP=27;I16=7,20,0,0,919,32179,0,0,1589,94441,0,0,500,11096,0,0;QS=3,0;MQSB=0.858077;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,145:5:0 0,21,176:7:0 +X 683 . A <*> 0 . DP=29;I16=8,21,0,0,949,32735,0,0,1709,101641,0,0,499,11103,0,0;QS=3,0;MQSB=0.876998;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,172:6:0 0,21,167:7:0 +X 684 . C <*> 0 . DP=29;I16=6,21,0,0,802,24468,0,0,1589,94441,0,0,473,10459,0,0;QS=3,0;MQSB=0.829029;MQ0F=0 PL:DP:DV 0,45,251:15:0 0,15,118:5:0 0,21,145:7:0 +X 685 . G <*> 0 . DP=28;I16=6,21,0,0,908,32092,0,0,1620,97200,0,0,498,11090,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,130:5:0 0,21,175:7:0 +X 686 . C <*> 0 . DP=28;I16=7,21,0,0,977,35493,0,0,1680,100800,0,0,500,11080,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,170:6:0 0,21,180:7:0 +X 687 . A <*> 0 . DP=28;I16=6,20,0,0,900,31952,0,0,1560,93600,0,0,475,10469,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,175:6:0 0,21,174:7:0 +X 688 . T <*> 0 . DP=27;I16=6,21,0,0,937,33971,0,0,1620,97200,0,0,501,11135,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,153:6:0 0,21,187:7:0 +X 689 . T A,<*> 0 . DP=27;I16=5,20,1,0,829,28967,13,169,1500,90000,60,3600,463,10359,25,625;QS=2.97105,0.0289532,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=1;BQB=1;MQ0F=0 PL:DP:DV 0,28,231,39,234,234:14:1 0,15,116,15,116,116:5:0 0,21,185,21,185,185:7:0 +X 690 . C <*> 0 . DP=27;I16=6,20,0,0,935,34553,0,0,1560,93600,0,0,486,10974,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,146:5:0 0,21,165:7:0 +X 691 . C <*> 0 . DP=26;I16=5,18,0,0,842,31906,0,0,1380,82800,0,0,446,10166,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,129:4:0 0,18,161:6:0 +X 692 . T <*> 0 . DP=26;I16=6,19,0,0,886,32434,0,0,1500,90000,0,0,486,11082,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,146:5:0 0,18,164:6:0 +X 693 . C <*> 0 . DP=27;I16=6,20,0,0,891,31839,0,0,1560,93600,0,0,483,11007,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,141:5:0 0,21,172:7:0 +X 694 . C <*> 0 . DP=27;I16=6,21,0,0,808,25004,0,0,1620,97200,0,0,498,11248,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,242:14:0 0,18,136:6:0 0,21,146:7:0 +X 695 . G <*> 0 . DP=25;I16=4,20,0,0,807,28037,0,0,1440,86400,0,0,476,10692,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,246:13:0 0,18,145:6:0 0,15,124:5:0 +X 696 . T <*> 0 . DP=25;I16=5,20,0,0,896,32870,0,0,1500,90000,0,0,499,11129,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,150:6:0 0,15,141:5:0 +X 697 . G <*> 0 . DP=26;I16=5,19,0,0,852,30594,0,0,1409,83641,0,0,450,9858,0,0;QS=3,0;MQSB=0.796124;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,142:5:0 0,15,120:5:0 +X 698 . T <*> 0 . DP=27;I16=6,20,0,0,917,33201,0,0,1529,90841,0,0,502,11114,0,0;QS=3,0;MQSB=0.83095;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,154:6:0 0,15,131:5:0 +X 699 . G <*> 0 . DP=28;I16=5,21,0,0,923,34103,0,0,1529,90841,0,0,498,10884,0,0;QS=3,0;MQSB=0.79189;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,163:6:0 0,15,132:5:0 +X 700 . A <*> 0 . DP=28;I16=6,22,0,0,989,35833,0,0,1618,95282,0,0,530,11626,0,0;QS=3,0;MQSB=0.904554;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,169:7:0 0,18,148:6:0 +X 701 . A <*> 0 . DP=29;I16=5,23,0,0,992,35956,0,0,1618,95282,0,0,517,11459,0,0;QS=3,0;MQSB=0.864394;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,186:7:0 0,18,144:6:0 +X 702 . A <*> 0 . DP=29;I16=5,23,0,0,1103,44105,0,0,1618,95282,0,0,520,11508,0,0;QS=3,0;MQSB=0.864394;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,204:7:0 0,18,159:6:0 +X 703 . G <*> 0 . DP=29;I16=5,23,0,0,1014,37508,0,0,1618,95282,0,0,522,11534,0,0;QS=3,0;MQSB=0.864394;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,172:7:0 0,18,144:6:0 +X 704 . A T,<*> 0 . DP=29;I16=4,23,1,0,954,34200,16,256,1558,91682,60,3600,499,10963,13,169;QS=2.97064,0.0293578,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.864394;BQB=1;MQ0F=0 PL:DP:DV 0,31,255,45,255,255:16:1 0,18,154,18,154,154:6:0 0,18,139,18,139,139:6:0 +X 705 . A <*> 0 . DP=29;I16=6,22,0,0,1042,39930,0,0,1618,95282,0,0,513,11189,0,0;QS=3,0;MQSB=0.904554;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,189:7:0 0,18,157:6:0 +X 706 . G <*> 0 . DP=30;I16=6,23,0,0,1029,37763,0,0,1678,98882,0,0,513,11225,0,0;QS=3,0;MQSB=0.900586;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,170:7:0 0,18,131:6:0 +X 707 . C <*> 0 . DP=30;I16=5,22,0,0,944,34494,0,0,1558,91682,0,0,464,10040,0,0;QS=3,0;MQSB=0.868709;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,131:5:0 0,18,134:6:0 +X 708 . C <*> 0 . DP=30;I16=6,24,0,0,898,27574,0,0,1738,102482,0,0,540,12010,0,0;QS=3,0;MQSB=0.896846;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,153:8:0 0,18,110:6:0 +X 709 . G <*> 0 . DP=29;I16=5,22,0,0,968,36130,0,0,1558,91682,0,0,507,11343,0,0;QS=3,0;MQSB=0.868709;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,178:8:0 0,15,132:5:0 +X 710 . G <*> 0 . DP=29;I16=5,23,0,0,961,34825,0,0,1618,95282,0,0,533,12029,0,0;QS=3,0;MQSB=0.864394;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,24,174:8:0 0,15,122:5:0 +X 711 . A <*> 0 . DP=29;I16=6,23,0,0,996,35700,0,0,1647,96123,0,0,565,12723,0,0;QS=3,0;MQSB=0.957107;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,171:7:0 0,18,142:6:0 +X 712 . C <*> 0 . DP=29;I16=6,23,0,0,1069,40863,0,0,1647,96123,0,0,565,12767,0,0;QS=3,0;MQSB=0.957107;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,156:7:0 0,18,146:6:0 +X 713 . T <*> 0 . DP=29;I16=6,23,0,0,1072,40426,0,0,1647,96123,0,0,565,12835,0,0;QS=3,0;MQSB=0.957107;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,187:7:0 0,18,149:6:0 +X 714 . C <*> 0 . DP=28;I16=6,21,0,0,988,37236,0,0,1558,91682,0,0,541,12301,0,0;QS=3,0;MQSB=0.90877;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,153:6:0 0,15,125:5:0 +X 715 . A <*> 0 . DP=28;I16=6,20,0,0,884,31414,0,0,1498,88082,0,0,522,12004,0,0;QS=3,0;MQSB=0.913254;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,138:6:0 0,15,120:5:0 +X 716 . C <*> 0 . DP=29;I16=4,23,0,0,998,37756,0,0,1527,88923,0,0,547,12501,0,0;QS=3,0;MQSB=0.877203;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,141:5:0 0,18,145:6:0 +X 717 . A <*> 0 . DP=31;I16=8,23,0,0,1136,42928,0,0,1767,103323,0,0,574,13254,0,0;QS=3,0;MQSB=0.987595;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,212:8:0 0,18,153:6:0 +X 718 . G <*> 0 . DP=29;I16=7,22,0,0,1066,40006,0,0,1647,96123,0,0,579,13407,0,0;QS=3,0;MQSB=0.979435;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,24,223:8:0 0,18,139:6:0 +X 719 . G <*> 0 . DP=29;I16=7,19,0,0,952,35868,0,0,1529,90841,0,0,510,11756,0,0;QS=3,0;MQSB=0.860025;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,204:8:0 0,12,120:4:0 +X 720 . G <*> 0 . DP=28;I16=6,20,0,0,986,37838,0,0,1467,85323,0,0,552,12940,0,0;QS=3,0;MQSB=0.970805;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,216:8:0 0,18,147:6:0 +X 721 . C <*> 0 . DP=28;I16=6,21,0,0,989,36901,0,0,1527,88923,0,0,567,13183,0,0;QS=3,0;MQSB=0.966147;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,24,197:8:0 0,18,147:6:0 +X 722 . A <*> 0 . DP=28;I16=6,21,0,0,949,33837,0,0,1527,88923,0,0,569,13225,0,0;QS=3,0;MQSB=0.966147;MQ0F=0 PL:DP:DV 0,39,244:13:0 0,24,205:8:0 0,18,143:6:0 +X 723 . A <*> 0 . DP=28;I16=6,19,0,0,925,34825,0,0,1438,84482,0,0,530,12366,0,0;QS=3,0;MQSB=0.918029;MQ0F=0 PL:DP:DV 0,36,253:12:0 0,24,206:8:0 0,15,135:5:0 +X 724 . C <*> 0 . DP=28;I16=5,22,0,0,967,35983,0,0,1527,88923,0,0,566,13028,0,0;QS=3,0;MQSB=0.932273;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,21,161:7:0 0,18,140:6:0 +X 725 . A <*> 0 . DP=28;I16=6,21,0,0,911,31971,0,0,1527,88923,0,0,565,12987,0,0;QS=3,0;MQSB=0.966147;MQ0F=0 PL:DP:DV 0,42,246:14:0 0,21,168:7:0 0,18,137:6:0 +X 726 . C <*> 0 . DP=28;I16=6,21,0,0,947,34531,0,0,1527,88923,0,0,563,12919,0,0;QS=3,0;MQSB=0.966147;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,21,166:7:0 0,18,136:6:0 +X 727 . A C,<*> 0 . DP=28;I16=6,20,0,1,904,32194,17,289,1498,88082,29,841,535,12199,25,625;QS=2.90811,0.0918919,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.966147;BQB=1;MQ0F=0 PL:DP:DV 0,42,247,42,247,247:14:0 0,21,191,21,191,191:7:0 0,1,109,15,112,119:6:1 +X 728 . C <*> 0 . DP=29;I16=6,22,0,0,1018,37990,0,0,1587,92523,0,0,557,12701,0,0;QS=3,0;MQSB=0.961573;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,208:8:0 0,18,142:6:0 +X 729 . T <*> 0 . DP=29;I16=7,22,0,0,1063,39315,0,0,1647,96123,0,0,581,13227,0,0;QS=3,0;MQSB=0.979435;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,244:9:0 0,18,142:6:0 +X 730 . A <*> 0 . DP=29;I16=7,21,0,0,993,35883,0,0,1618,95282,0,0,555,12529,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,219:9:0 0,15,135:5:0 +X 731 . T <*> 0 . DP=29;I16=7,22,0,0,1024,37312,0,0,1647,96123,0,0,578,13058,0,0;QS=3,0;MQSB=0.979435;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,210:9:0 0,18,148:6:0 +X 732 . C <*> 0 . DP=29;I16=7,21,0,0,1006,37058,0,0,1618,95282,0,0,550,12314,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,219:9:0 0,15,129:5:0 +X 733 . T <*> 0 . DP=29;I16=7,21,0,0,985,35497,0,0,1618,95282,0,0,547,12221,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,222:9:0 0,15,134:5:0 +X 734 . G <*> 0 . DP=29;I16=7,21,0,0,997,36453,0,0,1587,92523,0,0,544,12154,0,0;QS=3,0;MQSB=0.982906;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,204:8:0 0,18,139:6:0 +X 735 . A <*> 0 . DP=30;I16=7,21,0,0,963,33993,0,0,1618,95282,0,0,515,11437,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,190:8:0 0,18,148:6:0 +X 736 . C <*> 0 . DP=30;I16=8,20,0,0,1042,39326,0,0,1618,95282,0,0,512,11320,0,0;QS=3,0;MQSB=0.954515;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,218:8:0 0,18,152:6:0 +X 737 . T <*> 0 . DP=30;I16=8,22,0,0,1071,39825,0,0,1707,99723,0,0,560,12480,0,0;QS=3,0;MQSB=0.990151;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,243:9:0 0,21,149:7:0 +X 738 . G <*> 0 . DP=30;I16=8,21,0,0,1016,36816,0,0,1678,98882,0,0,533,11793,0,0;QS=3,0;MQSB=0.950946;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,210:9:0 0,18,141:6:0 +X 739 . T <*> 0 . DP=30;I16=7,22,0,0,1020,37326,0,0,1647,96123,0,0,534,11900,0,0;QS=3,0;MQSB=0.979435;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,202:8:0 0,21,155:7:0 +X 740 . T <*> 0 . DP=29;I16=7,21,0,0,1011,37465,0,0,1587,92523,0,0,532,11848,0,0;QS=3,0;MQSB=0.982906;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,24,232:8:0 0,21,155:7:0 +X 741 . T <*> 0 . DP=29;I16=7,21,0,0,984,36052,0,0,1587,92523,0,0,528,11722,0,0;QS=3,0;MQSB=0.982906;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,24,224:8:0 0,21,151:7:0 +X 742 . C <*> 0 . DP=30;I16=8,21,0,0,1046,39056,0,0,1678,98882,0,0,525,11671,0,0;QS=3,0;MQSB=0.950946;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,243:9:0 0,18,136:6:0 +X 743 . A <*> 0 . DP=30;I16=8,21,0,0,1026,37156,0,0,1678,98882,0,0,520,11500,0,0;QS=3,0;MQSB=0.950946;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,239:9:0 0,18,131:6:0 +X 744 . T <*> 0 . DP=30;I16=8,22,0,0,1100,41010,0,0,1707,99723,0,0,540,11984,0,0;QS=3,0;MQSB=0.990151;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,247:9:0 0,21,154:7:0 +X 745 . G <*> 0 . DP=31;I16=9,22,0,0,1078,38890,0,0,1767,103323,0,0,535,11873,0,0;QS=3,0;MQSB=0.996219;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,227:9:0 0,24,178:8:0 +X 746 . G <*> 0 . DP=31;I16=9,21,0,0,1001,35191,0,0,1707,99723,0,0,531,11793,0,0;QS=3,0;MQSB=0.997698;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,27,201:9:0 0,24,178:8:0 +X 747 . G <*> 0 . DP=30;I16=9,20,0,0,1017,36831,0,0,1647,96123,0,0,509,11343,0,0;QS=3,0;MQSB=0.99889;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,201:8:0 0,21,174:7:0 +X 748 . A <*> 0 . DP=30;I16=10,20,0,0,1046,37438,0,0,1707,99723,0,0,529,11721,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,27,242:9:0 0,18,159:6:0 +X 749 . A <*> 0 . DP=31;I16=10,21,0,0,1077,38303,0,0,1767,103323,0,0,530,11728,0,0;QS=3,0;MQSB=0.999777;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,27,240:9:0 0,18,164:6:0 +X 750 . A <*> 0 . DP=32;I16=10,20,0,0,1129,43093,0,0,1738,102482,0,0,500,11252,0,0;QS=3,0;MQSB=0.976097;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,232:8:0 0,15,161:5:0 +X 751 . G <*> 0 . DP=31;I16=11,20,0,0,1065,37955,0,0,1767,103323,0,0,535,11787,0,0;QS=3,0;MQSB=0.999148;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,27,206:9:0 0,18,150:6:0 +X 752 . T <*> 0 . DP=31;I16=11,20,0,0,1034,35786,0,0,1767,103323,0,0,537,11793,0,0;QS=3,0;MQSB=0.999148;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,27,223:9:0 0,18,143:6:0 +X 753 . C <*> 0 . DP=31;I16=12,19,0,0,1073,38779,0,0,1767,103323,0,0,540,11834,0,0;QS=3,0;MQSB=0.994873;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,30,227:10:0 0,18,158:6:0 +X 754 . T <*> 0 . DP=31;I16=12,19,0,0,1135,42527,0,0,1767,103323,0,0,542,11808,0,0;QS=3,0;MQSB=0.994873;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,30,255:10:0 0,18,172:6:0 +X 755 . G <*> 0 . DP=31;I16=12,19,0,0,1157,43695,0,0,1767,103323,0,0,544,11814,0,0;QS=3,0;MQSB=0.994873;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,30,255:10:0 0,18,162:6:0 +X 756 . G <*> 0 . DP=30;I16=12,17,0,0,1002,35566,0,0,1647,96123,0,0,539,11753,0,0;QS=3,0;MQSB=0.988062;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,30,242:10:0 0,18,157:6:0 +X 757 . A <*> 0 . DP=30;I16=12,17,0,0,1035,37723,0,0,1678,98882,0,0,523,11197,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,30,248:10:0 0,15,152:5:0 +X 758 . A <*> 0 . DP=30;I16=12,18,0,0,1015,35685,0,0,1707,99723,0,0,549,11825,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,30,247:10:0 0,18,156:6:0 +X 759 . A <*> 0 . DP=30;I16=12,16,0,0,998,36498,0,0,1618,95282,0,0,526,11472,0,0;QS=3,0;MQSB=0.995699;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,242:9:0 0,15,151:5:0 +X 760 . C <*> 0 . DP=31;I16=12,18,0,0,916,29466,0,0,1707,99723,0,0,547,11741,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,30,217:10:0 0,18,128:6:0 +X 761 . G <*> 0 . DP=30;I16=11,16,0,0,932,32884,0,0,1589,94441,0,0,512,11028,0,0;QS=3,0;MQSB=0.925036;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,27,220:9:0 0,15,153:5:0 +X 762 . G <*> 0 . DP=29;I16=11,18,0,0,1012,36984,0,0,1647,96123,0,0,541,11629,0,0;QS=3,0;MQSB=0.995968;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,27,220:9:0 0,21,173:7:0 +X 763 . C A,<*> 0 . DP=29;I16=11,16,0,1,948,35124,15,225,1558,91682,29,841,527,11473,2,4;QS=2.93697,0.0630252,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.993109;BQB=1;MQ0F=0 PL:DP:DV 0,39,255,39,255,255:13:0 0,24,193,24,193,193:8:0 0,6,158,18,161,165:7:1 +X 764 . A <*> 0 . DP=31;I16=12,18,0,0,1051,37737,0,0,1738,102482,0,0,516,11020,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,30,250:10:0 0,18,163:6:0 +X 765 . A <*> 0 . DP=32;I16=12,18,0,0,1071,39369,0,0,1738,102482,0,0,525,11379,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,30,254:10:0 0,18,169:6:0 +X 766 . C <*> 0 . DP=31;I16=13,18,0,0,1065,38285,0,0,1798,106082,0,0,547,11797,0,0;QS=3,0;MQSB=0.995005;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,33,235:11:0 0,18,164:6:0 +X 767 . A <*> 0 . DP=30;I16=12,18,0,0,996,34692,0,0,1738,102482,0,0,552,11926,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,33,244:11:0 0,18,148:6:0 +X 768 . C <*> 0 . DP=30;I16=12,18,0,0,1095,40739,0,0,1738,102482,0,0,556,12038,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,33,255:11:0 0,18,173:6:0 +X 769 . C <*> 0 . DP=30;I16=12,18,0,0,1110,42272,0,0,1738,102482,0,0,559,12133,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,33,255:11:0 0,18,173:6:0 +X 770 . A <*> 0 . DP=30;I16=12,18,0,0,1098,40852,0,0,1738,102482,0,0,562,12262,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,33,255:11:0 0,18,171:6:0 +X 771 . T <*> 0 . DP=30;I16=12,18,0,0,1111,41771,0,0,1738,102482,0,0,563,12325,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,33,255:11:0 0,18,177:6:0 +X 772 . T <*> 0 . DP=30;I16=12,18,0,0,1107,41429,0,0,1738,102482,0,0,563,12373,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,33,255:11:0 0,18,176:6:0 +X 773 . G <*> 0 . DP=30;I16=12,18,0,0,1123,42761,0,0,1738,102482,0,0,562,12406,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,33,255:11:0 0,18,175:6:0 +X 774 . A <*> 0 . DP=30;I16=12,18,0,0,1151,44801,0,0,1738,102482,0,0,560,12422,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,33,255:11:0 0,18,179:6:0 +X 775 . G <*> 0 . DP=30;I16=12,18,0,0,1136,43766,0,0,1738,102482,0,0,557,12419,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,33,255:11:0 0,18,177:6:0 +X 776 . A <*> 0 . DP=29;I16=12,17,0,0,1053,38865,0,0,1678,98882,0,0,553,12345,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,30,255:10:0 0,18,169:6:0 +X 777 . C <*> 0 . DP=28;I16=12,16,0,0,1019,37631,0,0,1618,95282,0,0,550,12298,0,0;QS=3,0;MQSB=0.995699;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,27,229:9:0 0,18,165:6:0 +X 778 . A <*> 0 . DP=28;I16=12,16,0,0,1079,42041,0,0,1618,95282,0,0,547,12277,0,0;QS=3,0;MQSB=0.995699;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,27,241:9:0 0,18,181:6:0 +X 779 . G <*> 0 . DP=28;I16=12,16,0,0,1025,38825,0,0,1618,95282,0,0,543,12231,0,0;QS=3,0;MQSB=0.995699;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,27,231:9:0 0,18,170:6:0 +X 780 . A <*> 0 . DP=28;I16=12,16,0,0,1005,36773,0,0,1618,95282,0,0,538,12160,0,0;QS=3,0;MQSB=0.995699;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,27,242:9:0 0,18,166:6:0 +X 781 . A <*> 0 . DP=28;I16=12,15,0,0,965,35857,0,0,1589,94441,0,0,519,11889,0,0;QS=3,0;MQSB=0.935229;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,222:8:0 0,15,159:5:0 +X 782 . A <*> 0 . DP=28;I16=12,16,0,0,1003,37315,0,0,1618,95282,0,0,530,12044,0,0;QS=3,0;MQSB=0.995699;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,229:8:0 0,18,171:6:0 +X 783 . A <*> 0 . DP=28;I16=12,16,0,0,989,36477,0,0,1618,95282,0,0,527,12001,0,0;QS=3,0;MQSB=0.995699;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,24,230:8:0 0,21,178:7:0 +X 784 . C <*> 0 . DP=26;I16=11,15,0,0,967,36387,0,0,1498,88082,0,0,527,11983,0,0;QS=3,0;MQSB=0.994627;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,207:7:0 0,21,178:7:0 +X 785 . A <*> 0 . DP=26;I16=11,15,0,0,989,38499,0,0,1498,88082,0,0,527,11989,0,0;QS=3,0;MQSB=0.994627;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,213:7:0 0,21,187:7:0 +X 786 . G <*> 0 . DP=26;I16=11,14,0,0,938,35698,0,0,1438,84482,0,0,501,11343,0,0;QS=3,0;MQSB=0.996634;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,211:7:0 0,21,180:7:0 +X 787 . G <*> 0 . DP=26;I16=11,15,0,0,914,33428,0,0,1498,88082,0,0,525,11969,0,0;QS=3,0;MQSB=0.994627;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,189:7:0 0,21,175:7:0 +X 788 . T <*> 0 . DP=26;I16=11,15,0,0,913,33357,0,0,1498,88082,0,0,524,11992,0,0;QS=3,0;MQSB=0.994627;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,180:7:0 0,21,188:7:0 +X 789 . G <*> 0 . DP=26;I16=11,15,0,0,963,36645,0,0,1498,88082,0,0,523,12037,0,0;QS=3,0;MQSB=0.994627;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,193:7:0 0,21,183:7:0 +X 790 . A <*> 0 . DP=26;I16=11,15,0,0,999,39113,0,0,1498,88082,0,0,520,12002,0,0;QS=3,0;MQSB=0.994627;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,198:7:0 0,21,201:7:0 +X 791 . G <*> 0 . DP=26;I16=11,15,0,0,934,34208,0,0,1498,88082,0,0,516,11934,0,0;QS=3,0;MQSB=0.994627;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,180:7:0 0,21,172:7:0 +X 792 . T <*> 0 . DP=26;I16=11,15,0,0,895,32009,0,0,1498,88082,0,0,511,11833,0,0;QS=3,0;MQSB=0.994627;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,184:7:0 0,21,172:7:0 +X 793 . G <*> 0 . DP=27;I16=11,15,0,0,965,36389,0,0,1498,88082,0,0,504,11652,0,0;QS=3,0;MQSB=0.994627;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,193:7:0 0,21,170:7:0 +X 794 . G <*> 0 . DP=26;I16=11,15,0,0,888,31804,0,0,1498,88082,0,0,508,11592,0,0;QS=3,0;MQSB=0.994627;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,198:8:0 0,18,161:6:0 +X 795 . T <*> 0 . DP=26;I16=9,15,0,0,859,31399,0,0,1409,83641,0,0,472,10908,0,0;QS=3,0;MQSB=0.96464;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,211:7:0 0,18,160:6:0 +X 796 . T <*> 0 . DP=27;I16=11,16,0,0,907,31641,0,0,1558,91682,0,0,499,11375,0,0;QS=3,0;MQSB=0.992419;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,27,221:9:0 0,15,150:5:0 +X 797 . G <*> 0 . DP=26;I16=11,15,0,0,882,31700,0,0,1529,90841,0,0,498,11298,0,0;QS=3,0;MQSB=0.927041;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,27,215:9:0 0,12,135:4:0 +X 798 . C <*> 0 . DP=26;I16=9,15,0,0,806,28552,0,0,1440,86400,0,0,466,10582,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,207:8:0 0,12,126:4:0 +X 799 . C <*> 0 . DP=26;I16=10,15,0,0,947,36407,0,0,1500,90000,0,0,491,11185,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,234:9:0 0,12,137:4:0 +X 800 . T <*> 0 . DP=26;I16=11,15,0,0,993,38475,0,0,1529,90841,0,0,495,11199,0,0;QS=3,0;MQSB=0.927041;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,27,255:9:0 0,12,139:4:0 +X 801 . G <*> 0 . DP=25;I16=11,14,0,0,938,35854,0,0,1469,87241,0,0,495,11209,0,0;QS=3,0;MQSB=0.929204;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,240:9:0 0,12,145:4:0 +X 802 . G <*> 0 . DP=25;I16=11,14,0,0,892,32802,0,0,1469,87241,0,0,495,11239,0,0;QS=3,0;MQSB=0.929204;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,229:9:0 0,12,137:4:0 +X 803 . G <*> 0 . DP=25;I16=11,14,0,0,906,33502,0,0,1469,87241,0,0,495,11289,0,0;QS=3,0;MQSB=0.929204;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,237:9:0 0,12,136:4:0 +X 804 . G <*> 0 . DP=25;I16=11,12,0,0,868,33326,0,0,1349,80041,0,0,466,10846,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,223:8:0 0,12,138:4:0 +X 805 . C <*> 0 . DP=24;I16=9,14,0,0,810,29684,0,0,1380,82800,0,0,482,11208,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,220:8:0 0,12,128:4:0 +X 806 . C <*> 0 . DP=25;I16=9,14,0,0,814,29856,0,0,1380,82800,0,0,483,11293,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,214:8:0 0,12,122:4:0 +X 807 . A <*> 0 . DP=25;I16=10,15,0,0,939,35997,0,0,1500,90000,0,0,503,11525,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,242:9:0 0,12,146:4:0 +X 808 . G <*> 0 . DP=25;I16=10,15,0,0,918,34720,0,0,1500,90000,0,0,505,11591,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,238:9:0 0,12,136:4:0 +X 809 . G <*> 0 . DP=25;I16=10,15,0,0,926,34932,0,0,1500,90000,0,0,506,11626,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,226:9:0 0,12,136:4:0 +X 810 . G C,<*> 0 . DP=25;I16=10,13,0,1,824,30436,14,196,1380,82800,60,3600,480,11288,14,196;QS=2.96552,0.0344828,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=1;BQB=1;MQ0F=0 PL:DP:DV 0,21,255,33,255,255:12:1 0,24,216,24,216,216:8:0 0,12,132,12,132,132:4:0 +X 811 . A <*> 0 . DP=25;I16=9,14,0,0,808,29404,0,0,1380,82800,0,0,484,11294,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,204:7:0 0,12,139:4:0 +X 812 . A <*> 0 . DP=25;I16=10,15,0,0,831,29515,0,0,1500,90000,0,0,500,11392,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,216:9:0 0,12,139:4:0 +X 813 . C <*> 0 . DP=25;I16=10,15,0,0,915,34093,0,0,1500,90000,0,0,497,11307,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,239:9:0 0,12,138:4:0 +X 814 . T <*> 0 . DP=25;I16=10,15,0,0,987,39343,0,0,1500,90000,0,0,494,11244,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,255:9:0 0,12,148:4:0 +X 815 . T <*> 0 . DP=25;I16=10,15,0,0,894,32670,0,0,1500,90000,0,0,491,11203,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,235:9:0 0,12,143:4:0 +X 816 . T <*> 0 . DP=25;I16=10,15,0,0,898,32990,0,0,1500,90000,0,0,488,11184,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,239:9:0 0,12,136:4:0 +X 817 . C <*> 0 . DP=24;I16=10,14,0,0,898,34256,0,0,1440,86400,0,0,485,11137,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,235:9:0 0,12,124:4:0 +X 818 . T <*> 0 . DP=23;I16=9,14,0,0,883,34371,0,0,1380,82800,0,0,484,11110,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,225:8:0 0,12,143:4:0 +X 819 . G <*> 0 . DP=23;I16=9,13,0,0,832,31932,0,0,1320,79200,0,0,461,10573,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,24,217:8:0 0,12,142:4:0 +X 820 . G <*> 0 . DP=24;I16=10,14,0,0,844,30848,0,0,1440,86400,0,0,484,11114,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,230:9:0 0,12,135:4:0 +X 821 . G <*> 0 . DP=24;I16=10,14,0,0,852,31572,0,0,1440,86400,0,0,484,11098,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,234:9:0 0,12,142:4:0 +X 822 . G <*> 0 . DP=25;I16=10,15,0,0,879,31785,0,0,1500,90000,0,0,481,10955,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,220:9:0 0,12,127:4:0 +X 823 . T <*> 0 . DP=25;I16=10,15,0,0,844,29686,0,0,1500,90000,0,0,478,10786,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,217:9:0 0,12,127:4:0 +X 824 . C <*> 0 . DP=25;I16=9,14,0,0,824,30252,0,0,1380,82800,0,0,427,9477,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,215:9:0 0,9,98:3:0 +X 825 . A <*> 0 . DP=25;I16=10,15,0,0,881,31665,0,0,1500,90000,0,0,467,10277,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,234:9:0 0,12,116:4:0 +X 826 . T <*> 0 . DP=25;I16=10,15,0,0,826,28364,0,0,1500,90000,0,0,461,10039,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,250:12:0 0,27,232:9:0 0,12,117:4:0 +X 827 . A <*> 0 . DP=25;I16=10,15,0,0,851,29477,0,0,1500,90000,0,0,455,9829,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,227:9:0 0,12,123:4:0 +X 828 . T C,<*> 0 . DP=25;I16=2,4,8,11,199,6917,656,23340,360,21600,1140,68400,116,2716,333,6931;QS=0.597777,2.40222,0;VDB=0.842082;SGB=-4.20907;RPB=0.950652;MQB=1;MQSB=1;BQB=0.929717;MQ0F=0 PL:DP:DV 211,0,35,217,65,255:12:10 116,0,91,128,106,213:9:5 120,12,0,120,12,120:4:4 +X 829 . T <*> 0 . DP=24;I16=10,13,0,0,863,32931,0,0,1380,82800,0,0,418,8818,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,242:8:0 0,12,132:4:0 +X 830 . C <*> 0 . DP=24;I16=10,14,0,0,910,34966,0,0,1440,86400,0,0,437,9267,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,220:8:0 0,12,134:4:0 +X 831 . T <*> 0 . DP=24;I16=10,14,0,0,906,34886,0,0,1440,86400,0,0,431,9119,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,243:8:0 0,12,133:4:0 +X 832 . C <*> 0 . DP=24;I16=10,14,0,0,888,33634,0,0,1440,86400,0,0,425,8999,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,220:8:0 0,12,123:4:0 +X 833 . T <*> 0 . DP=25;I16=10,14,0,0,820,29920,0,0,1440,86400,0,0,418,8856,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,224:8:0 0,12,113:4:0 +X 834 . G A,<*> 0 . DP=25;I16=2,3,7,10,164,5898,590,21124,300,18000,1020,61200,104,2296,305,6441;QS=0.520056,2.47994,0;VDB=0.788006;SGB=-4.01214;RPB=0.999233;MQB=1;MQSB=1;BQB=0.821668;MQ0F=0 PL:DP:DV 185,0,46,191,73,246:11:9 128,0,59,137,74,193:8:5 89,9,0,89,9,89:3:3 +X 835 . T <*> 0 . DP=26;I16=9,15,0,0,767,26675,0,0,1440,86400,0,0,406,8652,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,240:12:0 0,24,213:8:0 0,12,98:4:0 +X 836 . G <*> 0 . DP=23;I16=8,15,0,0,833,30561,0,0,1380,82800,0,0,403,8541,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,243:11:0 0,24,214:8:0 0,12,130:4:0 +X 837 . T <*> 0 . DP=23;I16=8,15,0,0,843,31499,0,0,1380,82800,0,0,400,8456,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,241:11:0 0,24,221:8:0 0,12,143:4:0 +X 838 . T <*> 0 . DP=23;I16=8,15,0,0,870,33172,0,0,1380,82800,0,0,397,8397,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,252:11:0 0,24,224:8:0 0,12,134:4:0 +X 839 . G <*> 0 . DP=24;I16=8,15,0,0,862,32774,0,0,1380,82800,0,0,393,8315,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,249:11:0 0,24,212:8:0 0,12,142:4:0 +X 840 . A <*> 0 . DP=25;I16=9,15,0,0,876,32682,0,0,1440,86400,0,0,375,7731,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,243:11:0 0,21,196:7:0 0,18,180:6:0 +X 841 . T <*> 0 . DP=25;I16=9,16,0,0,861,30879,0,0,1500,90000,0,0,396,8260,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,213:11:0 0,24,226:8:0 0,18,185:6:0 +X 842 . T <*> 0 . DP=24;I16=9,15,0,0,872,31990,0,0,1440,86400,0,0,393,8199,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,227:10:0 0,24,231:8:0 0,18,175:6:0 +X 843 . C <*> 0 . DP=24;I16=9,15,0,0,844,30604,0,0,1440,86400,0,0,390,8172,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,228:10:0 0,24,229:8:0 0,18,160:6:0 +X 844 . T <*> 0 . DP=24;I16=9,15,0,0,900,34094,0,0,1440,86400,0,0,386,8128,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,227:10:0 0,24,238:8:0 0,18,189:6:0 +X 845 . G <*> 0 . DP=25;I16=10,15,0,0,916,33866,0,0,1500,90000,0,0,382,8116,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,239:10:0 0,24,225:8:0 0,21,196:7:0 +X 846 . G <*> 0 . DP=24;I16=9,14,0,0,802,28414,0,0,1380,82800,0,0,354,7460,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,223:9:0 0,24,208:8:0 0,18,164:6:0 +X 847 . T <*> 0 . DP=24;I16=8,15,0,0,809,29007,0,0,1380,82800,0,0,377,8083,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,210:9:0 0,24,219:8:0 0,18,149:6:0 +X 848 . G <*> 0 . DP=23;I16=8,15,0,0,829,30351,0,0,1380,82800,0,0,384,8138,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,199:8:0 0,27,243:9:0 0,18,167:6:0 +X 849 . G <*> 0 . DP=22;I16=8,12,0,0,684,23844,0,0,1200,72000,0,0,349,7517,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,160:6:0 0,27,233:9:0 0,15,140:5:0 +X 850 . T <*> 0 . DP=21;I16=6,14,0,0,706,25508,0,0,1200,72000,0,0,360,7568,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,153:6:0 0,24,226:8:0 0,18,147:6:0 +X 851 . G <*> 0 . DP=21;I16=7,14,0,0,707,24667,0,0,1260,75600,0,0,386,8254,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,140:6:0 0,27,233:9:0 0,18,156:6:0 +X 852 . G <*> 0 . DP=21;I16=7,13,0,0,687,24223,0,0,1200,72000,0,0,368,7976,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,147:6:0 0,27,222:9:0 0,15,146:5:0 +X 853 . A <*> 0 . DP=21;I16=7,14,0,0,721,25603,0,0,1260,75600,0,0,388,8442,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,146:6:0 0,27,223:9:0 0,18,166:6:0 +X 854 . A <*> 0 . DP=21;I16=7,14,0,0,725,25843,0,0,1260,75600,0,0,389,8517,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,179:7:0 0,24,209:8:0 0,18,168:6:0 +X 855 . A <*> 0 . DP=21;I16=7,14,0,0,683,23803,0,0,1260,75600,0,0,391,8611,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,171:7:0 0,24,204:8:0 0,18,152:6:0 +X 856 . C <*> 0 . DP=21;I16=7,14,0,0,763,28293,0,0,1260,75600,0,0,392,8676,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,192:7:0 0,24,222:8:0 0,18,172:6:0 +X 857 . A <*> 0 . DP=22;I16=8,14,0,0,786,28480,0,0,1320,79200,0,0,393,8763,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,182:7:0 0,24,220:8:0 0,21,194:7:0 +X 858 . A <*> 0 . DP=22;I16=8,14,0,0,816,31358,0,0,1320,79200,0,0,395,8873,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,192:7:0 0,24,236:8:0 0,21,198:7:0 +X 859 . G <*> 0 . DP=22;I16=8,14,0,0,824,31356,0,0,1320,79200,0,0,395,8907,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,202:7:0 0,24,223:8:0 0,21,203:7:0 +X 860 . A <*> 0 . DP=22;I16=8,13,0,0,743,26985,0,0,1260,75600,0,0,369,8291,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,184:7:0 0,21,202:7:0 0,21,190:7:0 +X 861 . C <*> 0 . DP=22;I16=8,14,0,0,770,28376,0,0,1320,79200,0,0,393,8899,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,206:8:0 0,24,216:8:0 0,18,161:6:0 +X 862 . T <*> 0 . DP=22;I16=8,14,0,0,762,27500,0,0,1320,79200,0,0,393,8905,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,188:8:0 0,24,213:8:0 0,18,177:6:0 +X 863 . G <*> 0 . DP=23;I16=9,14,0,0,836,30660,0,0,1380,82800,0,0,393,8935,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,228:9:0 0,24,221:8:0 0,18,180:6:0 +X 864 . T <*> 0 . DP=22;I16=9,13,0,0,795,29085,0,0,1320,79200,0,0,395,8989,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,215:8:0 0,24,221:8:0 0,18,180:6:0 +X 865 . C <*> 0 . DP=22;I16=8,14,0,0,785,28475,0,0,1320,79200,0,0,397,9015,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,227:9:0 0,21,193:7:0 0,18,177:6:0 +X 866 . C <*> 0 . DP=21;I16=7,13,0,0,694,24890,0,0,1200,72000,0,0,395,8985,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,220:8:0 0,18,149:6:0 0,18,177:6:0 +X 867 . C <*> 0 . DP=21;I16=7,14,0,0,761,28443,0,0,1260,75600,0,0,403,9023,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,223:9:0 0,18,182:6:0 0,18,187:6:0 +X 868 . A <*> 0 . DP=21;I16=7,14,0,0,799,31183,0,0,1260,75600,0,0,406,9054,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,228:9:0 0,18,189:6:0 0,18,202:6:0 +X 869 . G <*> 0 . DP=21;I16=7,14,0,0,795,30733,0,0,1260,75600,0,0,409,9103,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,236:9:0 0,18,190:6:0 0,18,187:6:0 +X 870 . C <*> 0 . DP=21;I16=7,13,0,0,758,29080,0,0,1200,72000,0,0,403,9089,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,226:8:0 0,18,183:6:0 0,18,187:6:0 +X 871 . C <*> 0 . DP=21;I16=7,14,0,0,769,29383,0,0,1260,75600,0,0,413,9155,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,232:9:0 0,18,176:6:0 0,18,192:6:0 +X 872 . T <*> 0 . DP=21;I16=7,14,0,0,785,29879,0,0,1260,75600,0,0,413,9109,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,228:9:0 0,18,187:6:0 0,18,188:6:0 +X 873 . G <*> 0 . DP=21;I16=7,14,0,0,768,28506,0,0,1260,75600,0,0,413,9083,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,233:9:0 0,18,172:6:0 0,18,182:6:0 +X 874 . G <*> 0 . DP=21;I16=7,12,0,0,700,26434,0,0,1140,68400,0,0,374,8234,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,227:8:0 0,15,143:5:0 0,18,189:6:0 +X 875 . G <*> 0 . DP=21;I16=7,14,0,0,717,25659,0,0,1260,75600,0,0,411,8995,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,227:9:0 0,18,163:6:0 0,18,159:6:0 +X 876 . T <*> 0 . DP=21;I16=7,14,0,0,719,25261,0,0,1260,75600,0,0,410,8984,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,222:9:0 0,18,156:6:0 0,18,173:6:0 +X 877 . G <*> 0 . DP=21;I16=7,14,0,0,747,27419,0,0,1260,75600,0,0,409,8995,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,235:9:0 0,18,162:6:0 0,18,176:6:0 +X 878 . A <*> 0 . DP=21;I16=7,13,0,0,738,27650,0,0,1200,72000,0,0,391,8739,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,216:8:0 0,18,172:6:0 0,18,191:6:0 +X 879 . T <*> 0 . DP=21;I16=7,13,0,0,731,26927,0,0,1200,72000,0,0,389,8759,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,214:8:0 0,18,175:6:0 0,18,184:6:0 +X 880 . A <*> 0 . DP=21;I16=7,14,0,0,737,26481,0,0,1260,75600,0,0,405,9109,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,227:9:0 0,18,165:6:0 0,18,172:6:0 +X 881 . C <*> 0 . DP=20;I16=7,13,0,0,742,27898,0,0,1200,72000,0,0,404,9154,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,231:8:0 0,18,164:6:0 0,18,183:6:0 +X 882 . A <*> 0 . DP=20;I16=7,13,0,0,776,30564,0,0,1200,72000,0,0,403,9217,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,225:8:0 0,18,188:6:0 0,18,200:6:0 +X 883 . G <*> 0 . DP=20;I16=7,13,0,0,702,25898,0,0,1200,72000,0,0,401,9247,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,214:8:0 0,18,175:6:0 0,18,176:6:0 +X 884 . C <*> 0 . DP=19;I16=7,12,0,0,629,21449,0,0,1140,68400,0,0,400,9292,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,201:8:0 0,18,155:6:0 0,15,144:5:0 +X 885 . G <*> 0 . DP=18;I16=7,11,0,0,605,20851,0,0,1080,64800,0,0,400,9350,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,215:8:0 0,15,140:5:0 0,15,130:5:0 +X 886 . A <*> 0 . DP=18;I16=7,11,0,0,681,26145,0,0,1080,64800,0,0,400,9420,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,222:8:0 0,15,164:5:0 0,15,163:5:0 +X 887 . G <*> 0 . DP=18;I16=7,11,0,0,631,22891,0,0,1080,64800,0,0,399,9451,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,222:8:0 0,15,138:5:0 0,15,149:5:0 +X 888 . A <*> 0 . DP=18;I16=7,10,0,0,593,21563,0,0,1020,61200,0,0,373,8867,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,216:8:0 0,15,132:5:0 0,12,127:4:0 +X 889 . C <*> 0 . DP=18;I16=7,11,0,0,624,22732,0,0,1080,64800,0,0,396,9492,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,213:8:0 0,15,134:5:0 0,15,160:5:0 +X 890 . C <*> 0 . DP=19;I16=7,11,0,0,616,22426,0,0,1080,64800,0,0,368,8826,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,215:8:0 0,15,138:5:0 0,15,152:5:0 +X 891 . C <*> 0 . DP=19;I16=7,11,0,0,661,24891,0,0,1080,64800,0,0,365,8745,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,227:8:0 0,15,141:5:0 0,15,165:5:0 +X 892 . C <*> 0 . DP=19;I16=7,12,0,0,691,25761,0,0,1140,68400,0,0,387,9299,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,230:9:0 0,15,146:5:0 0,15,167:5:0 +X 893 . A <*> 0 . DP=19;I16=7,12,0,0,673,24521,0,0,1140,68400,0,0,384,9238,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,221:9:0 0,15,142:5:0 0,15,166:5:0 +X 894 . T <*> 0 . DP=19;I16=7,12,0,0,670,24268,0,0,1140,68400,0,0,380,9138,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,225:9:0 0,15,134:5:0 0,15,165:5:0 +X 895 . C <*> 0 . DP=20;I16=8,12,0,0,712,26186,0,0,1200,72000,0,0,376,9050,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,248:10:0 0,15,149:5:0 0,15,162:5:0 +X 896 . T <*> 0 . DP=19;I16=8,10,0,0,684,26696,0,0,1080,64800,0,0,348,8300,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,238:9:0 0,12,141:4:0 0,15,180:5:0 +X 897 . C <*> 0 . DP=18;I16=8,10,0,0,693,27001,0,0,1080,64800,0,0,370,8764,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,12,131:4:0 0,15,166:5:0 +X 898 . T <*> 0 . DP=18;I16=8,10,0,0,674,25656,0,0,1080,64800,0,0,367,8617,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,243:9:0 0,12,125:4:0 0,15,172:5:0 +X 899 . A <*> 0 . DP=18;I16=9,8,0,0,597,21451,0,0,1020,61200,0,0,340,7858,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,239:9:0 0,9,99:3:0 0,15,145:5:0 +X 900 . C <*> 0 . DP=18;I16=9,9,0,0,658,24550,0,0,1080,64800,0,0,364,8362,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,98:3:0 0,15,166:5:0 +X 901 . C <*> 0 . DP=18;I16=9,9,0,0,680,26004,0,0,1080,64800,0,0,363,8255,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,99:3:0 0,15,169:5:0 +X 902 . A <*> 0 . DP=18;I16=9,9,0,0,681,26253,0,0,1080,64800,0,0,362,8162,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,253:10:0 0,9,115:3:0 0,15,174:5:0 +X 903 . A <*> 0 . DP=18;I16=9,8,0,0,645,24625,0,0,1020,61200,0,0,336,7458,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,250:9:0 0,9,101:3:0 0,15,171:5:0 +X 904 . A <*> 0 . DP=18;I16=9,9,0,0,640,23412,0,0,1080,64800,0,0,359,7969,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,249:10:0 0,9,85:3:0 0,15,174:5:0 +X 905 . A <*> 0 . DP=18;I16=9,9,0,0,675,25673,0,0,1080,64800,0,0,357,7871,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,103:3:0 0,15,172:5:0 +X 906 . A <*> 0 . DP=18;I16=9,9,0,0,669,25193,0,0,1080,64800,0,0,355,7789,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,102:3:0 0,15,166:5:0 +X 907 . A <*> 0 . DP=18;I16=9,9,0,0,661,24541,0,0,1080,64800,0,0,353,7723,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,94:3:0 0,15,165:5:0 +X 908 . T <*> 0 . DP=18;I16=9,9,0,0,673,25579,0,0,1080,64800,0,0,351,7673,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,83:3:0 0,15,168:5:0 +X 909 . T <*> 0 . DP=18;I16=9,9,0,0,653,23847,0,0,1080,64800,0,0,348,7590,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,95:3:0 0,15,161:5:0 +X 910 . A <*> 0 . DP=18;I16=9,9,0,0,652,23790,0,0,1080,64800,0,0,344,7476,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,248:10:0 0,9,104:3:0 0,15,162:5:0 +X 911 . A <*> 0 . DP=18;I16=9,9,0,0,688,26440,0,0,1080,64800,0,0,340,7382,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,109:3:0 0,15,168:5:0 +X 912 . A <*> 0 . DP=18;I16=9,9,0,0,691,26705,0,0,1080,64800,0,0,336,7308,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,115:3:0 0,15,173:5:0 +X 913 . A <*> 0 . DP=19;I16=9,10,0,0,692,25762,0,0,1140,68400,0,0,332,7254,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,109:3:0 0,15,171:5:0 +X 914 . A <*> 0 . DP=19;I16=9,10,0,0,712,26966,0,0,1140,68400,0,0,329,7221,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,109:3:0 0,15,164:5:0 +X 915 . T <*> 0 . DP=18;I16=9,9,0,0,638,23228,0,0,1080,64800,0,0,326,7160,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,247:10:0 0,9,99:3:0 0,15,163:5:0 +X 916 . T <*> 0 . DP=19;I16=9,8,0,0,626,23136,0,0,1020,61200,0,0,296,6396,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,241:9:0 0,9,103:3:0 0,15,164:5:0 +X 917 . A <*> 0 . DP=19;I16=9,10,0,0,726,27962,0,0,1117,66169,0,0,318,6908,0,0;QS=3,0;MQSB=0.934728;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,125:4:0 0,15,171:5:0 +X 918 . G <*> 0 . DP=19;I16=9,10,0,0,688,25456,0,0,1117,66169,0,0,314,6818,0,0;QS=3,0;MQSB=0.934728;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,129:4:0 0,15,147:5:0 +X 919 . C <*> 0 . DP=18;I16=8,10,0,0,672,25786,0,0,1057,62569,0,0,311,6751,0,0;QS=3,0;MQSB=0.938795;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,92:3:0 0,15,152:5:0 +X 920 . T <*> 0 . DP=18;I16=8,10,0,0,681,26113,0,0,1057,62569,0,0,308,6706,0,0;QS=3,0;MQSB=0.938795;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,95:3:0 0,15,171:5:0 +X 921 . G <*> 0 . DP=17;I16=7,10,0,0,617,22841,0,0,997,58969,0,0,304,6582,0,0;QS=3,0;MQSB=0.943335;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,6,47:2:0 0,15,164:5:0 +X 922 . G <*> 0 . DP=16;I16=7,8,0,0,560,21156,0,0,877,51769,0,0,276,5852,0,0;QS=3,0;MQSB=0.921243;MQ0F=0 PL:DP:DV 0,24,243:8:0 0,6,64:2:0 0,15,151:5:0 +X 923 . G <*> 0 . DP=16;I16=7,8,0,0,562,21350,0,0,877,51769,0,0,273,5765,0,0;QS=3,0;MQSB=0.921243;MQ0F=0 PL:DP:DV 0,24,245:8:0 0,6,65:2:0 0,15,144:5:0 +X 924 . C <*> 0 . DP=16;I16=7,9,0,0,603,22955,0,0,937,55369,0,0,295,6321,0,0;QS=3,0;MQSB=0.933674;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,6,57:2:0 0,15,157:5:0 +X 925 . A <*> 0 . DP=16;I16=7,9,0,0,576,21618,0,0,937,55369,0,0,291,6219,0,0;QS=3,0;MQSB=0.933674;MQ0F=0 PL:DP:DV 0,27,244:9:0 0,6,58:2:0 0,15,163:5:0 +X 926 . T <*> 0 . DP=16;I16=7,9,0,0,585,22015,0,0,937,55369,0,0,287,6133,0,0;QS=3,0;MQSB=0.933674;MQ0F=0 PL:DP:DV 0,27,241:9:0 0,6,63:2:0 0,15,161:5:0 +X 927 . G <*> 0 . DP=17;I16=7,10,0,0,641,24481,0,0,997,58969,0,0,283,6063,0,0;QS=3,0;MQSB=0.943335;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,9,82:3:0 0,15,158:5:0 +X 928 . G <*> 0 . DP=17;I16=7,10,0,0,625,23195,0,0,997,58969,0,0,280,6010,0,0;QS=3,0;MQSB=0.943335;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,9,84:3:0 0,15,150:5:0 +X 929 . T <*> 0 . DP=16;I16=7,9,0,0,580,21580,0,0,937,55369,0,0,277,5925,0,0;QS=3,0;MQSB=0.933674;MQ0F=0 PL:DP:DV 0,27,248:9:0 0,9,79:3:0 0,12,128:4:0 +X 930 . G <*> 0 . DP=16;I16=7,8,0,0,565,21561,0,0,877,51769,0,0,249,5233,0,0;QS=3,0;MQSB=0.921243;MQ0F=0 PL:DP:DV 0,24,247:8:0 0,9,82:3:0 0,12,127:4:0 +X 931 . G <*> 0 . DP=16;I16=7,9,0,0,553,19935,0,0,937,55369,0,0,271,5809,0,0;QS=3,0;MQSB=0.933674;MQ0F=0 PL:DP:DV 0,27,244:9:0 0,9,80:3:0 0,12,113:4:0 +X 932 . T <*> 0 . DP=16;I16=7,9,0,0,558,20128,0,0,937,55369,0,0,268,5778,0,0;QS=3,0;MQSB=0.933674;MQ0F=0 PL:DP:DV 0,27,229:9:0 0,9,89:3:0 0,12,122:4:0 +X 933 . G <*> 0 . DP=16;I16=7,8,0,0,558,20926,0,0,877,51769,0,0,239,5091,0,0;QS=3,0;MQSB=0.921243;MQ0F=0 PL:DP:DV 0,24,241:8:0 0,9,94:3:0 0,12,116:4:0 +X 934 . C <*> 0 . DP=15;I16=7,8,0,0,548,20256,0,0,877,51769,0,0,261,5673,0,0;QS=3,0;MQSB=0.921243;MQ0F=0 PL:DP:DV 0,27,244:9:0 0,9,83:3:0 0,9,99:3:0 +X 935 . A <*> 0 . DP=15;I16=7,8,0,0,534,19780,0,0,846,49010,0,0,259,5647,0,0;QS=3,0;MQSB=0.720273;MQ0F=0 PL:DP:DV 0,27,233:9:0 0,9,86:3:0 0,9,101:3:0 +X 936 . T <*> 0 . DP=15;I16=7,8,0,0,579,22499,0,0,846,49010,0,0,257,5589,0,0;QS=3,0;MQSB=0.720273;MQ0F=0 PL:DP:DV 0,27,252:9:0 0,9,91:3:0 0,9,100:3:0 +X 937 . G <*> 0 . DP=16;I16=8,7,0,0,550,20650,0,0,846,49010,0,0,232,5022,0,0;QS=3,0;MQSB=0.651439;MQ0F=0 PL:DP:DV 0,24,228:8:0 0,9,84:3:0 0,12,115:4:0 +X 938 . C <*> 0 . DP=16;I16=8,7,0,0,553,20669,0,0,846,49010,0,0,231,5001,0,0;QS=3,0;MQSB=0.651439;MQ0F=0 PL:DP:DV 0,24,234:8:0 0,9,77:3:0 0,12,119:4:0 +X 939 . C <*> 0 . DP=16;I16=8,8,0,0,582,22100,0,0,906,52610,0,0,250,5392,0,0;QS=3,0;MQSB=0.702619;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,9,71:3:0 0,12,115:4:0 +X 940 . T <*> 0 . DP=15;I16=8,7,0,0,583,23339,0,0,846,49010,0,0,248,5320,0,0;QS=3,0;MQSB=0.651439;MQ0F=0 PL:DP:DV 0,27,252:9:0 0,6,71:2:0 0,12,124:4:0 +X 941 . G <*> 0 . DP=14;I16=7,7,0,0,501,18707,0,0,786,45410,0,0,246,5216,0,0;QS=3,0;MQSB=0.714506;MQ0F=0 PL:DP:DV 0,27,240:9:0 0,6,59:2:0 0,9,93:3:0 +X 942 . T <*> 0 . DP=14;I16=7,7,0,0,525,19799,0,0,786,45410,0,0,244,5128,0,0;QS=3,0;MQSB=0.714506;MQ0F=0 PL:DP:DV 0,27,237:9:0 0,6,70:2:0 0,9,94:3:0 +X 943 . A <*> 0 . DP=14;I16=7,7,0,0,545,21399,0,0,786,45410,0,0,242,5056,0,0;QS=3,0;MQSB=0.714506;MQ0F=0 PL:DP:DV 0,27,248:9:0 0,6,71:2:0 0,9,93:3:0 +X 944 . G <*> 0 . DP=14;I16=7,7,0,0,529,20143,0,0,786,45410,0,0,240,5000,0,0;QS=3,0;MQSB=0.714506;MQ0F=0 PL:DP:DV 0,27,249:9:0 0,6,65:2:0 0,9,95:3:0 +X 945 . T <*> 0 . DP=14;I16=7,7,0,0,523,19621,0,0,786,45410,0,0,238,4960,0,0;QS=3,0;MQSB=0.714506;MQ0F=0 PL:DP:DV 0,27,239:9:0 0,6,70:2:0 0,9,95:3:0 +X 946 . C <*> 0 . DP=13;I16=6,6,0,0,455,17581,0,0,666,38210,0,0,223,4739,0,0;QS=3,0;MQSB=0.660716;MQ0F=0 PL:DP:DV 0,24,240:8:0 0,6,56:2:0 0,6,70:2:0 +X 947 . C <*> 0 . DP=14;I16=7,7,0,0,509,19007,0,0,755,42651,0,0,238,4928,0,0;QS=3,0;MQSB=0.925999;MQ0F=0 PL:DP:DV 0,27,251:9:0 0,9,83:3:0 0,6,66:2:0 +X 948 . C <*> 0 . DP=14;I16=7,7,0,0,520,20050,0,0,755,42651,0,0,237,4887,0,0;QS=3,0;MQSB=0.925999;MQ0F=0 PL:DP:DV 0,27,254:9:0 0,9,78:3:0 0,6,69:2:0 +X 949 . A <*> 0 . DP=15;I16=7,8,0,0,547,20705,0,0,815,46251,0,0,236,4864,0,0;QS=3,0;MQSB=0.959011;MQ0F=0 PL:DP:DV 0,30,250:10:0 0,9,90:3:0 0,6,72:2:0 +X 950 . G <*> 0 . DP=15;I16=6,8,0,0,563,22871,0,0,786,45410,0,0,231,4835,0,0;QS=3,0;MQSB=0.740818;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,6,71:2:0 0,6,72:2:0 +X 951 . C <*> 0 . DP=16;I16=7,8,0,0,554,21080,0,0,846,49010,0,0,230,4840,0,0;QS=3,0;MQSB=0.720273;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,65:2:0 0,6,73:2:0 +X 952 . T <*> 0 . DP=16;I16=8,8,0,0,595,22565,0,0,875,49851,0,0,237,4913,0,0;QS=3,0;MQSB=0.934676;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,93:3:0 0,6,73:2:0 +X 953 . A <*> 0 . DP=16;I16=8,8,0,0,567,20515,0,0,875,49851,0,0,237,4921,0,0;QS=3,0;MQSB=0.934676;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,91:3:0 0,6,69:2:0 +X 954 . T <*> 0 . DP=15;I16=7,8,0,0,544,20412,0,0,815,46251,0,0,238,4948,0,0;QS=3,0;MQSB=0.959011;MQ0F=0 PL:DP:DV 0,30,249:10:0 0,9,94:3:0 0,6,69:2:0 +X 955 . T <*> 0 . DP=15;I16=7,8,0,0,543,19953,0,0,815,46251,0,0,239,4993,0,0;QS=3,0;MQSB=0.959011;MQ0F=0 PL:DP:DV 0,30,246:10:0 0,9,95:3:0 0,6,68:2:0 +X 956 . C <*> 0 . DP=15;I16=6,8,0,0,543,21255,0,0,786,45410,0,0,229,4935,0,0;QS=3,0;MQSB=0.740818;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,6,62:2:0 0,6,70:2:0 +X 957 . A <*> 0 . DP=15;I16=7,8,0,0,504,17684,0,0,815,46251,0,0,241,5137,0,0;QS=3,0;MQSB=0.959011;MQ0F=0 PL:DP:DV 0,30,240:10:0 0,9,74:3:0 0,6,67:2:0 +X 958 . C <*> 0 . DP=14;I16=6,8,0,0,505,18981,0,0,755,42651,0,0,243,5235,0,0;QS=3,0;MQSB=0.981425;MQ0F=0 PL:DP:DV 0,30,253:10:0 0,9,78:3:0 0,3,39:1:0 +X 959 . A <*> 0 . DP=14;I16=5,8,0,0,519,20885,0,0,726,41810,0,0,231,5153,0,0;QS=3,0;MQSB=0.765017;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,6,72:2:0 0,3,38:1:0 +X 960 . G <*> 0 . DP=15;I16=6,9,0,0,539,19901,0,0,815,46251,0,0,247,5479,0,0;QS=3,0;MQSB=0.99308;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,106:4:0 0,3,41:1:0 +X 961 . T <*> 0 . DP=14;I16=6,8,0,0,523,19835,0,0,755,42651,0,0,250,5574,0,0;QS=3,0;MQSB=0.981425;MQ0F=0 PL:DP:DV 0,27,248:9:0 0,12,114:4:0 0,3,39:1:0 +X 962 . G <*> 0 . DP=14;I16=5,8,0,0,498,19194,0,0,726,41810,0,0,236,5394,0,0;QS=3,0;MQSB=0.765017;MQ0F=0 PL:DP:DV 0,27,253:9:0 0,9,91:3:0 0,3,36:1:0 +X 963 . C <*> 0 . DP=13;I16=5,8,0,0,500,19610,0,0,695,39051,0,0,256,5754,0,0;QS=3,0;MQSB=0.997325;MQ0F=0 PL:DP:DV 0,24,234:8:0 0,12,118:4:0 0,3,40:1:0 +X 964 . T <*> 0 . DP=13;I16=5,8,0,0,512,20430,0,0,695,39051,0,0,259,5835,0,0;QS=3,0;MQSB=0.997325;MQ0F=0 PL:DP:DV 0,24,227:8:0 0,12,128:4:0 0,3,42:1:0 +X 965 . G <*> 0 . DP=13;I16=4,8,0,0,467,18429,0,0,666,38210,0,0,241,5477,0,0;QS=3,0;MQSB=0.793923;MQ0F=0 PL:DP:DV 0,24,228:8:0 0,9,93:3:0 0,3,40:1:0 +X 966 . A <*> 0 . DP=13;I16=4,8,0,0,443,16785,0,0,666,38210,0,0,242,5490,0,0;QS=3,0;MQSB=0.793923;MQ0F=0 PL:DP:DV 0,24,212:8:0 0,9,95:3:0 0,3,40:1:0 +X 967 . G <*> 0 . DP=13;I16=4,8,0,0,464,18036,0,0,666,38210,0,0,243,5513,0,0;QS=3,0;MQSB=0.793923;MQ0F=0 PL:DP:DV 0,24,230:8:0 0,9,91:3:0 0,3,41:1:0 +X 968 . G <*> 0 . DP=13;I16=4,8,0,0,441,16549,0,0,666,38210,0,0,244,5546,0,0;QS=3,0;MQSB=0.793923;MQ0F=0 PL:DP:DV 0,24,218:8:0 0,9,87:3:0 0,3,42:1:0 +X 969 . T <*> 0 . DP=13;I16=4,8,0,0,450,16970,0,0,666,38210,0,0,245,5589,0,0;QS=3,0;MQSB=0.793923;MQ0F=0 PL:DP:DV 0,24,220:8:0 0,9,98:3:0 0,3,31:1:0 +X 970 . G <*> 0 . DP=13;I16=4,7,0,0,413,15579,0,0,629,36841,0,0,220,4968,0,0;QS=3,0;MQSB=0.924449;MQ0F=0 PL:DP:DV 0,24,221:8:0 0,6,71:2:0 0,3,33:1:0 +X 971 . G <*> 0 . DP=13;I16=4,8,0,0,459,17711,0,0,666,38210,0,0,245,5609,0,0;QS=3,0;MQSB=0.793923;MQ0F=0 PL:DP:DV 0,24,223:8:0 0,9,93:3:0 0,3,38:1:0 +X 972 . G <*> 0 . DP=13;I16=4,8,0,0,446,17192,0,0,666,38210,0,0,245,5637,0,0;QS=3,0;MQSB=0.793923;MQ0F=0 PL:DP:DV 0,24,210:8:0 0,9,96:3:0 0,3,39:1:0 +X 973 . A <*> 0 . DP=12;I16=4,7,0,0,402,15018,0,0,606,34610,0,0,246,5676,0,0;QS=3,0;MQSB=0.763675;MQ0F=0 PL:DP:DV 0,21,192:7:0 0,9,89:3:0 0,3,42:1:0 +X 974 . A <*> 0 . DP=12;I16=4,7,0,0,417,16273,0,0,606,34610,0,0,247,5725,0,0;QS=3,0;MQSB=0.763675;MQ0F=0 PL:DP:DV 0,21,198:7:0 0,9,96:3:0 0,3,42:1:0 +X 975 . G <*> 0 . DP=13;I16=4,8,0,0,454,17560,0,0,666,38210,0,0,247,5733,0,0;QS=3,0;MQSB=0.793923;MQ0F=0 PL:DP:DV 0,24,213:8:0 0,9,95:3:0 0,3,42:1:0 +X 976 . A <*> 0 . DP=13;I16=4,8,0,0,431,16083,0,0,666,38210,0,0,248,5750,0,0;QS=3,0;MQSB=0.793923;MQ0F=0 PL:DP:DV 0,24,227:8:0 0,9,70:3:0 0,3,41:1:0 +X 977 . T <*> 0 . DP=13;I16=4,8,0,0,438,16316,0,0,666,38210,0,0,248,5726,0,0;QS=3,0;MQSB=0.793923;MQ0F=0 PL:DP:DV 0,24,210:8:0 0,9,93:3:0 0,3,37:1:0 +X 978 . G <*> 0 . DP=12;I16=4,8,0,0,430,16060,0,0,666,38210,0,0,248,5710,0,0;QS=3,0;MQSB=0.793923;MQ0F=0 PL:DP:DV 0,24,224:8:0 0,9,75:3:0 0,3,40:1:0 +X 979 . C <*> 0 . DP=13;I16=4,8,0,0,453,17461,0,0,689,40441,0,0,223,5077,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,27,232:9:0 0,6,72:2:0 0,3,41:1:0 +X 980 . T <*> 0 . DP=13;I16=4,8,0,0,438,16412,0,0,689,40441,0,0,224,5078,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,27,220:9:0 0,6,76:2:0 0,3,43:1:0 +X 981 . T <*> 0 . DP=13;I16=4,9,0,0,484,18602,0,0,726,41810,0,0,250,5714,0,0;QS=3,0;MQSB=0.826565;MQ0F=0 PL:DP:DV 0,27,224:9:0 0,9,97:3:0 0,3,41:1:0 +X 982 . G <*> 0 . DP=14;I16=4,10,0,0,520,20128,0,0,786,45410,0,0,250,5686,0,0;QS=3,0;MQSB=0.852144;MQ0F=0 PL:DP:DV 0,30,237:10:0 0,9,99:3:0 0,3,40:1:0 +X 983 . A <*> 0 . DP=14;I16=4,10,0,0,570,23360,0,0,786,45410,0,0,251,5671,0,0;QS=3,0;MQSB=0.852144;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,101:3:0 0,3,42:1:0 +X 984 . G <*> 0 . DP=15;I16=4,10,0,0,529,20459,0,0,786,45410,0,0,252,5670,0,0;QS=3,0;MQSB=0.852144;MQ0F=0 PL:DP:DV 0,30,253:10:0 0,9,88:3:0 0,3,43:1:0 +X 985 . C <*> 0 . DP=17;I16=4,13,0,0,580,20280,0,0,966,56210,0,0,261,5747,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,33,246:11:0 0,12,100:4:0 0,6,65:2:0 +X 986 . C A,<*> 0 . DP=17;I16=3,12,0,1,519,18353,13,169,846,49010,60,3600,235,5101,4,16;QS=2.95873,0.0412698,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.921781;BQB=1;MQ0F=0 PL:DP:DV 0,16,197,27,200,201:10:1 0,12,108,12,108,108:4:0 0,6,69,6,69,69:2:0 +X 987 . C <*> 0 . DP=17;I16=4,13,0,0,634,23914,0,0,966,56210,0,0,267,5755,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,107:4:0 0,6,69:2:0 +X 988 . A <*> 0 . DP=17;I16=4,13,0,0,633,24341,0,0,966,56210,0,0,269,5737,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,111:4:0 0,6,82:2:0 +X 989 . G <*> 0 . DP=17;I16=4,13,0,0,635,24149,0,0,966,56210,0,0,271,5739,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,114:4:0 0,6,80:2:0 +X 990 . G <*> 0 . DP=16;I16=4,12,0,0,591,22177,0,0,906,52610,0,0,274,5760,0,0;QS=3,0;MQSB=0.88901;MQ0F=0 PL:DP:DV 0,30,246:10:0 0,12,105:4:0 0,6,83:2:0 +X 991 . A <*> 0 . DP=16;I16=3,11,0,0,548,21542,0,0,809,47641,0,0,227,4549,0,0;QS=3,0;MQSB=0.973096;MQ0F=0 PL:DP:DV 0,27,232:9:0 0,9,100:3:0 0,6,80:2:0 +X 992 . G <*> 0 . DP=16;I16=4,12,0,0,562,20436,0,0,906,52610,0,0,278,5760,0,0;QS=3,0;MQSB=0.88901;MQ0F=0 PL:DP:DV 0,30,240:10:0 0,12,102:4:0 0,6,76:2:0 +X 993 . T <*> 0 . DP=16;I16=4,12,0,0,564,20752,0,0,906,52610,0,0,280,5790,0,0;QS=3,0;MQSB=0.88901;MQ0F=0 PL:DP:DV 0,30,222:10:0 0,12,121:4:0 0,6,73:2:0 +X 994 . T <*> 0 . DP=17;I16=5,11,0,0,597,22625,0,0,906,52610,0,0,270,5696,0,0;QS=3,0;MQSB=0.851779;MQ0F=0 PL:DP:DV 0,27,227:9:0 0,12,123:4:0 0,9,103:3:0 +X 995 . C <*> 0 . DP=16;I16=4,11,0,0,588,23228,0,0,846,49010,0,0,273,5741,0,0;QS=3,0;MQSB=0.872525;MQ0F=0 PL:DP:DV 0,24,216:8:0 0,12,119:4:0 0,9,110:3:0 +X 996 . A <*> 0 . DP=16;I16=4,12,0,0,562,20416,0,0,906,52610,0,0,290,6000,0,0;QS=3,0;MQSB=0.88901;MQ0F=0 PL:DP:DV 0,27,207:9:0 0,12,107:4:0 0,9,113:3:0 +X 997 . A <*> 0 . DP=16;I16=4,12,0,0,600,23520,0,0,906,52610,0,0,294,6110,0,0;QS=3,0;MQSB=0.88901;MQ0F=0 PL:DP:DV 0,27,209:9:0 0,12,123:4:0 0,9,121:3:0 +X 998 . G <*> 0 . DP=17;I16=4,13,0,0,603,22299,0,0,966,56210,0,0,298,6240,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,30,226:10:0 0,12,99:4:0 0,9,115:3:0 +X 999 . G <*> 0 . DP=17;I16=4,12,0,0,575,21519,0,0,906,52610,0,0,302,6390,0,0;QS=3,0;MQSB=0.88901;MQ0F=0 PL:DP:DV 0,27,202:9:0 0,12,118:4:0 0,9,111:3:0 +X 1000 . C <*> 0 . DP=17;I16=4,13,0,0,637,24465,0,0,966,56210,0,0,308,6564,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,30,235:10:0 0,12,118:4:0 0,9,109:3:0 +X 1001 . T <*> 0 . DP=17;I16=4,13,0,0,647,24907,0,0,966,56210,0,0,312,6708,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,30,228:10:0 0,12,120:4:0 0,9,122:3:0 +X 1002 . G <*> 0 . DP=17;I16=4,13,0,0,627,23691,0,0,966,56210,0,0,316,6872,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,30,220:10:0 0,12,123:4:0 0,9,109:3:0 +X 1003 . C T,<*> 0 . DP=18;I16=4,13,0,1,633,23953,22,484,966,56210,60,3600,297,6515,21,441;QS=2.9375,0.0625,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.913725;BQB=1;MQ0F=0 PL:DP:DV 0,8,207,27,211,220:10:1 0,15,132,15,132,132:5:0 0,9,102,9,102,102:3:0 +X 1004 . A <*> 0 . DP=19;I16=5,14,0,0,653,23107,0,0,1086,63410,0,0,321,7061,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,33,231:11:0 0,15,131:5:0 0,9,98:3:0 +X 1005 . A <*> 0 . DP=19;I16=5,14,0,0,670,24380,0,0,1086,63410,0,0,324,7138,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,33,231:11:0 0,15,132:5:0 0,9,113:3:0 +X 1006 . T <*> 0 . DP=19;I16=4,14,0,0,659,24869,0,0,1026,59810,0,0,327,7237,0,0;QS=3,0;MQSB=0.913725;MQ0F=0 PL:DP:DV 0,30,220:10:0 0,15,134:5:0 0,9,115:3:0 +X 1007 . G <*> 0 . DP=18;I16=4,13,0,0,651,25373,0,0,966,56210,0,0,306,6732,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,27,225:9:0 0,15,138:5:0 0,9,113:3:0 +X 1008 . A <*> 0 . DP=18;I16=4,13,0,0,667,27041,0,0,966,56210,0,0,309,6821,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,27,222:9:0 0,15,147:5:0 0,9,118:3:0 +X 1009 . G <*> 0 . DP=18;I16=4,13,0,0,635,24431,0,0,966,56210,0,0,312,6928,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,27,213:9:0 0,15,139:5:0 0,9,116:3:0 +X 1010 . C <*> 0 . DP=18;I16=4,14,0,0,661,25289,0,0,1026,59810,0,0,339,7629,0,0;QS=3,0;MQSB=0.913725;MQ0F=0 PL:DP:DV 0,30,234:10:0 0,15,126:5:0 0,9,114:3:0 +X 1011 . T <*> 0 . DP=18;I16=4,14,0,0,671,25325,0,0,1026,59810,0,0,339,7623,0,0;QS=3,0;MQSB=0.913725;MQ0F=0 PL:DP:DV 0,30,226:10:0 0,15,131:5:0 0,9,118:3:0 +X 1012 . A <*> 0 . DP=19;I16=5,14,0,0,639,22891,0,0,1063,61179,0,0,339,7633,0,0;QS=3,0;MQSB=0.990403;MQ0F=0 PL:DP:DV 0,30,201:10:0 0,18,154:6:0 0,9,113:3:0 +X 1013 . T <*> 0 . DP=18;I16=5,12,0,0,623,23913,0,0,943,53979,0,0,325,7385,0,0;QS=3,0;MQSB=0.998612;MQ0F=0 PL:DP:DV 0,24,202:8:0 0,18,161:6:0 0,9,115:3:0 +X 1014 . G <*> 0 . DP=18;I16=5,13,0,0,656,24596,0,0,1003,57579,0,0,341,7605,0,0;QS=3,0;MQSB=0.995153;MQ0F=0 PL:DP:DV 0,27,218:9:0 0,18,159:6:0 0,9,113:3:0 +X 1015 . A <*> 0 . DP=18;I16=5,13,0,0,646,23878,0,0,1003,57579,0,0,342,7618,0,0;QS=3,0;MQSB=0.995153;MQ0F=0 PL:DP:DV 0,27,209:9:0 0,18,164:6:0 0,9,109:3:0 +X 1016 . T <*> 0 . DP=17;I16=4,12,0,0,588,22114,0,0,929,54841,0,0,340,7632,0,0;QS=3,0;MQSB=0.971017;MQ0F=0 PL:DP:DV 0,27,212:9:0 0,12,124:4:0 0,9,101:3:0 +X 1017 . T <*> 0 . DP=18;I16=5,13,0,0,635,23433,0,0,1026,59810,0,0,346,7694,0,0;QS=3,0;MQSB=0.942222;MQ0F=0 PL:DP:DV 0,27,213:9:0 0,18,155:6:0 0,9,105:3:0 +X 1018 . G <*> 0 . DP=18;I16=5,13,0,0,650,24550,0,0,1026,59810,0,0,349,7757,0,0;QS=3,0;MQSB=0.942222;MQ0F=0 PL:DP:DV 0,27,215:9:0 0,18,179:6:0 0,9,91:3:0 +X 1019 . C <*> 0 . DP=18;I16=5,12,0,0,555,18561,0,0,966,56210,0,0,327,7213,0,0;QS=3,0;MQSB=0.951229;MQ0F=0 PL:DP:DV 0,24,181:8:0 0,18,143:6:0 0,9,104:3:0 +X 1020 . G <*> 0 . DP=19;I16=6,12,0,0,625,22287,0,0,1026,59810,0,0,332,7402,0,0;QS=3,0;MQSB=0.97296;MQ0F=0 PL:DP:DV 0,27,228:9:0 0,18,157:6:0 0,9,87:3:0 +X 1021 . C <*> 0 . DP=19;I16=5,13,0,0,625,22761,0,0,1026,59810,0,0,332,7326,0,0;QS=3,0;MQSB=0.942222;MQ0F=0 PL:DP:DV 0,27,220:9:0 0,18,153:6:0 0,9,92:3:0 +X 1022 . C <*> 0 . DP=19;I16=6,13,0,0,727,27975,0,0,1086,63410,0,0,360,8034,0,0;QS=3,0;MQSB=0.965977;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,168:6:0 0,9,110:3:0 +X 1023 . A <*> 0 . DP=19;I16=6,12,0,0,647,23997,0,0,1026,59810,0,0,338,7510,0,0;QS=3,0;MQSB=0.97296;MQ0F=0 PL:DP:DV 0,27,216:9:0 0,18,168:6:0 0,9,112:3:0 +X 1024 . C <*> 0 . DP=20;I16=7,13,0,0,729,27471,0,0,1146,67010,0,0,364,8154,0,0;QS=3,0;MQSB=0.980568;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,169:6:0 0,9,106:3:0 +X 1025 . T <*> 0 . DP=20;I16=7,13,0,0,757,29387,0,0,1146,67010,0,0,366,8192,0,0;QS=3,0;MQSB=0.980568;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,181:6:0 0,9,117:3:0 +X 1026 . G <*> 0 . DP=20;I16=7,13,0,0,747,28435,0,0,1146,67010,0,0,367,8201,0,0;QS=3,0;MQSB=0.980568;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,169:6:0 0,9,113:3:0 +X 1027 . C <*> 0 . DP=20;I16=7,13,0,0,720,26688,0,0,1146,67010,0,0,368,8232,0,0;QS=3,0;MQSB=0.980568;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,145:6:0 0,9,110:3:0 +X 1028 . A <*> 0 . DP=19;I16=6,12,0,0,645,23681,0,0,1026,59810,0,0,348,7800,0,0;QS=3,0;MQSB=0.97296;MQ0F=0 PL:DP:DV 0,30,238:10:0 0,15,146:5:0 0,9,99:3:0 +X 1029 . C <*> 0 . DP=19;I16=7,12,0,0,699,26817,0,0,1086,63410,0,0,371,8305,0,0;QS=3,0;MQSB=0.985816;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,138:5:0 0,9,111:3:0 +X 1030 . T <*> 0 . DP=19;I16=7,12,0,0,749,29789,0,0,1086,63410,0,0,371,8293,0,0;QS=3,0;MQSB=0.985816;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,158:5:0 0,9,122:3:0 +X 1031 . T <*> 0 . DP=21;I16=9,12,0,0,748,27726,0,0,1206,70610,0,0,371,8297,0,0;QS=3,0;MQSB=0.997478;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,144:5:0 0,9,113:3:0 +X 1032 . T <*> 0 . DP=21;I16=9,12,0,0,761,28033,0,0,1206,70610,0,0,373,8319,0,0;QS=3,0;MQSB=0.997478;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,156:5:0 0,9,111:3:0 +X 1033 . G <*> 0 . DP=22;I16=10,12,0,0,773,28227,0,0,1266,74210,0,0,375,8361,0,0;QS=3,0;MQSB=0.999457;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,169:6:0 0,9,101:3:0 +X 1034 . G <*> 0 . DP=22;I16=8,12,0,0,703,25617,0,0,1169,69241,0,0,340,7684,0,0;QS=3,0;MQSB=0.953497;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,149:5:0 0,9,102:3:0 +X 1035 . C <*> 0 . DP=21;I16=10,11,0,0,719,26103,0,0,1237,73369,0,0,382,8508,0,0;QS=3,0;MQSB=0.927743;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,163:6:0 0,9,94:3:0 +X 1036 . C <*> 0 . DP=22;I16=11,10,0,0,756,28390,0,0,1237,73369,0,0,360,7938,0,0;QS=3,0;MQSB=0.939898;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,175:6:0 0,12,135:4:0 +X 1037 . T <*> 0 . DP=22;I16=11,11,0,0,839,32737,0,0,1297,76969,0,0,389,8641,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,188:6:0 0,12,138:4:0 +X 1038 . G <*> 0 . DP=21;I16=10,10,0,0,752,28750,0,0,1177,69769,0,0,368,8066,0,0;QS=3,0;MQSB=0.931063;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,184:6:0 0,9,107:3:0 +X 1039 . G <*> 0 . DP=21;I16=10,11,0,0,775,29373,0,0,1237,73369,0,0,397,8761,0,0;QS=3,0;MQSB=0.927743;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,189:6:0 0,9,111:3:0 +X 1040 . A <*> 0 . DP=21;I16=10,11,0,0,759,28007,0,0,1237,73369,0,0,401,8851,0,0;QS=3,0;MQSB=0.927743;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,177:6:0 0,9,107:3:0 +X 1041 . C <*> 0 . DP=21;I16=8,11,0,0,713,27117,0,0,1140,68400,0,0,371,8255,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,155:5:0 0,9,110:3:0 +X 1042 . A <*> 0 . DP=23;I16=12,10,0,0,800,29464,0,0,1297,76969,0,0,384,8466,0,0;QS=3,0;MQSB=0.947103;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,185:6:0 0,15,145:5:0 +X 1043 . A <*> 0 . DP=23;I16=12,11,0,0,850,32160,0,0,1357,80569,0,0,414,9192,0,0;QS=3,0;MQSB=0.944319;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,188:6:0 0,15,159:5:0 +X 1044 . C <*> 0 . DP=23;I16=12,10,0,0,812,30758,0,0,1297,76969,0,0,394,8690,0,0;QS=3,0;MQSB=0.947103;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,181:6:0 0,15,150:5:0 +X 1045 . A <*> 0 . DP=23;I16=12,11,0,0,887,34519,0,0,1357,80569,0,0,424,9460,0,0;QS=3,0;MQSB=0.944319;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,197:6:0 0,15,156:5:0 +X 1046 . G <*> 0 . DP=23;I16=12,11,0,0,862,33240,0,0,1357,80569,0,0,428,9576,0,0;QS=3,0;MQSB=0.944319;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,183:6:0 0,15,158:5:0 +X 1047 . A <*> 0 . DP=23;I16=12,11,0,0,890,34804,0,0,1357,80569,0,0,432,9712,0,0;QS=3,0;MQSB=0.944319;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,198:6:0 0,15,165:5:0 +X 1048 . G <*> 0 . DP=23;I16=12,10,0,0,846,33054,0,0,1297,76969,0,0,411,9243,0,0;QS=3,0;MQSB=0.947103;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,195:6:0 0,15,156:5:0 +X 1049 . C <*> 0 . DP=22;I16=12,10,0,0,808,30644,0,0,1297,76969,0,0,441,10043,0,0;QS=3,0;MQSB=0.947103;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,182:6:0 0,15,160:5:0 +X 1050 . A <*> 0 . DP=22;I16=11,10,0,0,808,31334,0,0,1237,73369,0,0,430,9940,0,0;QS=3,0;MQSB=0.939898;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,193:6:0 0,12,138:4:0 +X 1051 . A <*> 0 . DP=21;I16=11,9,0,0,731,27495,0,0,1177,69769,0,0,423,9621,0,0;QS=3,0;MQSB=0.943233;MQ0F=0 PL:DP:DV 0,27,238:9:0 0,18,187:6:0 0,15,150:5:0 +X 1052 . A <*> 0 . DP=21;I16=11,9,0,0,759,29327,0,0,1177,69769,0,0,427,9747,0,0;QS=3,0;MQSB=0.943233;MQ0F=0 PL:DP:DV 0,27,247:9:0 0,18,190:6:0 0,15,150:5:0 +X 1053 . A <*> 0 . DP=21;I16=11,8,0,0,674,25210,0,0,1117,66169,0,0,406,9264,0,0;QS=3,0;MQSB=0.946915;MQ0F=0 PL:DP:DV 0,24,224:8:0 0,18,161:6:0 0,15,149:5:0 +X 1054 . C <*> 0 . DP=21;I16=11,10,0,0,791,30157,0,0,1237,73369,0,0,459,10623,0,0;QS=3,0;MQSB=0.939898;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,189:6:0 0,15,153:5:0 +X 1055 . C <*> 0 . DP=22;I16=12,10,0,0,818,31448,0,0,1297,76969,0,0,462,10750,0,0;QS=3,0;MQSB=0.947103;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,191:6:0 0,15,157:5:0 +X 1056 . C <*> 0 . DP=22;I16=12,9,0,0,793,31265,0,0,1237,73369,0,0,441,10271,0,0;QS=3,0;MQSB=0.950149;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,195:6:0 0,15,161:5:0 +X 1057 . T <*> 0 . DP=23;I16=12,10,0,0,821,31667,0,0,1297,76969,0,0,467,10911,0,0;QS=3,0;MQSB=0.947103;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,196:6:0 0,15,159:5:0 +X 1058 . G <*> 0 . DP=23;I16=12,11,0,0,863,32871,0,0,1357,80569,0,0,493,11569,0,0;QS=3,0;MQSB=0.944319;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,197:7:0 0,15,155:5:0 +X 1059 . T <*> 0 . DP=23;I16=12,10,0,0,797,29803,0,0,1297,76969,0,0,468,10944,0,0;QS=3,0;MQSB=0.947103;MQ0F=0 PL:DP:DV 0,30,249:10:0 0,21,202:7:0 0,15,152:5:0 +X 1060 . C <*> 0 . DP=23;I16=12,11,0,0,829,31041,0,0,1357,80569,0,0,492,11536,0,0;QS=3,0;MQSB=0.944319;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,178:7:0 0,15,163:5:0 +X 1061 . T <*> 0 . DP=22;I16=12,9,0,0,810,31840,0,0,1237,73369,0,0,465,10797,0,0;QS=3,0;MQSB=0.950149;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,175:5:0 0,15,158:5:0 +X 1062 . C A,<*> 0 . DP=22;I16=12,9,0,1,826,32780,33,1089,1237,73369,60,3600,462,10652,25,625;QS=2.85398,0.146018,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.947103;BQB=1;MQ0F=0 PL:DP:DV 0,33,255,33,255,255:11:0 15,0,151,30,154,176:6:1 0,15,164,15,164,164:5:0 +X 1063 . T <*> 0 . DP=22;I16=12,9,0,0,820,32460,0,0,1237,73369,0,0,459,10525,0,0;QS=3,0;MQSB=0.950149;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,183:6:0 0,15,166:5:0 +X 1064 . A <*> 0 . DP=23;I16=12,9,0,0,793,30355,0,0,1237,73369,0,0,464,10752,0,0;QS=3,0;MQSB=0.950149;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,180:6:0 0,15,162:5:0 +X 1065 . A <*> 0 . DP=23;I16=12,9,0,0,814,31978,0,0,1237,73369,0,0,462,10694,0,0;QS=3,0;MQSB=0.950149;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,186:6:0 0,15,174:5:0 +X 1066 . A <*> 0 . DP=27;I16=15,9,0,0,890,34378,0,0,1417,84169,0,0,460,10652,0,0;QS=3,0;MQSB=0.96464;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,198:7:0 0,18,181:6:0 +X 1067 . A <*> 0 . DP=27;I16=15,10,0,0,913,35031,0,0,1477,87769,0,0,470,10600,0,0;QS=3,0;MQSB=0.962269;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,208:7:0 0,18,182:6:0 +X 1068 . A <*> 0 . DP=27;I16=15,9,0,0,898,34580,0,0,1417,84169,0,0,456,10342,0,0;QS=3,0;MQSB=0.96464;MQ0F=0 PL:DP:DV 0,30,253:10:0 0,24,218:8:0 0,18,181:6:0 +X 1069 . A <*> 0 . DP=28;I16=16,10,0,0,914,33888,0,0,1537,91369,0,0,481,10925,0,0;QS=3,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,207:8:0 0,21,177:7:0 +X 1070 . A <*> 0 . DP=28;I16=15,11,0,0,955,36445,0,0,1537,91369,0,0,467,10351,0,0;QS=3,0;MQSB=0.960078;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,223:8:0 0,21,188:7:0 +X 1071 . G <*> 0 . DP=28;I16=16,10,0,0,974,37570,0,0,1537,91369,0,0,466,10284,0,0;QS=3,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,192:7:0 0,21,191:7:0 +X 1072 . A <*> 0 . DP=28;I16=16,11,0,0,1007,38205,0,0,1597,94969,0,0,490,10868,0,0;QS=3,0;MQSB=0.96384;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,239:8:0 0,21,195:7:0 +X 1073 . A <*> 0 . DP=28;I16=16,10,0,0,976,37822,0,0,1537,91369,0,0,463,10177,0,0;QS=3,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,33,254:11:0 0,24,236:8:0 0,21,199:7:0 +X 1074 . A <*> 0 . DP=28;I16=16,11,0,0,1003,38097,0,0,1597,94969,0,0,484,10664,0,0;QS=3,0;MQSB=0.96384;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,232:8:0 0,21,203:7:0 +X 1075 . A <*> 0 . DP=28;I16=16,10,0,0,964,36762,0,0,1537,91369,0,0,476,10564,0,0;QS=3,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,222:8:0 0,21,200:7:0 +X 1076 . G <*> 0 . DP=28;I16=16,10,0,0,966,37048,0,0,1537,91369,0,0,476,10536,0,0;QS=3,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,209:8:0 0,21,183:7:0 +X 1077 . A <*> 0 . DP=29;I16=17,11,0,0,1038,39240,0,0,1657,98569,0,0,480,10548,0,0;QS=3,0;MQSB=0.967085;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,231:8:0 0,24,209:8:0 +X 1078 . A <*> 0 . DP=29;I16=17,11,0,0,1053,40425,0,0,1657,98569,0,0,480,10562,0,0;QS=3,0;MQSB=0.967085;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,234:8:0 0,24,214:8:0 +X 1079 . A <*> 0 . DP=28;I16=17,10,0,0,1019,39007,0,0,1597,94969,0,0,479,10505,0,0;QS=3,0;MQSB=0.968979;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,223:8:0 0,24,206:8:0 +X 1080 . A <*> 0 . DP=29;I16=18,10,0,0,1049,40827,0,0,1657,98569,0,0,478,10478,0,0;QS=3,0;MQSB=0.971673;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,246:9:0 0,24,218:8:0 +X 1081 . G <*> 0 . DP=30;I16=19,8,0,0,988,37392,0,0,1597,94969,0,0,436,9550,0,0;QS=3,0;MQSB=0.977696;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,24,210:8:0 0,27,210:9:0 +X 1082 . A <*> 0 . DP=30;I16=20,7,0,0,989,37109,0,0,1597,94969,0,0,438,9564,0,0;QS=3,0;MQSB=0.981425;MQ0F=0 PL:DP:DV 0,27,224:9:0 0,27,226:9:0 0,27,217:9:0 +X 1083 . A <*> 0 . DP=30;I16=20,8,0,0,1039,39827,0,0,1657,98569,0,0,455,9803,0,0;QS=3,0;MQSB=0.979523;MQ0F=0 PL:DP:DV 0,30,246:10:0 0,27,233:9:0 0,27,217:9:0 +X 1084 . A <*> 0 . DP=31;I16=21,8,0,0,1049,39097,0,0,1717,102169,0,0,457,9849,0,0;QS=3,0;MQSB=0.981133;MQ0F=0 PL:DP:DV 0,33,253:11:0 0,27,226:9:0 0,27,215:9:0 +X 1085 . A <*> 0 . DP=30;I16=21,8,0,0,1052,39534,0,0,1717,102169,0,0,486,10552,0,0;QS=3,0;MQSB=0.981133;MQ0F=0 PL:DP:DV 0,30,232:10:0 0,30,247:10:0 0,27,214:9:0 +X 1086 . A <*> 0 . DP=28;I16=21,6,0,0,969,36223,0,0,1597,94969,0,0,492,10660,0,0;QS=3,0;MQSB=0.98481;MQ0F=0 PL:DP:DV 0,30,219:10:0 0,27,236:9:0 0,24,179:8:0 +X 1087 . C <*> 0 . DP=28;I16=22,6,0,0,984,36046,0,0,1657,98569,0,0,498,10796,0,0;QS=3,0;MQSB=0.985992;MQ0F=0 PL:DP:DV 0,30,234:10:0 0,27,229:9:0 0,27,173:9:0 +X 1088 . T <*> 0 . DP=29;I16=23,6,0,0,1133,45203,0,0,1717,102169,0,0,503,10863,0,0;QS=3,0;MQSB=0.987041;MQ0F=0 PL:DP:DV 0,30,252:10:0 0,30,250:10:0 0,27,198:9:0 +X 1089 . C <*> 0 . DP=29;I16=23,6,0,0,1093,42347,0,0,1717,102169,0,0,509,10965,0,0;QS=3,0;MQSB=0.987041;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,30,237:10:0 0,27,188:9:0 +X 1090 . A <*> 0 . DP=29;I16=23,6,0,0,1061,39845,0,0,1717,102169,0,0,515,11103,0,0;QS=3,0;MQSB=0.987041;MQ0F=0 PL:DP:DV 0,30,221:10:0 0,30,250:10:0 0,27,183:9:0 +X 1091 . C <*> 0 . DP=29;I16=23,6,0,0,1063,39713,0,0,1717,102169,0,0,521,11277,0,0;QS=3,0;MQSB=0.987041;MQ0F=0 PL:DP:DV 0,30,247:10:0 0,30,244:10:0 0,27,177:9:0 +X 1092 . T <*> 0 . DP=29;I16=23,6,0,0,1121,44489,0,0,1717,102169,0,0,524,11334,0,0;QS=3,0;MQSB=0.987041;MQ0F=0 PL:DP:DV 0,30,244:10:0 0,30,251:10:0 0,27,198:9:0 +X 1093 . G <*> 0 . DP=29;I16=23,6,0,0,1085,41377,0,0,1717,102169,0,0,526,11372,0,0;QS=3,0;MQSB=0.987041;MQ0F=0 PL:DP:DV 0,30,249:10:0 0,30,243:10:0 0,27,184:9:0 +X 1094 . G <*> 0 . DP=29;I16=22,6,0,0,1018,38808,0,0,1657,98569,0,0,521,11393,0,0;QS=3,0;MQSB=0.985992;MQ0F=0 PL:DP:DV 0,30,243:10:0 0,30,232:10:0 0,24,185:8:0 +X 1095 . A <*> 0 . DP=28;I16=22,6,0,0,1023,38551,0,0,1657,98569,0,0,529,11443,0,0;QS=3,0;MQSB=0.985992;MQ0F=0 PL:DP:DV 0,30,236:10:0 0,30,244:10:0 0,24,178:8:0 +X 1096 . T <*> 0 . DP=30;I16=24,5,0,0,1020,37168,0,0,1717,102169,0,0,505,10849,0,0;QS=3,0;MQSB=0.989637;MQ0F=0 PL:DP:DV 0,33,234:11:0 0,27,220:9:0 0,27,178:9:0 +X 1097 . A <*> 0 . DP=30;I16=24,6,0,0,1056,38166,0,0,1777,105769,0,0,533,11537,0,0;QS=3,0;MQSB=0.987976;MQ0F=0 PL:DP:DV 0,33,230:11:0 0,30,237:10:0 0,27,177:9:0 +X 1098 . T <*> 0 . DP=29;I16=24,5,0,0,1081,40557,0,0,1717,102169,0,0,537,11633,0,0;QS=3,0;MQSB=0.989637;MQ0F=0 PL:DP:DV 0,30,210:10:0 0,30,251:10:0 0,27,186:9:0 +X 1099 . G <*> 0 . DP=29;I16=24,5,0,0,1091,41719,0,0,1717,102169,0,0,540,11712,0,0;QS=3,0;MQSB=0.989637;MQ0F=0 PL:DP:DV 0,30,229:10:0 0,30,242:10:0 0,27,182:9:0 +X 1100 . A <*> 0 . DP=29;I16=24,5,0,0,1106,42976,0,0,1717,102169,0,0,543,11825,0,0;QS=3,0;MQSB=0.989637;MQ0F=0 PL:DP:DV 0,30,210:10:0 0,30,255:10:0 0,27,191:9:0 +X 1101 . A <*> 0 . DP=29;I16=24,5,0,0,1154,46420,0,0,1717,102169,0,0,545,11921,0,0;QS=3,0;MQSB=0.989637;MQ0F=0 PL:DP:DV 0,30,222:10:0 0,30,255:10:0 0,27,198:9:0 +X 1102 . T <*> 0 . DP=29;I16=24,4,0,0,1046,39520,0,0,1657,98569,0,0,522,11424,0,0;QS=3,0;MQSB=0.991416;MQ0F=0 PL:DP:DV 0,30,210:10:0 0,27,233:9:0 0,27,186:9:0 +X 1103 . G <*> 0 . DP=30;I16=24,6,0,0,1134,43486,0,0,1777,105769,0,0,548,12158,0,0;QS=3,0;MQSB=0.987976;MQ0F=0 PL:DP:DV 0,30,223:10:0 0,30,255:10:0 0,30,222:10:0 +X 1104 . A <*> 0 . DP=28;I16=23,5,0,0,1089,43067,0,0,1657,98569,0,0,552,12296,0,0;QS=3,0;MQSB=0.988819;MQ0F=0 PL:DP:DV 0,27,213:9:0 0,27,233:9:0 0,30,233:10:0 +X 1105 . T <*> 0 . DP=28;I16=23,5,0,0,1035,38743,0,0,1657,98569,0,0,556,12462,0,0;QS=3,0;MQSB=0.988819;MQ0F=0 PL:DP:DV 0,27,203:9:0 0,27,227:9:0 0,30,222:10:0 +X 1106 . A <*> 0 . DP=29;I16=23,5,0,0,1003,36715,0,0,1657,98569,0,0,532,11882,0,0;QS=3,0;MQSB=0.988819;MQ0F=0 PL:DP:DV 0,30,227:10:0 0,24,198:8:0 0,30,217:10:0 +X 1107 . C <*> 0 . DP=29;I16=23,6,0,0,1093,41509,0,0,1717,102169,0,0,558,12532,0,0;QS=3,0;MQSB=0.987041;MQ0F=0 PL:DP:DV 0,30,244:10:0 0,27,233:9:0 0,30,220:10:0 +X 1108 . A <*> 0 . DP=29;I16=23,6,0,0,1138,44908,0,0,1717,102169,0,0,558,12536,0,0;QS=3,0;MQSB=0.987041;MQ0F=0 PL:DP:DV 0,30,239:10:0 0,27,253:9:0 0,30,227:10:0 +X 1109 . G <*> 0 . DP=29;I16=23,6,0,0,1140,45200,0,0,1717,102169,0,0,557,12519,0,0;QS=3,0;MQSB=0.987041;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,27,240:9:0 0,30,224:10:0 +X 1110 . G <*> 0 . DP=29;I16=23,6,0,0,1086,41054,0,0,1717,102169,0,0,555,12481,0,0;QS=3,0;MQSB=0.987041;MQ0F=0 PL:DP:DV 0,30,242:10:0 0,27,229:9:0 0,30,224:10:0 +X 1111 . T <*> 0 . DP=29;I16=22,6,0,0,1025,37919,0,0,1680,100800,0,0,552,12470,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,227:10:0 0,24,227:8:0 0,30,211:10:0 +X 1112 . T <*> 0 . DP=28;I16=22,6,0,0,1034,38986,0,0,1680,100800,0,0,550,12440,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,226:10:0 0,24,221:8:0 0,30,221:10:0 +X 1113 . G <*> 0 . DP=28;I16=23,5,0,0,1085,42273,0,0,1680,100800,0,0,548,12386,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,202:7:0 0,33,222:11:0 +X 1114 . A <*> 0 . DP=28;I16=23,5,0,0,1079,42279,0,0,1680,100800,0,0,546,12306,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,235:10:0 0,21,209:7:0 0,33,238:11:0 +X 1115 . G <*> 0 . DP=28;I16=23,5,0,0,1114,44550,0,0,1680,100800,0,0,544,12250,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,208:7:0 0,33,234:11:0 +X 1116 . G <*> 0 . DP=29;I16=24,5,0,0,1059,39531,0,0,1740,104400,0,0,542,12218,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,236:10:0 0,24,204:8:0 0,33,226:11:0 +X 1117 . A <*> 0 . DP=29;I16=24,5,0,0,1124,43896,0,0,1740,104400,0,0,541,12211,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,235:10:0 0,24,227:8:0 0,33,234:11:0 +X 1118 . T <*> 0 . DP=29;I16=24,4,0,0,1100,44802,0,0,1680,100800,0,0,539,12131,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,230:10:0 0,21,188:7:0 0,33,248:11:0 +X 1119 . C <*> 0 . DP=29;I16=23,4,0,0,1078,44864,0,0,1620,97200,0,0,526,11958,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,224:9:0 0,21,191:7:0 0,33,255:11:0 +X 1120 . C <*> 0 . DP=29;I16=23,5,0,0,1113,46071,0,0,1680,100800,0,0,536,12054,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,227:9:0 0,24,214:8:0 0,33,255:11:0 +X 1121 . A <*> 0 . DP=30;I16=24,5,0,0,1167,48549,0,0,1740,104400,0,0,536,12056,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,233:9:0 0,24,220:8:0 0,36,255:12:0 +X 1122 . T <*> 0 . DP=32;I16=26,5,0,0,1235,50967,0,0,1860,111600,0,0,535,11985,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,230:10:0 0,27,238:9:0 0,36,255:12:0 +X 1123 . T <*> 0 . DP=32;I16=26,5,0,0,1219,50121,0,0,1860,111600,0,0,535,11893,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,221:10:0 0,27,236:9:0 0,36,255:12:0 +X 1124 . A <*> 0 . DP=31;I16=25,5,0,0,1187,48827,0,0,1800,108000,0,0,536,11832,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,218:9:0 0,27,235:9:0 0,36,255:12:0 +X 1125 . T <*> 0 . DP=31;I16=25,5,0,0,1211,51001,0,0,1800,108000,0,0,537,11801,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,228:9:0 0,27,235:9:0 0,36,255:12:0 +X 1126 . C <*> 0 . DP=31;I16=25,5,0,0,1225,52001,0,0,1800,108000,0,0,538,11800,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,234:9:0 0,27,241:9:0 0,36,255:12:0 +X 1127 . T <*> 0 . DP=31;I16=25,5,0,0,1257,55245,0,0,1800,108000,0,0,539,11829,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,231:9:0 0,27,252:9:0 0,36,255:12:0 +X 1128 . G <*> 0 . DP=31;I16=25,5,0,0,1217,51743,0,0,1800,108000,0,0,540,11888,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,236:9:0 0,27,229:9:0 0,36,255:12:0 +X 1129 . A G,<*> 0 . DP=31;I16=24,4,0,1,1101,45631,32,1024,1680,100800,60,3600,514,11300,25,625;QS=2.93535,0.0646465,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=1;BQB=1;MQ0F=0 PL:DP:DV 0,24,204,24,204,204:8:0 0,27,229,27,229,229:9:0 0,4,198,33,201,219:12:1 +X 1130 . A <*> 0 . DP=31;I16=25,5,0,0,1189,49509,0,0,1800,108000,0,0,539,11943,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,215:9:0 0,27,236:9:0 0,36,255:12:0 +X 1131 . A <*> 0 . DP=29;I16=23,5,0,0,1156,49362,0,0,1680,100800,0,0,540,11988,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,206:7:0 0,27,250:9:0 0,36,255:12:0 +X 1132 . T <*> 0 . DP=29;I16=23,5,0,0,1123,47359,0,0,1680,100800,0,0,540,12008,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,198:7:0 0,27,229:9:0 0,36,255:12:0 +X 1133 . G <*> 0 . DP=30;I16=23,5,0,0,1148,48796,0,0,1680,100800,0,0,540,12052,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,214:7:0 0,27,232:9:0 0,36,255:12:0 +X 1134 . C <*> 0 . DP=29;I16=22,6,0,0,1162,50224,0,0,1680,100800,0,0,547,12155,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,209:7:0 0,27,254:9:0 0,36,255:12:0 +X 1135 . T <*> 0 . DP=29;I16=22,6,0,0,1214,55020,0,0,1680,100800,0,0,549,12257,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,209:7:0 0,27,255:9:0 0,36,255:12:0 +X 1136 . T <*> 0 . DP=29;I16=22,6,0,0,1148,49270,0,0,1680,100800,0,0,551,12383,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,200:7:0 0,27,255:9:0 0,36,255:12:0 +X 1137 . G <*> 0 . DP=28;I16=21,6,0,0,1087,46051,0,0,1620,97200,0,0,554,12532,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,214:7:0 0,27,234:9:0 0,33,254:11:0 +X 1138 . G <*> 0 . DP=28;I16=21,6,0,0,1040,42504,0,0,1620,97200,0,0,557,12703,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,197:7:0 0,27,234:9:0 0,33,246:11:0 +X 1139 . A <*> 0 . DP=28;I16=21,6,0,0,1103,47389,0,0,1620,97200,0,0,559,12845,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,200:7:0 0,27,254:9:0 0,33,255:11:0 +X 1140 . C <*> 0 . DP=28;I16=21,6,0,0,1072,44372,0,0,1620,97200,0,0,561,13007,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,214:7:0 0,27,234:9:0 0,33,250:11:0 +X 1141 . C <*> 0 . DP=28;I16=21,6,0,0,1106,47298,0,0,1620,97200,0,0,562,13140,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,212:7:0 0,27,245:9:0 0,33,255:11:0 +X 1142 . A <*> 0 . DP=28;I16=21,6,0,0,1114,47788,0,0,1620,97200,0,0,560,13146,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,212:7:0 0,27,255:9:0 0,33,251:11:0 +X 1143 . G <*> 0 . DP=26;I16=19,7,0,0,1041,42249,0,0,1560,93600,0,0,585,13799,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,222:7:0 0,27,249:9:0 0,30,253:10:0 +X 1144 . A <*> 0 . DP=26;I16=19,7,0,0,1018,40154,0,0,1560,93600,0,0,585,13847,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,205:7:0 0,27,250:9:0 0,30,255:10:0 +X 1145 . T <*> 0 . DP=26;I16=19,7,0,0,1016,39852,0,0,1560,93600,0,0,584,13866,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,206:7:0 0,27,250:9:0 0,30,249:10:0 +X 1146 . G <*> 0 . DP=26;I16=19,7,0,0,1011,39743,0,0,1560,93600,0,0,582,13856,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,210:7:0 0,27,246:9:0 0,30,254:10:0 +X 1147 . T <*> 0 . DP=27;I16=20,6,0,0,1010,39730,0,0,1560,93600,0,0,579,13815,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,207:8:0 0,24,234:8:0 0,30,255:10:0 +X 1148 . T <*> 0 . DP=26;I16=20,6,0,0,1002,39214,0,0,1560,93600,0,0,576,13690,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,196:8:0 0,24,237:8:0 0,30,255:10:0 +X 1149 . T <*> 0 . DP=26;I16=20,6,0,0,1022,40532,0,0,1560,93600,0,0,573,13579,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,205:8:0 0,24,231:8:0 0,30,255:10:0 +X 1150 . T <*> 0 . DP=26;I16=20,6,0,0,1032,41212,0,0,1560,93600,0,0,569,13433,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,208:8:0 0,24,236:8:0 0,30,255:10:0 +X 1151 . G <*> 0 . DP=26;I16=20,6,0,0,1021,40285,0,0,1560,93600,0,0,565,13303,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,220:8:0 0,24,231:8:0 0,30,248:10:0 +X 1152 . A <*> 0 . DP=27;I16=20,7,0,0,1040,40772,0,0,1620,97200,0,0,561,13189,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,202:8:0 0,24,230:8:0 0,33,255:11:0 +X 1153 . A <*> 0 . DP=27;I16=20,7,0,0,1039,40717,0,0,1620,97200,0,0,557,13043,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,202:8:0 0,24,233:8:0 0,33,255:11:0 +X 1154 . T <*> 0 . DP=28;I16=21,7,0,0,1073,41861,0,0,1680,100800,0,0,552,12866,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,212:9:0 0,24,236:8:0 0,33,255:11:0 +X 1155 . T <*> 0 . DP=27;I16=20,7,0,0,1074,43046,0,0,1620,97200,0,0,549,12707,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,211:8:0 0,24,236:8:0 0,33,255:11:0 +X 1156 . T <*> 0 . DP=28;I16=19,8,0,0,1065,42533,0,0,1620,97200,0,0,520,11892,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,210:8:0 0,24,239:8:0 0,33,255:11:0 +X 1157 . T <*> 0 . DP=28;I16=20,8,0,0,1094,43108,0,0,1680,100800,0,0,541,12299,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,230:9:0 0,24,230:8:0 0,33,255:11:0 +X 1158 . G <*> 0 . DP=28;I16=20,8,0,0,1098,43584,0,0,1680,100800,0,0,536,12056,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,240:9:0 0,24,224:8:0 0,33,255:11:0 +X 1159 . G <*> 0 . DP=28;I16=20,8,0,0,1096,43222,0,0,1680,100800,0,0,530,11790,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,249:9:0 0,24,229:8:0 0,33,255:11:0 +X 1160 . A <*> 0 . DP=30;I16=20,10,0,0,1146,44510,0,0,1800,108000,0,0,524,11552,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,229:9:0 0,24,242:8:0 0,39,255:13:0 +X 1161 . T <*> 0 . DP=30;I16=20,10,0,0,1136,43548,0,0,1800,108000,0,0,520,11344,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,221:9:0 0,24,230:8:0 0,39,255:13:0 +X 1162 . T <*> 0 . DP=30;I16=20,10,0,0,1147,44365,0,0,1800,108000,0,0,516,11168,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,232:9:0 0,24,229:8:0 0,39,255:13:0 +X 1163 . T <*> 0 . DP=31;I16=20,11,0,0,1176,45394,0,0,1860,111600,0,0,511,10975,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,243:10:0 0,24,231:8:0 0,39,255:13:0 +X 1164 . T <*> 0 . DP=31;I16=20,11,0,0,1166,44864,0,0,1860,111600,0,0,506,10768,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,235:10:0 0,24,234:8:0 0,39,255:13:0 +X 1165 . T <*> 0 . DP=31;I16=20,11,0,0,1189,46635,0,0,1860,111600,0,0,501,10599,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,240:10:0 0,24,231:8:0 0,39,255:13:0 +X 1166 . T <*> 0 . DP=30;I16=19,11,0,0,1137,43791,0,0,1800,108000,0,0,497,10467,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,231:9:0 0,24,228:8:0 0,39,255:13:0 +X 1167 . C <*> 0 . DP=28;I16=17,11,0,0,1114,44588,0,0,1680,100800,0,0,495,10369,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,21,216:7:0 0,36,255:12:0 +X 1168 . A <*> 0 . DP=28;I16=17,11,0,0,1074,41862,0,0,1680,100800,0,0,493,10303,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,238:9:0 0,21,203:7:0 0,36,255:12:0 +X 1169 . T <*> 0 . DP=28;I16=17,11,0,0,1089,42589,0,0,1680,100800,0,0,491,10269,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,247:9:0 0,21,212:7:0 0,36,255:12:0 +X 1170 . A <*> 0 . DP=27;I16=16,11,0,0,1033,39891,0,0,1620,97200,0,0,490,10266,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,244:9:0 0,21,214:7:0 0,33,255:11:0 +X 1171 . T <*> 0 . DP=28;I16=17,11,0,0,1086,42472,0,0,1680,100800,0,0,488,10244,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,249:9:0 0,24,223:8:0 0,33,255:11:0 +X 1172 . T <*> 0 . DP=28;I16=17,11,0,0,1086,42598,0,0,1680,100800,0,0,486,10206,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,235:9:0 0,24,228:8:0 0,33,255:11:0 +X 1173 . T <*> 0 . DP=29;I16=18,11,0,0,1126,44348,0,0,1740,104400,0,0,483,10153,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,241:9:0 0,27,241:9:0 0,33,255:11:0 +X 1174 . T <*> 0 . DP=29;I16=18,11,0,0,1098,42352,0,0,1740,104400,0,0,481,10135,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,230:9:0 0,27,238:9:0 0,33,255:11:0 +X 1175 . G <*> 0 . DP=28;I16=18,10,0,0,1063,40975,0,0,1680,100800,0,0,480,10152,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,234:8:0 0,27,234:9:0 0,33,255:11:0 +X 1176 . T <*> 0 . DP=28;I16=18,10,0,0,1045,39823,0,0,1680,100800,0,0,479,10203,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,221:8:0 0,27,233:9:0 0,33,255:11:0 +X 1177 . A <*> 0 . DP=28;I16=18,10,0,0,1040,39006,0,0,1680,100800,0,0,478,10288,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,220:8:0 0,27,228:9:0 0,33,255:11:0 +X 1178 . A <*> 0 . DP=27;I16=17,10,0,0,1006,38238,0,0,1620,97200,0,0,477,10355,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,221:8:0 0,27,227:9:0 0,30,255:10:0 +X 1179 . T <*> 0 . DP=27;I16=17,10,0,0,1012,38396,0,0,1620,97200,0,0,475,10403,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,223:8:0 0,27,224:9:0 0,30,255:10:0 +X 1180 . C <*> 0 . DP=27;I16=16,10,0,0,1006,39508,0,0,1560,93600,0,0,469,10423,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,222:7:0 0,27,224:9:0 0,30,255:10:0 +X 1181 . T <*> 0 . DP=26;I16=16,10,0,0,1021,40581,0,0,1560,93600,0,0,469,10441,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,236:8:0 0,24,229:8:0 0,30,255:10:0 +X 1182 . T <*> 0 . DP=26;I16=14,11,0,0,939,35915,0,0,1500,90000,0,0,457,10347,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,236:9:0 0,21,209:7:0 0,27,255:9:0 +X 1183 . T <*> 0 . DP=25;I16=13,11,0,0,899,34555,0,0,1440,86400,0,0,455,10341,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,239:9:0 0,18,192:6:0 0,27,255:9:0 +X 1184 . G <*> 0 . DP=24;I16=13,11,0,0,916,35398,0,0,1440,86400,0,0,465,10479,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,234:8:0 0,21,201:7:0 0,27,255:9:0 +X 1185 . C <*> 0 . DP=24;I16=13,11,0,0,908,35014,0,0,1440,86400,0,0,465,10541,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,246:8:0 0,21,191:7:0 0,27,250:9:0 +X 1186 . A <*> 0 . DP=24;I16=13,11,0,0,946,37648,0,0,1440,86400,0,0,463,10525,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,240:8:0 0,21,205:7:0 0,27,255:9:0 +X 1187 . G <*> 0 . DP=25;I16=14,11,0,0,908,33870,0,0,1500,90000,0,0,461,10529,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,240:9:0 0,21,205:7:0 0,27,240:9:0 +X 1188 . T <*> 0 . DP=25;I16=14,11,0,0,886,32138,0,0,1500,90000,0,0,461,10553,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,248:10:0 0,21,196:7:0 0,24,216:8:0 +X 1189 . A <*> 0 . DP=25;I16=14,11,0,0,920,34392,0,0,1500,90000,0,0,461,10497,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,174:6:0 0,27,252:9:0 +X 1190 . T <*> 0 . DP=26;I16=14,12,0,0,960,35876,0,0,1560,93600,0,0,462,10462,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,185:6:0 0,27,252:9:0 +X 1191 . A <*> 0 . DP=26;I16=14,12,0,0,928,33922,0,0,1560,93600,0,0,464,10450,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,173:6:0 0,27,245:9:0 +X 1192 . T <*> 0 . DP=26;I16=14,12,0,0,981,37505,0,0,1560,93600,0,0,465,10413,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,191:6:0 0,27,255:9:0 +X 1193 . T <*> 0 . DP=26;I16=14,12,0,0,976,37054,0,0,1560,93600,0,0,466,10402,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,191:6:0 0,27,255:9:0 +X 1194 . T <*> 0 . DP=26;I16=14,12,0,0,951,35219,0,0,1560,93600,0,0,466,10368,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,178:6:0 0,27,249:9:0 +X 1195 . A <*> 0 . DP=26;I16=14,12,0,0,917,33253,0,0,1560,93600,0,0,466,10362,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,177:6:0 0,27,235:9:0 +X 1196 . C <*> 0 . DP=25;I16=13,12,0,0,921,34209,0,0,1500,90000,0,0,466,10334,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,187:6:0 0,27,236:9:0 +X 1197 . C <*> 0 . DP=24;I16=12,12,0,0,906,34862,0,0,1440,86400,0,0,464,10184,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,186:6:0 0,24,233:8:0 +X 1198 . A <*> 0 . DP=24;I16=12,12,0,0,937,36815,0,0,1440,86400,0,0,461,10013,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,190:6:0 0,24,245:8:0 +X 1199 . G <*> 0 . DP=24;I16=12,12,0,0,879,33035,0,0,1440,86400,0,0,457,9821,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,163:6:0 0,24,221:8:0 +X 1200 . T <*> 0 . DP=24;I16=11,12,0,0,895,35141,0,0,1380,82800,0,0,428,9032,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,176:5:0 0,24,247:8:0 +X 1201 . T <*> 0 . DP=24;I16=12,12,0,0,889,33727,0,0,1440,86400,0,0,449,9521,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,177:6:0 0,24,238:8:0 +X 1202 . C <*> 0 . DP=25;I16=13,12,0,0,929,35121,0,0,1500,90000,0,0,445,9413,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,175:6:0 0,24,230:8:0 +X 1203 . A <*> 0 . DP=25;I16=13,12,0,0,943,36107,0,0,1500,90000,0,0,442,9334,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,184:6:0 0,24,241:8:0 +X 1204 . G <*> 0 . DP=24;I16=13,11,0,0,876,33106,0,0,1440,86400,0,0,439,9235,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,174:6:0 0,21,218:7:0 +X 1205 . C <*> 0 . DP=24;I16=13,11,0,0,891,33869,0,0,1440,86400,0,0,436,9166,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,176:6:0 0,21,217:7:0 +X 1206 . A <*> 0 . DP=23;I16=13,10,0,0,846,31744,0,0,1380,82800,0,0,434,9126,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,179:6:0 0,21,212:7:0 +X 1207 . T <*> 0 . DP=23;I16=13,9,0,0,819,30877,0,0,1320,79200,0,0,407,8489,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,254:10:0 0,18,189:6:0 0,18,194:6:0 +X 1208 . C <*> 0 . DP=24;I16=14,10,0,0,910,35236,0,0,1440,86400,0,0,429,9079,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,190:7:0 0,21,217:7:0 +X 1209 . C T,<*> 0 . DP=24;I16=14,9,0,1,869,33481,21,441,1380,82800,60,3600,408,8710,19,361;QS=2.91393,0.0860656,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=1;BQB=1;MQ0F=0 PL:DP:DV 0,30,255,30,255,255:10:0 0,0,153,18,156,166:7:1 0,21,209,21,209,209:7:0 +X 1210 . C <*> 0 . DP=24;I16=14,10,0,0,915,35713,0,0,1440,86400,0,0,425,9091,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,199:7:0 0,21,209:7:0 +X 1211 . T <*> 0 . DP=24;I16=14,10,0,0,905,34669,0,0,1440,86400,0,0,423,9139,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,213:7:0 0,21,214:7:0 +X 1212 . A <*> 0 . DP=24;I16=14,10,0,0,850,30690,0,0,1440,86400,0,0,421,9215,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,246:10:0 0,21,190:7:0 0,21,204:7:0 +X 1213 . A <*> 0 . DP=24;I16=14,10,0,0,852,31192,0,0,1440,86400,0,0,418,9268,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,253:10:0 0,21,197:7:0 0,21,195:7:0 +X 1214 . C <*> 0 . DP=23;I16=13,10,0,0,851,32099,0,0,1380,82800,0,0,415,9295,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,186:7:0 0,18,184:6:0 +X 1215 . T <*> 0 . DP=23;I16=13,9,0,0,839,32475,0,0,1320,79200,0,0,386,8668,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,211:7:0 0,15,172:5:0 +X 1216 . C <*> 0 . DP=23;I16=13,10,0,0,863,32923,0,0,1380,82800,0,0,406,9260,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,196:7:0 0,18,172:6:0 +X 1217 . A <*> 0 . DP=22;I16=12,10,0,0,820,30926,0,0,1320,79200,0,0,402,9244,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,172:6:0 0,18,191:6:0 +X 1218 . A <*> 0 . DP=22;I16=12,10,0,0,764,27286,0,0,1320,79200,0,0,398,9244,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,145:6:0 0,18,184:6:0 +X 1219 . A <*> 0 . DP=21;I16=12,9,0,0,803,31119,0,0,1260,75600,0,0,395,9259,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,175:6:0 0,15,173:5:0 +X 1220 . A <*> 0 . DP=21;I16=12,9,0,0,752,27700,0,0,1260,75600,0,0,392,9288,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,253:10:0 0,18,167:6:0 0,15,167:5:0 +X 1221 . A <*> 0 . DP=20;I16=12,8,0,0,722,26564,0,0,1200,72000,0,0,390,9330,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,147:5:0 0,15,157:5:0 +X 1222 . T <*> 0 . DP=18;I16=10,8,0,0,666,25034,0,0,1080,64800,0,0,389,9333,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,245:9:0 0,15,143:5:0 0,12,142:4:0 +X 1223 . T <*> 0 . DP=17;I16=9,7,0,0,574,21262,0,0,960,57600,0,0,364,8720,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,232:9:0 0,12,122:4:0 0,9,120:3:0 +X 1224 . C <*> 0 . DP=19;I16=10,7,0,0,639,24429,0,0,1020,61200,0,0,364,8740,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,128:4:0 0,9,112:3:0 +X 1225 . A <*> 0 . DP=19;I16=10,9,0,0,713,27139,0,0,1109,65641,0,0,395,9419,0,0;QS=3,0;MQSB=0.920044;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,137:5:0 0,12,145:4:0 +X 1226 . A <*> 0 . DP=19;I16=10,9,0,0,688,25468,0,0,1109,65641,0,0,397,9469,0,0;QS=3,0;MQSB=0.920044;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,127:5:0 0,12,147:4:0 +X 1227 . A <*> 0 . DP=19;I16=10,9,0,0,698,26104,0,0,1109,65641,0,0,399,9531,0,0;QS=3,0;MQSB=0.920044;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,133:5:0 0,12,146:4:0 +X 1228 . A <*> 0 . DP=19;I16=10,9,0,0,705,26721,0,0,1109,65641,0,0,399,9505,0,0;QS=3,0;MQSB=0.920044;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,143:5:0 0,12,145:4:0 +X 1229 . A <*> 0 . DP=18;I16=10,8,0,0,693,26891,0,0,1049,62041,0,0,400,9490,0,0;QS=3,0;MQSB=0.906029;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,123:4:0 0,12,138:4:0 +X 1230 . T <*> 0 . DP=18;I16=10,8,0,0,643,23601,0,0,1049,62041,0,0,401,9485,0,0;QS=3,0;MQSB=0.906029;MQ0F=0 PL:DP:DV 0,30,245:10:0 0,12,115:4:0 0,12,144:4:0 +X 1231 . C <*> 0 . DP=18;I16=10,7,0,0,663,26041,0,0,1020,61200,0,0,390,9320,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,98:3:0 0,12,138:4:0 +X 1232 . T <*> 0 . DP=18;I16=10,8,0,0,683,26261,0,0,1049,62041,0,0,401,9409,0,0;QS=3,0;MQSB=0.906029;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,133:4:0 0,12,129:4:0 +X 1233 . G <*> 0 . DP=18;I16=10,8,0,0,657,24509,0,0,1049,62041,0,0,401,9389,0,0;QS=3,0;MQSB=0.906029;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,124:4:0 0,12,129:4:0 +X 1234 . A <*> 0 . DP=19;I16=10,8,0,0,677,26177,0,0,1080,64800,0,0,386,9134,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,101:3:0 0,12,144:4:0 +X 1235 . A <*> 0 . DP=19;I16=10,9,0,0,697,26363,0,0,1109,65641,0,0,400,9282,0,0;QS=3,0;MQSB=0.920044;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,129:4:0 0,12,140:4:0 +X 1236 . A <*> 0 . DP=19;I16=10,9,0,0,671,24693,0,0,1109,65641,0,0,398,9148,0,0;QS=3,0;MQSB=0.920044;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,103:4:0 0,12,136:4:0 +X 1237 . T <*> 0 . DP=19;I16=9,9,0,0,649,24061,0,0,1049,62041,0,0,370,8356,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,98:3:0 0,12,135:4:0 +X 1238 . C <*> 0 . DP=20;I16=11,9,0,0,733,27709,0,0,1169,69241,0,0,391,8783,0,0;QS=3,0;MQSB=0.916401;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,104:4:0 0,12,145:4:0 +X 1239 . C <*> 0 . DP=20;I16=10,9,0,0,672,24596,0,0,1109,65641,0,0,363,7981,0,0;QS=3,0;MQSB=0.920044;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,76:3:0 0,12,124:4:0 +X 1240 . C <*> 0 . DP=20;I16=11,9,0,0,723,26895,0,0,1169,69241,0,0,385,8451,0,0;QS=3,0;MQSB=0.916401;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,118:4:0 0,12,129:4:0 +X 1241 . A <*> 0 . DP=20;I16=11,9,0,0,719,26575,0,0,1169,69241,0,0,382,8318,0,0;QS=3,0;MQSB=0.916401;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,104:4:0 0,12,141:4:0 +X 1242 . A <*> 0 . DP=21;I16=12,9,0,0,749,27599,0,0,1229,72841,0,0,379,8207,0,0;QS=3,0;MQSB=0.913101;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,109:4:0 0,15,153:5:0 +X 1243 . A <*> 0 . DP=21;I16=12,9,0,0,738,26862,0,0,1229,72841,0,0,377,8119,0,0;QS=3,0;MQSB=0.913101;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,110:4:0 0,15,158:5:0 +X 1244 . C <*> 0 . DP=21;I16=12,8,0,0,670,22952,0,0,1169,69241,0,0,365,7955,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,101:4:0 0,15,148:5:0 +X 1245 . G <*> 0 . DP=21;I16=12,9,0,0,657,21627,0,0,1229,72841,0,0,373,8015,0,0;QS=3,0;MQSB=0.913101;MQ0F=0 PL:DP:DV 0,36,245:12:0 0,12,95:4:0 0,15,158:5:0 +X 1246 . C <*> 0 . DP=21;I16=12,9,0,0,652,21348,0,0,1229,72841,0,0,370,7948,0,0;QS=3,0;MQSB=0.913101;MQ0F=0 PL:DP:DV 0,36,252:12:0 0,12,95:4:0 0,15,146:5:0 +X 1247 . G <*> 0 . DP=20;I16=11,9,0,0,655,22291,0,0,1169,69241,0,0,367,7853,0,0;QS=3,0;MQSB=0.916401;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,87:4:0 0,15,150:5:0 +X 1248 . C <*> 0 . DP=20;I16=10,8,0,0,659,25037,0,0,1080,64800,0,0,314,6530,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,90:3:0 0,15,156:5:0 +X 1249 . C <*> 0 . DP=21;I16=12,9,0,0,772,28954,0,0,1229,72841,0,0,360,7680,0,0;QS=3,0;MQSB=0.913101;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,111:4:0 0,15,166:5:0 +X 1250 . A <*> 0 . DP=21;I16=12,9,0,0,757,27599,0,0,1229,72841,0,0,356,7554,0,0;QS=3,0;MQSB=0.913101;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,114:4:0 0,15,161:5:0 +X 1251 . A <*> 0 . DP=21;I16=12,9,0,0,758,27890,0,0,1229,72841,0,0,352,7452,0,0;QS=3,0;MQSB=0.913101;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,115:4:0 0,15,174:5:0 +X 1252 . T <*> 0 . DP=21;I16=12,9,0,0,758,27574,0,0,1229,72841,0,0,348,7374,0,0;QS=3,0;MQSB=0.913101;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,124:4:0 0,15,159:5:0 +X 1253 . A <*> 0 . DP=20;I16=12,8,0,0,718,26292,0,0,1169,69241,0,0,345,7319,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,127:4:0 0,12,144:4:0 +X 1254 . A <*> 0 . DP=20;I16=12,8,0,0,781,30817,0,0,1169,69241,0,0,342,7286,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,134:4:0 0,12,156:4:0 +X 1255 . G <*> 0 . DP=21;I16=12,9,0,0,785,30039,0,0,1229,72841,0,0,339,7275,0,0;QS=3,0;MQSB=0.913101;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,128:4:0 0,15,169:5:0 +X 1256 . C <*> 0 . DP=20;I16=12,8,0,0,742,27910,0,0,1169,69241,0,0,338,7286,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,116:4:0 0,15,165:5:0 +X 1257 . A <*> 0 . DP=20;I16=12,8,0,0,745,28017,0,0,1169,69241,0,0,337,7319,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,132:4:0 0,15,167:5:0 +X 1258 . T <*> 0 . DP=20;I16=12,8,0,0,753,28507,0,0,1169,69241,0,0,336,7374,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,126:4:0 0,15,170:5:0 +X 1259 . T <*> 0 . DP=20;I16=12,8,0,0,690,24762,0,0,1169,69241,0,0,335,7451,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,33,236:11:0 0,12,128:4:0 0,15,170:5:0 +X 1260 . C <*> 0 . DP=20;I16=12,8,0,0,719,26541,0,0,1169,69241,0,0,333,7499,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,127:4:0 0,15,155:5:0 +X 1261 . C <*> 0 . DP=18;I16=11,6,0,0,602,22374,0,0,989,58441,0,0,308,6940,0,0;QS=3,0;MQSB=0.85832;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,117:4:0 0,9,109:3:0 +X 1262 . C <*> 0 . DP=18;I16=12,6,0,0,653,24345,0,0,1049,62041,0,0,333,7597,0,0;QS=3,0;MQSB=0.85394;MQ0F=0 PL:DP:DV 0,30,253:10:0 0,15,145:5:0 0,9,114:3:0 +X 1263 . T <*> 0 . DP=17;I16=12,5,0,0,654,25656,0,0,989,58441,0,0,335,7645,0,0;QS=3,0;MQSB=0.818731;MQ0F=0 PL:DP:DV 0,27,238:9:0 0,15,158:5:0 0,9,118:3:0 +X 1264 . T <*> 0 . DP=17;I16=12,5,0,0,615,22855,0,0,989,58441,0,0,336,7658,0,0;QS=3,0;MQSB=0.818731;MQ0F=0 PL:DP:DV 0,27,226:9:0 0,15,149:5:0 0,9,114:3:0 +X 1265 . T <*> 0 . DP=17;I16=12,5,0,0,620,23176,0,0,989,58441,0,0,334,7538,0,0;QS=3,0;MQSB=0.818731;MQ0F=0 PL:DP:DV 0,27,232:9:0 0,15,144:5:0 0,9,114:3:0 +X 1266 . G <*> 0 . DP=18;I16=13,5,0,0,675,25765,0,0,1049,62041,0,0,332,7438,0,0;QS=3,0;MQSB=0.814433;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,145:5:0 0,9,114:3:0 +X 1267 . A <*> 0 . DP=18;I16=13,5,0,0,663,24799,0,0,1049,62041,0,0,331,7359,0,0;QS=3,0;MQSB=0.814433;MQ0F=0 PL:DP:DV 0,30,253:10:0 0,15,138:5:0 0,9,114:3:0 +X 1268 . G <*> 0 . DP=18;I16=13,5,0,0,638,23584,0,0,1049,62041,0,0,329,7251,0,0;QS=3,0;MQSB=0.814433;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,112:5:0 0,9,108:3:0 +X 1269 . C <*> 0 . DP=18;I16=13,5,0,0,592,20458,0,0,1049,62041,0,0,327,7163,0,0;QS=3,0;MQSB=0.814433;MQ0F=0 PL:DP:DV 0,30,224:10:0 0,15,130:5:0 0,9,107:3:0 +X 1270 . G <*> 0 . DP=18;I16=13,5,0,0,537,16775,0,0,1049,62041,0,0,325,7095,0,0;QS=3,0;MQSB=0.814433;MQ0F=0 PL:DP:DV 0,30,206:10:0 0,15,104:5:0 0,9,98:3:0 +X 1271 . T <*> 0 . DP=18;I16=12,5,0,0,620,22824,0,0,989,58441,0,0,298,6422,0,0;QS=3,0;MQSB=0.818731;MQ0F=0 PL:DP:DV 0,27,240:9:0 0,15,138:5:0 0,9,109:3:0 +X 1272 . C <*> 0 . DP=17;I16=11,5,0,0,597,22587,0,0,929,54841,0,0,297,6393,0,0;QS=3,0;MQSB=0.823561;MQ0F=0 PL:DP:DV 0,27,251:9:0 0,12,113:4:0 0,9,110:3:0 +X 1273 . A <*> 0 . DP=18;I16=12,6,0,0,633,23063,0,0,1049,62041,0,0,318,6866,0,0;QS=3,0;MQSB=0.85394;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,109:4:0 0,9,113:3:0 +X 1274 . T <*> 0 . DP=17;I16=10,6,0,0,609,23335,0,0,929,54841,0,0,293,6205,0,0;QS=3,0;MQSB=0.863243;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,67:2:0 0,9,115:3:0 +X 1275 . G <*> 0 . DP=17;I16=11,6,0,0,602,21976,0,0,989,58441,0,0,317,6763,0,0;QS=3,0;MQSB=0.85832;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,87:3:0 0,9,112:3:0 +X 1276 . T <*> 0 . DP=17;I16=11,6,0,0,587,20925,0,0,989,58441,0,0,316,6714,0,0;QS=3,0;MQSB=0.85832;MQ0F=0 PL:DP:DV 0,33,248:11:0 0,9,94:3:0 0,9,110:3:0 +X 1277 . C <*> 0 . DP=18;I16=11,7,0,0,590,20126,0,0,1049,62041,0,0,314,6634,0,0;QS=3,0;MQSB=0.883327;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,85:3:0 0,9,106:3:0 +X 1278 . G <*> 0 . DP=18;I16=11,7,0,0,603,20675,0,0,1049,62041,0,0,313,6575,0,0;QS=3,0;MQSB=0.883327;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,77:3:0 0,9,96:3:0 +X 1279 . G <*> 0 . DP=18;I16=11,7,0,0,646,23662,0,0,1049,62041,0,0,312,6538,0,0;QS=3,0;MQSB=0.883327;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,85:3:0 0,9,113:3:0 +X 1280 . T <*> 0 . DP=18;I16=10,7,0,0,558,19192,0,0,989,58441,0,0,296,6298,0,0;QS=3,0;MQSB=0.887766;MQ0F=0 PL:DP:DV 0,33,249:11:0 0,9,86:3:0 0,9,97:3:0 +X 1281 . G <*> 0 . DP=17;I16=10,6,0,0,564,21244,0,0,929,54841,0,0,270,5658,0,0;QS=3,0;MQSB=0.863243;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,85:3:0 0,9,103:3:0 +X 1282 . C <*> 0 . DP=18;I16=10,8,0,0,654,24308,0,0,1049,62041,0,0,294,6286,0,0;QS=3,0;MQSB=0.906029;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,94:3:0 0,12,131:4:0 +X 1283 . T <*> 0 . DP=18;I16=10,8,0,0,677,26313,0,0,1049,62041,0,0,294,6308,0,0;QS=3,0;MQSB=0.906029;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,83:3:0 0,12,154:4:0 +X 1284 . T <*> 0 . DP=18;I16=10,8,0,0,631,22949,0,0,1049,62041,0,0,293,6301,0,0;QS=3,0;MQSB=0.906029;MQ0F=0 PL:DP:DV 0,33,254:11:0 0,9,92:3:0 0,12,145:4:0 +X 1285 . G <*> 0 . DP=18;I16=10,7,0,0,657,25545,0,0,989,58441,0,0,267,5691,0,0;QS=3,0;MQSB=0.887766;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,94:3:0 0,12,145:4:0 +X 1286 . G <*> 0 . DP=18;I16=10,8,0,0,650,24684,0,0,1049,62041,0,0,291,6353,0,0;QS=3,0;MQSB=0.906029;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,78:3:0 0,12,148:4:0 +X 1287 . A <*> 0 . DP=17;I16=9,8,0,0,609,22229,0,0,989,58441,0,0,291,6411,0,0;QS=3,0;MQSB=0.91051;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,91:3:0 0,12,137:4:0 +X 1288 . A <*> 0 . DP=17;I16=9,8,0,0,605,22315,0,0,989,58441,0,0,290,6438,0,0;QS=3,0;MQSB=0.91051;MQ0F=0 PL:DP:DV 0,30,245:10:0 0,9,103:3:0 0,12,140:4:0 +X 1289 . T <*> 0 . DP=18;I16=10,8,0,0,637,23207,0,0,1049,62041,0,0,289,6483,0,0;QS=3,0;MQSB=0.906029;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,99:3:0 0,12,141:4:0 +X 1290 . G <*> 0 . DP=15;I16=9,6,0,0,559,21163,0,0,869,51241,0,0,292,6544,0,0;QS=3,0;MQSB=0.868815;MQ0F=0 PL:DP:DV 0,27,242:9:0 0,9,97:3:0 0,9,106:3:0 +X 1291 . T <*> 0 . DP=15;I16=9,6,0,0,547,20303,0,0,869,51241,0,0,295,6619,0,0;QS=3,0;MQSB=0.868815;MQ0F=0 PL:DP:DV 0,27,225:9:0 0,9,91:3:0 0,9,117:3:0 +X 1292 . T <*> 0 . DP=15;I16=9,6,0,0,559,21121,0,0,869,51241,0,0,297,6657,0,0;QS=3,0;MQSB=0.868815;MQ0F=0 PL:DP:DV 0,27,236:9:0 0,9,95:3:0 0,9,113:3:0 +X 1293 . T <*> 0 . DP=15;I16=9,6,0,0,578,22428,0,0,869,51241,0,0,299,6707,0,0;QS=3,0;MQSB=0.868815;MQ0F=0 PL:DP:DV 0,27,242:9:0 0,9,100:3:0 0,9,116:3:0 +X 1294 . G <*> 0 . DP=16;I16=9,7,0,0,606,23572,0,0,929,54841,0,0,301,6769,0,0;QS=3,0;MQSB=0.892753;MQ0F=0 PL:DP:DV 0,27,254:9:0 0,12,110:4:0 0,9,119:3:0 +X 1295 . G <*> 0 . DP=16;I16=9,7,0,0,567,21419,0,0,929,54841,0,0,304,6844,0,0;QS=3,0;MQSB=0.892753;MQ0F=0 PL:DP:DV 0,27,244:9:0 0,12,102:4:0 0,9,114:3:0 +X 1296 . G <*> 0 . DP=16;I16=8,7,0,0,518,19300,0,0,869,51241,0,0,294,6740,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,27,227:9:0 0,9,89:3:0 0,9,114:3:0 +X 1297 . G <*> 0 . DP=18;I16=9,8,0,0,551,19323,0,0,958,55682,0,0,322,7444,0,0;QS=3,0;MQSB=0.998843;MQ0F=0 PL:DP:DV 0,30,219:10:0 0,9,86:3:0 0,12,133:4:0 +X 1298 . T <*> 0 . DP=18;I16=10,8,0,0,615,22371,0,0,1018,59282,0,0,336,7638,0,0;QS=3,0;MQSB=0.99606;MQ0F=0 PL:DP:DV 0,30,233:10:0 0,12,105:4:0 0,12,138:4:0 +X 1299 . T <*> 0 . DP=18;I16=9,8,0,0,619,23135,0,0,958,55682,0,0,328,7548,0,0;QS=3,0;MQSB=0.998843;MQ0F=0 PL:DP:DV 0,30,242:10:0 0,9,97:3:0 0,12,136:4:0 +X 1300 . T <*> 0 . DP=18;I16=10,8,0,0,631,23107,0,0,1018,59282,0,0,338,7638,0,0;QS=3,0;MQSB=0.99606;MQ0F=0 PL:DP:DV 0,30,235:10:0 0,12,121:4:0 0,12,136:4:0 +X 1301 . T G,<*> 0 . DP=18;I16=8,8,1,0,599,22623,18,324,929,54841,29,841,314,7040,25,625;QS=2.9434,0.0566038,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.998843;BQB=1;MQ0F=0 PL:DP:DV 0,9,213,24,216,222:9:1 0,12,126,12,126,126:4:0 0,12,135,12,135,135:4:0 +X 1302 . G <*> 0 . DP=17;I16=9,8,0,0,624,23544,0,0,958,55682,0,0,341,7709,0,0;QS=3,0;MQSB=0.998843;MQ0F=0 PL:DP:DV 0,27,240:9:0 0,12,127:4:0 0,12,140:4:0 +X 1303 . G <*> 0 . DP=17;I16=9,8,0,0,582,21200,0,0,958,55682,0,0,342,7718,0,0;QS=3,0;MQSB=0.998843;MQ0F=0 PL:DP:DV 0,27,217:9:0 0,12,125:4:0 0,12,138:4:0 +X 1304 . A <*> 0 . DP=18;I16=10,8,0,0,652,24124,0,0,1018,59282,0,0,343,7741,0,0;QS=3,0;MQSB=0.99606;MQ0F=0 PL:DP:DV 0,27,218:9:0 0,12,131:4:0 0,15,169:5:0 +X 1305 . T <*> 0 . DP=18;I16=10,8,0,0,685,26381,0,0,1018,59282,0,0,345,7779,0,0;QS=3,0;MQSB=0.99606;MQ0F=0 PL:DP:DV 0,27,241:9:0 0,12,122:4:0 0,15,174:5:0 +X 1306 . T <*> 0 . DP=18;I16=9,8,0,0,644,24628,0,0,958,55682,0,0,345,7829,0,0;QS=3,0;MQSB=0.998843;MQ0F=0 PL:DP:DV 0,27,236:9:0 0,9,106:3:0 0,15,168:5:0 +X 1307 . T <*> 0 . DP=17;I16=9,8,0,0,628,23746,0,0,958,55682,0,0,348,7902,0,0;QS=3,0;MQSB=0.998843;MQ0F=0 PL:DP:DV 0,27,226:9:0 0,9,104:3:0 0,15,167:5:0 +X 1308 . A <*> 0 . DP=19;I16=9,10,0,0,690,25500,0,0,1078,62882,0,0,350,7938,0,0;QS=3,0;MQSB=0.999167;MQ0F=0 PL:DP:DV 0,30,236:10:0 0,12,127:4:0 0,15,173:5:0 +X 1309 . C <*> 0 . DP=19;I16=9,9,0,0,698,27148,0,0,1049,62041,0,0,342,7818,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,106:3:0 0,15,169:5:0 +X 1310 . A <*> 0 . DP=19;I16=9,10,0,0,751,29953,0,0,1078,62882,0,0,356,7958,0,0;QS=3,0;MQSB=0.999167;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,132:4:0 0,15,183:5:0 +X 1311 . G <*> 0 . DP=19;I16=9,10,0,0,742,29384,0,0,1078,62882,0,0,359,7995,0,0;QS=3,0;MQSB=0.999167;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,128:4:0 0,15,174:5:0 +X 1312 . C <*> 0 . DP=19;I16=9,10,0,0,717,27783,0,0,1078,62882,0,0,362,8050,0,0;QS=3,0;MQSB=0.999167;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,115:4:0 0,15,166:5:0 +X 1313 . T <*> 0 . DP=19;I16=9,10,0,0,751,30061,0,0,1078,62882,0,0,364,8074,0,0;QS=3,0;MQSB=0.999167;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,135:4:0 0,15,175:5:0 +X 1314 . T <*> 0 . DP=19;I16=9,10,0,0,707,26983,0,0,1078,62882,0,0,366,8118,0,0;QS=3,0;MQSB=0.999167;MQ0F=0 PL:DP:DV 0,30,245:10:0 0,12,134:4:0 0,15,174:5:0 +X 1315 . T <*> 0 . DP=19;I16=9,10,0,0,717,27491,0,0,1078,62882,0,0,367,8131,0,0;QS=3,0;MQSB=0.999167;MQ0F=0 PL:DP:DV 0,30,250:10:0 0,12,132:4:0 0,15,174:5:0 +X 1316 . G <*> 0 . DP=21;I16=10,11,0,0,776,29502,0,0,1198,70082,0,0,368,8162,0,0;QS=3,0;MQSB=0.99938;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,128:4:0 0,18,188:6:0 +X 1317 . G <*> 0 . DP=21;I16=10,11,0,0,751,27855,0,0,1198,70082,0,0,371,8213,0,0;QS=3,0;MQSB=0.99938;MQ0F=0 PL:DP:DV 0,33,253:11:0 0,12,130:4:0 0,18,179:6:0 +X 1318 . G <*> 0 . DP=21;I16=10,11,0,0,749,27663,0,0,1198,70082,0,0,372,8188,0,0;QS=3,0;MQSB=0.99938;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,130:4:0 0,18,184:6:0 +X 1319 . A <*> 0 . DP=21;I16=10,11,0,0,768,28390,0,0,1198,70082,0,0,373,8189,0,0;QS=3,0;MQSB=0.99938;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,124:4:0 0,18,186:6:0 +X 1320 . C <*> 0 . DP=21;I16=10,11,0,0,728,25496,0,0,1198,70082,0,0,373,8165,0,0;QS=3,0;MQSB=0.99938;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,113:4:0 0,18,161:6:0 +X 1321 . G <*> 0 . DP=22;I16=10,12,0,0,762,27412,0,0,1289,76441,0,0,374,8164,0,0;QS=3,0;MQSB=0.924723;MQ0F=0 PL:DP:DV 0,33,244:11:0 0,9,104:3:0 0,24,208:8:0 +X 1322 . C <*> 0 . DP=22;I16=10,12,0,0,852,33528,0,0,1289,76441,0,0,377,8187,0,0;QS=3,0;MQSB=0.924723;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,111:3:0 0,24,225:8:0 +X 1323 . T <*> 0 . DP=22;I16=10,12,0,0,874,35152,0,0,1289,76441,0,0,379,8185,0,0;QS=3,0;MQSB=0.924723;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,112:3:0 0,24,237:8:0 +X 1324 . C <*> 0 . DP=21;I16=9,12,0,0,793,30585,0,0,1229,72841,0,0,381,8157,0,0;QS=3,0;MQSB=0.913101;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,109:3:0 0,24,218:8:0 +X 1325 . A <*> 0 . DP=21;I16=9,12,0,0,782,29430,0,0,1229,72841,0,0,383,8153,0,0;QS=3,0;MQSB=0.913101;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,105:3:0 0,24,218:8:0 +X 1326 . A <*> 0 . DP=21;I16=9,12,0,0,791,30479,0,0,1229,72841,0,0,385,8173,0,0;QS=3,0;MQSB=0.913101;MQ0F=0 PL:DP:DV 0,30,249:10:0 0,9,108:3:0 0,24,230:8:0 +X 1327 . C <*> 0 . DP=23;I16=11,12,0,0,834,31048,0,0,1349,80041,0,0,387,8217,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,99:3:0 0,27,237:9:0 +X 1328 . C <*> 0 . DP=23;I16=11,12,0,0,878,33972,0,0,1349,80041,0,0,391,8287,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,105:3:0 0,27,254:9:0 +X 1329 . T <*> 0 . DP=23;I16=11,12,0,0,882,34756,0,0,1349,80041,0,0,395,8385,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,112:3:0 0,27,255:9:0 +X 1330 . G <*> 0 . DP=23;I16=11,12,0,0,856,32638,0,0,1349,80041,0,0,398,8460,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,101:3:0 0,27,241:9:0 +X 1331 . T <*> 0 . DP=23;I16=11,12,0,0,847,31785,0,0,1349,80041,0,0,400,8512,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,106:3:0 0,27,247:9:0 +X 1332 . A <*> 0 . DP=23;I16=11,12,0,0,826,30264,0,0,1349,80041,0,0,402,8592,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,33,252:11:0 0,9,104:3:0 0,27,238:9:0 +X 1333 . C <*> 0 . DP=23;I16=11,12,0,0,836,30928,0,0,1349,80041,0,0,404,8700,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,101:3:0 0,27,236:9:0 +X 1334 . C <*> 0 . DP=22;I16=11,11,0,0,830,32380,0,0,1289,76441,0,0,405,8733,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,107:3:0 0,27,238:9:0 +X 1335 . T <*> 0 . DP=22;I16=11,11,0,0,877,35371,0,0,1289,76441,0,0,406,8788,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,113:3:0 0,27,253:9:0 +X 1336 . C <*> 0 . DP=25;I16=12,12,0,0,890,33648,0,0,1378,80882,0,0,398,8784,0,0;QS=3,0;MQSB=0.786628;MQ0F=0 PL:DP:DV 0,33,250:11:0 0,12,131:4:0 0,27,237:9:0 +X 1337 . A <*> 0 . DP=26;I16=13,13,0,0,941,34611,0,0,1498,88082,0,0,411,8967,0,0;QS=3,0;MQSB=0.800737;MQ0F=0 PL:DP:DV 0,33,249:11:0 0,15,152:5:0 0,30,247:10:0 +X 1338 . A <*> 0 . DP=26;I16=12,14,0,0,982,37358,0,0,1498,88082,0,0,416,9048,0,0;QS=3,0;MQSB=0.771623;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,153:5:0 0,30,255:10:0 +X 1339 . T <*> 0 . DP=27;I16=12,15,0,0,989,36855,0,0,1558,91682,0,0,422,9160,0,0;QS=3,0;MQSB=0.765017;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,151:5:0 0,33,255:11:0 +X 1340 . A <*> 0 . DP=27;I16=11,15,0,0,937,34141,0,0,1498,88082,0,0,425,9289,0,0;QS=3,0;MQSB=0.738577;MQ0F=0 PL:DP:DV 0,30,250:10:0 0,15,149:5:0 0,33,254:11:0 +X 1341 . A <*> 0 . DP=27;I16=12,14,0,0,929,33961,0,0,1498,88082,0,0,410,8810,0,0;QS=3,0;MQSB=0.771623;MQ0F=0 PL:DP:DV 0,30,245:10:0 0,15,141:5:0 0,33,255:11:0 +X 1342 . A <*> 0 . DP=27;I16=12,15,0,0,951,34575,0,0,1558,91682,0,0,439,9499,0,0;QS=3,0;MQSB=0.765017;MQ0F=0 PL:DP:DV 0,33,254:11:0 0,15,159:5:0 0,33,249:11:0 +X 1343 . C <*> 0 . DP=25;I16=10,15,0,0,902,33364,0,0,1469,87241,0,0,445,9593,0,0;QS=3,0;MQSB=0.9171;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,140:5:0 0,30,233:10:0 +X 1344 . C <*> 0 . DP=26;I16=10,16,0,0,985,37915,0,0,1529,90841,0,0,451,9715,0,0;QS=3,0;MQSB=0.914947;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,163:6:0 0,30,238:10:0 +X 1345 . T <*> 0 . DP=26;I16=10,16,0,0,1004,39262,0,0,1529,90841,0,0,458,9866,0,0;QS=3,0;MQSB=0.914947;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,182:6:0 0,30,242:10:0 +X 1346 . G <*> 0 . DP=26;I16=10,16,0,0,1003,38983,0,0,1529,90841,0,0,465,10047,0,0;QS=3,0;MQSB=0.914947;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,172:6:0 0,30,239:10:0 +X 1347 . A <*> 0 . DP=26;I16=10,16,0,0,995,38409,0,0,1529,90841,0,0,470,10156,0,0;QS=3,0;MQSB=0.914947;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,177:6:0 0,30,243:10:0 +X 1348 . T <*> 0 . DP=26;I16=10,16,0,0,988,38126,0,0,1529,90841,0,0,474,10242,0,0;QS=3,0;MQSB=0.914947;MQ0F=0 PL:DP:DV 0,30,252:10:0 0,18,185:6:0 0,30,251:10:0 +X 1349 . T <*> 0 . DP=26;I16=9,15,0,0,905,34409,0,0,1409,83641,0,0,454,9730,0,0;QS=3,0;MQSB=0.904837;MQ0F=0 PL:DP:DV 0,24,225:8:0 0,18,176:6:0 0,30,248:10:0 +X 1350 . T <*> 0 . DP=26;I16=10,16,0,0,975,36909,0,0,1498,88082,0,0,485,10495,0,0;QS=3,0;MQSB=0.700784;MQ0F=0 PL:DP:DV 0,27,242:9:0 0,21,195:7:0 0,30,249:10:0 +X 1351 . T <*> 0 . DP=26;I16=10,16,0,0,956,35602,0,0,1498,88082,0,0,491,10663,0,0;QS=3,0;MQSB=0.700784;MQ0F=0 PL:DP:DV 0,27,238:9:0 0,21,193:7:0 0,30,240:10:0 +X 1352 . A <*> 0 . DP=26;I16=10,16,0,0,901,31965,0,0,1498,88082,0,0,496,10810,0,0;QS=3,0;MQSB=0.700784;MQ0F=0 PL:DP:DV 0,27,250:9:0 0,21,180:7:0 0,30,211:10:0 +X 1353 . A <*> 0 . DP=26;I16=10,16,0,0,927,33583,0,0,1498,88082,0,0,499,10885,0,0;QS=3,0;MQSB=0.700784;MQ0F=0 PL:DP:DV 0,27,240:9:0 0,21,187:7:0 0,30,224:10:0 +X 1354 . A <*> 0 . DP=26;I16=10,16,0,0,927,33621,0,0,1498,88082,0,0,502,10986,0,0;QS=3,0;MQSB=0.700784;MQ0F=0 PL:DP:DV 0,27,237:9:0 0,21,190:7:0 0,30,223:10:0 +X 1355 . A <*> 0 . DP=26;I16=10,16,0,0,924,33736,0,0,1498,88082,0,0,505,11113,0,0;QS=3,0;MQSB=0.700784;MQ0F=0 PL:DP:DV 0,27,239:9:0 0,21,186:7:0 0,30,227:10:0 +X 1356 . A <*> 0 . DP=25;I16=10,15,0,0,916,34050,0,0,1438,84482,0,0,509,11265,0,0;QS=3,0;MQSB=0.707404;MQ0F=0 PL:DP:DV 0,27,249:9:0 0,21,178:7:0 0,27,226:9:0 +X 1357 . A <*> 0 . DP=25;I16=9,15,0,0,949,38007,0,0,1378,80882,0,0,488,10816,0,0;QS=3,0;MQSB=0.67032;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,21,193:7:0 0,24,217:8:0 +X 1358 . G <*> 0 . DP=25;I16=9,15,0,0,873,32435,0,0,1378,80882,0,0,491,10967,0,0;QS=3,0;MQSB=0.67032;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,21,172:7:0 0,24,188:8:0 +X 1359 . T <*> 0 . DP=25;I16=9,15,0,0,857,31139,0,0,1378,80882,0,0,494,11144,0,0;QS=3,0;MQSB=0.67032;MQ0F=0 PL:DP:DV 0,27,232:9:0 0,21,184:7:0 0,24,196:8:0 +X 1360 . T <*> 0 . DP=25;I16=9,15,0,0,879,32419,0,0,1378,80882,0,0,497,11347,0,0;QS=3,0;MQSB=0.67032;MQ0F=0 PL:DP:DV 0,27,248:9:0 0,21,184:7:0 0,24,192:8:0 +X 1361 . T <*> 0 . DP=27;I16=9,17,0,0,936,34238,0,0,1498,88082,0,0,500,11576,0,0;QS=3,0;MQSB=0.657209;MQ0F=0 PL:DP:DV 0,27,234:9:0 0,24,201:8:0 0,27,206:9:0 +X 1362 . G <*> 0 . DP=26;I16=9,17,0,0,973,36785,0,0,1498,88082,0,0,502,11680,0,0;QS=3,0;MQSB=0.657209;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,24,202:8:0 0,27,207:9:0 +X 1363 . G <*> 0 . DP=25;I16=8,17,0,0,936,35390,0,0,1438,84482,0,0,504,11756,0,0;QS=3,0;MQSB=0.612391;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,21,181:7:0 0,27,202:9:0 +X 1364 . G <*> 0 . DP=25;I16=8,17,0,0,902,32840,0,0,1438,84482,0,0,504,11752,0,0;QS=3,0;MQSB=0.612391;MQ0F=0 PL:DP:DV 0,27,233:9:0 0,21,184:7:0 0,27,200:9:0 +X 1365 . G <*> 0 . DP=26;I16=9,17,0,0,946,35224,0,0,1498,88082,0,0,503,11717,0,0;QS=3,0;MQSB=0.657209;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,24,190:8:0 0,27,202:9:0 +X 1366 . G <*> 0 . DP=25;I16=8,15,0,0,840,31058,0,0,1318,77282,0,0,454,10450,0,0;QS=3,0;MQSB=0.625784;MQ0F=0 PL:DP:DV 0,21,215:7:0 0,21,181:7:0 0,27,199:9:0 +X 1367 . G C,<*> 0 . DP=25;I16=7,16,0,1,836,30888,27,729,1349,80041,60,3600,472,11152,15,225;QS=2.91641,0.0835913,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.864405;BQB=1;MQ0F=0 PL:DP:DV 0,24,236,24,236,236:8:0 0,21,179,21,179,179:7:0 0,0,171,24,174,189:9:1 +X 1368 . A <*> 0 . DP=26;I16=8,17,0,0,869,30839,0,0,1438,84482,0,0,481,11095,0,0;QS=3,0;MQSB=0.612391;MQ0F=0 PL:DP:DV 0,27,240:9:0 0,21,180:7:0 0,27,197:9:0 +X 1369 . T <*> 0 . DP=26;I16=8,18,0,0,902,32160,0,0,1498,88082,0,0,508,11758,0,0;QS=3,0;MQSB=0.606531;MQ0F=0 PL:DP:DV 0,27,242:9:0 0,24,197:8:0 0,27,194:9:0 +X 1370 . T <*> 0 . DP=27;I16=8,17,0,0,926,34736,0,0,1438,84482,0,0,458,10466,0,0;QS=3,0;MQSB=0.612391;MQ0F=0 PL:DP:DV 0,27,238:9:0 0,21,195:7:0 0,27,215:9:0 +X 1371 . C <*> 0 . DP=27;I16=8,19,0,0,929,33255,0,0,1558,91682,0,0,509,11695,0,0;QS=3,0;MQSB=0.601139;MQ0F=0 PL:DP:DV 0,27,241:9:0 0,24,196:8:0 0,30,196:10:0 +X 1372 . C <*> 0 . DP=27;I16=8,19,0,0,954,34882,0,0,1558,91682,0,0,510,11696,0,0;QS=3,0;MQSB=0.601139;MQ0F=0 PL:DP:DV 0,27,251:9:0 0,24,198:8:0 0,30,200:10:0 +X 1373 . C <*> 0 . DP=26;I16=8,17,0,0,892,32692,0,0,1438,84482,0,0,486,11044,0,0;QS=3,0;MQSB=0.612391;MQ0F=0 PL:DP:DV 0,24,243:8:0 0,21,186:7:0 0,30,195:10:0 +X 1374 . C <*> 0 . DP=26;I16=8,17,0,0,953,36553,0,0,1438,84482,0,0,487,11039,0,0;QS=3,0;MQSB=0.612391;MQ0F=0 PL:DP:DV 0,24,249:8:0 0,21,193:7:0 0,30,211:10:0 +X 1375 . T <*> 0 . DP=27;I16=9,18,0,0,1011,38377,0,0,1558,91682,0,0,512,11630,0,0;QS=3,0;MQSB=0.651439;MQ0F=0 PL:DP:DV 0,27,243:9:0 0,24,215:8:0 0,30,215:10:0 +X 1376 . A <*> 0 . DP=27;I16=9,17,0,0,912,32444,0,0,1498,88082,0,0,488,10992,0,0;QS=3,0;MQSB=0.657209;MQ0F=0 PL:DP:DV 0,27,234:9:0 0,21,198:7:0 0,30,195:10:0 +X 1377 . A <*> 0 . DP=26;I16=9,17,0,0,994,38518,0,0,1498,88082,0,0,515,11625,0,0;QS=3,0;MQSB=0.657209;MQ0F=0 PL:DP:DV 0,24,228:8:0 0,24,221:8:0 0,30,228:10:0 +X 1378 . G <*> 0 . DP=26;I16=9,17,0,0,910,33180,0,0,1498,88082,0,0,517,11653,0,0;QS=3,0;MQSB=0.657209;MQ0F=0 PL:DP:DV 0,24,234:8:0 0,24,199:8:0 0,30,197:10:0 +X 1379 . C <*> 0 . DP=26;I16=9,17,0,0,891,31779,0,0,1498,88082,0,0,519,11701,0,0;QS=3,0;MQSB=0.657209;MQ0F=0 PL:DP:DV 0,24,228:8:0 0,24,198:8:0 0,30,193:10:0 +X 1380 . C <*> 0 . DP=26;I16=9,17,0,0,925,33925,0,0,1498,88082,0,0,520,11720,0,0;QS=3,0;MQSB=0.657209;MQ0F=0 PL:DP:DV 0,24,226:8:0 0,24,202:8:0 0,30,209:10:0 +X 1381 . C <*> 0 . DP=28;I16=10,18,0,0,878,28560,0,0,1618,95282,0,0,521,11761,0,0;QS=3,0;MQSB=0.689069;MQ0F=0 PL:DP:DV 0,24,211:8:0 0,24,177:8:0 0,36,208:12:0 +X 1382 . G <*> 0 . DP=28;I16=8,18,0,0,905,32553,0,0,1529,90841,0,0,482,10912,0,0;QS=3,0;MQSB=0.882497;MQ0F=0 PL:DP:DV 0,24,213:8:0 0,18,152:6:0 0,36,243:12:0 +X 1383 . C <*> 0 . DP=27;I16=10,16,0,0,897,32373,0,0,1498,88082,0,0,502,11242,0,0;QS=3,0;MQSB=0.700784;MQ0F=0 PL:DP:DV 0,24,225:8:0 0,21,163:7:0 0,33,241:11:0 +X 1384 . C <*> 0 . DP=28;I16=11,17,0,0,980,35558,0,0,1618,95282,0,0,529,11885,0,0;QS=3,0;MQSB=0.726331;MQ0F=0 PL:DP:DV 0,27,248:9:0 0,24,184:8:0 0,33,239:11:0 +X 1385 . A <*> 0 . DP=30;I16=11,18,0,0,949,33215,0,0,1678,98882,0,0,508,11356,0,0;QS=3,0;MQSB=0.720887;MQ0F=0 PL:DP:DV 0,30,232:10:0 0,27,185:9:0 0,30,234:10:0 +X 1386 . C <*> 0 . DP=30;I16=11,19,0,0,1088,39938,0,0,1738,102482,0,0,537,12011,0,0;QS=3,0;MQSB=0.715831;MQ0F=0 PL:DP:DV 0,30,248:10:0 0,27,218:9:0 0,33,255:11:0 +X 1387 . C <*> 0 . DP=31;I16=12,19,0,0,1101,40297,0,0,1798,106082,0,0,540,12022,0,0;QS=3,0;MQSB=0.743137;MQ0F=0 PL:DP:DV 0,33,250:11:0 0,27,219:9:0 0,33,252:11:0 +X 1388 . C <*> 0 . DP=31;I16=11,19,0,0,999,34081,0,0,1769,105241,0,0,519,11439,0,0;QS=3,0;MQSB=0.91982;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,185:8:0 0,33,211:11:0 +X 1389 . G <*> 0 . DP=31;I16=11,19,0,0,1065,39119,0,0,1738,102482,0,0,535,11941,0,0;QS=3,0;MQSB=0.715831;MQ0F=0 PL:DP:DV 0,27,234:9:0 0,30,234:10:0 0,33,255:11:0 +X 1390 . G <*> 0 . DP=31;I16=12,19,0,0,1152,43744,0,0,1798,106082,0,0,555,12241,0,0;QS=3,0;MQSB=0.743137;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,30,245:10:0 0,33,255:11:0 +X 1391 . A <*> 0 . DP=31;I16=12,19,0,0,1241,50255,0,0,1798,106082,0,0,560,12326,0,0;QS=3,0;MQSB=0.743137;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,30,255:10:0 0,33,255:11:0 +X 1392 . G <*> 0 . DP=31;I16=12,19,0,0,1160,44364,0,0,1798,106082,0,0,564,12392,0,0;QS=3,0;MQSB=0.743137;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,30,250:10:0 0,33,255:11:0 +X 1393 . A <*> 0 . DP=31;I16=12,19,0,0,1123,41811,0,0,1798,106082,0,0,568,12490,0,0;QS=3,0;MQSB=0.743137;MQ0F=0 PL:DP:DV 0,30,228:10:0 0,30,255:10:0 0,33,255:11:0 +X 1394 . C <*> 0 . DP=31;I16=12,19,0,0,1139,42555,0,0,1798,106082,0,0,571,12569,0,0;QS=3,0;MQSB=0.743137;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,30,244:10:0 0,33,255:11:0 +X 1395 . A <*> 0 . DP=31;I16=12,19,0,0,1206,48048,0,0,1798,106082,0,0,575,12677,0,0;QS=3,0;MQSB=0.743137;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,240:9:0 0,33,255:11:0 +X 1396 . G <*> 0 . DP=31;I16=12,19,0,0,1196,46882,0,0,1798,106082,0,0,579,12763,0,0;QS=3,0;MQSB=0.743137;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,249:9:0 0,33,255:11:0 +X 1397 . C <*> 0 . DP=31;I16=12,18,0,0,993,33339,0,0,1738,102482,0,0,579,12775,0,0;QS=3,0;MQSB=0.748022;MQ0F=0 PL:DP:DV 0,30,231:10:0 0,27,205:9:0 0,33,217:11:0 +X 1398 . G <*> 0 . DP=30;I16=12,18,0,0,1055,38309,0,0,1738,102482,0,0,584,12826,0,0;QS=3,0;MQSB=0.748022;MQ0F=0 PL:DP:DV 0,33,250:11:0 0,27,229:9:0 0,30,244:10:0 +X 1399 . G <*> 0 . DP=30;I16=12,18,0,0,1132,43666,0,0,1738,102482,0,0,586,12854,0,0;QS=3,0;MQSB=0.748022;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,239:9:0 0,30,255:10:0 +X 1400 . A <*> 0 . DP=30;I16=11,18,0,0,1101,42271,0,0,1678,98882,0,0,563,12289,0,0;QS=3,0;MQSB=0.720887;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,27,239:9:0 0,30,246:10:0 +X 1401 . T <*> 0 . DP=30;I16=12,18,0,0,1130,44170,0,0,1738,102482,0,0,589,12955,0,0;QS=3,0;MQSB=0.748022;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,251:9:0 0,30,255:10:0 +X 1402 . T <*> 0 . DP=31;I16=13,18,0,0,1152,44058,0,0,1798,106082,0,0,589,12977,0,0;QS=3,0;MQSB=0.771348;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,244:9:0 0,30,255:10:0 +X 1403 . T <*> 0 . DP=31;I16=13,18,0,0,1178,45296,0,0,1798,106082,0,0,590,13032,0,0;QS=3,0;MQSB=0.771348;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,249:9:0 0,30,255:10:0 +X 1404 . C <*> 0 . DP=31;I16=13,18,0,0,1102,40838,0,0,1798,106082,0,0,591,13121,0,0;QS=3,0;MQSB=0.771348;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,236:9:0 0,30,244:10:0 +X 1405 . C <*> 0 . DP=30;I16=12,18,0,0,1154,45216,0,0,1738,102482,0,0,593,13243,0,0;QS=3,0;MQSB=0.748022;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,241:9:0 0,27,229:9:0 +X 1406 . T <*> 0 . DP=30;I16=12,18,0,0,1153,44919,0,0,1738,102482,0,0,595,13397,0,0;QS=3,0;MQSB=0.748022;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,248:9:0 0,27,223:9:0 +X 1407 . T <*> 0 . DP=30;I16=11,18,0,0,1074,40182,0,0,1678,98882,0,0,570,12856,0,0;QS=3,0;MQSB=0.720887;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,231:9:0 0,27,215:9:0 +X 1408 . A <*> 0 . DP=30;I16=12,18,0,0,1131,43363,0,0,1738,102482,0,0,596,13592,0,0;QS=3,0;MQSB=0.748022;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,30,244:10:0 0,27,234:9:0 +X 1409 . G <*> 0 . DP=29;I16=12,17,0,0,1082,40752,0,0,1678,98882,0,0,599,13729,0,0;QS=3,0;MQSB=0.753269;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,237:9:0 0,27,204:9:0 +X 1410 . T <*> 0 . DP=29;I16=12,17,0,0,1084,41030,0,0,1678,98882,0,0,601,13841,0,0;QS=3,0;MQSB=0.753269;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,239:9:0 0,27,218:9:0 +X 1411 . T <*> 0 . DP=29;I16=12,17,0,0,958,32550,0,0,1678,98882,0,0,600,13826,0,0;QS=3,0;MQSB=0.753269;MQ0F=0 PL:DP:DV 0,33,250:11:0 0,27,206:9:0 0,27,194:9:0 +X 1412 . A T,<*> 0 . DP=29;I16=11,17,1,0,924,31586,25,625,1649,98041,29,841,573,13159,24,576;QS=2.90842,0.0915751,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.753269;BQB=1;MQ0F=0 PL:DP:DV 0,33,245,33,245,245:11:0 0,2,171,24,174,187:9:1 0,27,192,27,192,192:9:0 +X 1413 . C <*> 0 . DP=29;I16=12,17,0,0,1067,39941,0,0,1678,98882,0,0,591,13521,0,0;QS=3,0;MQSB=0.753269;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,230:9:0 0,27,209:9:0 +X 1414 . T <*> 0 . DP=29;I16=12,17,0,0,1123,44271,0,0,1678,98882,0,0,585,13335,0,0;QS=3,0;MQSB=0.753269;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,236:9:0 0,27,221:9:0 +X 1415 . T <*> 0 . DP=29;I16=12,17,0,0,1000,35254,0,0,1678,98882,0,0,577,13077,0,0;QS=3,0;MQSB=0.753269;MQ0F=0 PL:DP:DV 0,33,246:11:0 0,27,216:9:0 0,27,208:9:0 +X 1416 . A <*> 0 . DP=30;I16=13,17,0,0,1026,36124,0,0,1738,102482,0,0,569,12847,0,0;QS=3,0;MQSB=0.776389;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,208:9:0 0,27,199:9:0 +X 1417 . C <*> 0 . DP=29;I16=13,16,0,0,1111,42941,0,0,1678,98882,0,0,563,12645,0,0;QS=3,0;MQSB=0.781802;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,235:9:0 0,24,211:8:0 +X 1418 . T <*> 0 . DP=29;I16=13,16,0,0,1111,43021,0,0,1678,98882,0,0,557,12471,0,0;QS=3,0;MQSB=0.781802;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,231:9:0 0,24,207:8:0 +X 1419 . A <*> 0 . DP=29;I16=13,16,0,0,1039,38191,0,0,1678,98882,0,0,551,12325,0,0;QS=3,0;MQSB=0.781802;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,222:9:0 0,24,199:8:0 +X 1420 . T <*> 0 . DP=29;I16=13,16,0,0,1039,37885,0,0,1678,98882,0,0,544,12158,0,0;QS=3,0;MQSB=0.781802;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,234:9:0 0,24,185:8:0 +X 1421 . G <*> 0 . DP=31;I16=13,18,0,0,1129,41649,0,0,1798,106082,0,0,536,11970,0,0;QS=3,0;MQSB=0.771348;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,30,247:10:0 0,24,191:8:0 +X 1422 . C <*> 0 . DP=29;I16=13,16,0,0,1075,40645,0,0,1678,98882,0,0,532,11810,0,0;QS=3,0;MQSB=0.781802;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,30,239:10:0 0,18,180:6:0 +X 1423 . T <*> 0 . DP=31;I16=14,17,0,0,1179,45767,0,0,1798,106082,0,0,528,11678,0,0;QS=3,0;MQSB=0.79638;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,36,255:12:0 0,18,183:6:0 +X 1424 . C <*> 0 . DP=30;I16=13,17,0,0,1086,40448,0,0,1738,102482,0,0,527,11575,0,0;QS=3,0;MQSB=0.776389;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,36,255:12:0 0,18,174:6:0 +X 1425 . C <*> 0 . DP=30;I16=13,17,0,0,1124,42974,0,0,1738,102482,0,0,525,11453,0,0;QS=3,0;MQSB=0.776389;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,36,255:12:0 0,18,180:6:0 +X 1426 . T <*> 0 . DP=32;I16=15,17,0,0,1218,47130,0,0,1858,109682,0,0,523,11363,0,0;QS=3,0;MQSB=0.813784;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,36,255:12:0 0,18,188:6:0 +X 1427 . T <*> 0 . DP=32;I16=14,18,0,0,1126,40772,0,0,1827,106923,0,0,524,11306,0,0;QS=3,0;MQSB=0.916401;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,36,255:12:0 0,18,176:6:0 +X 1428 . G <*> 0 . DP=33;I16=15,18,0,0,1188,43596,0,0,1887,110523,0,0,525,11233,0,0;QS=3,0;MQSB=0.930476;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,36,255:12:0 0,18,166:6:0 +X 1429 . G <*> 0 . DP=33;I16=14,18,0,0,1070,37720,0,0,1858,109682,0,0,507,10795,0,0;QS=3,0;MQSB=0.997118;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,33,243:11:0 0,18,148:6:0 +X 1430 . C <*> 0 . DP=33;I16=15,18,0,0,1145,40795,0,0,1887,110523,0,0,529,11193,0,0;QS=3,0;MQSB=0.930476;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,36,247:12:0 0,18,157:6:0 +X 1431 . C <*> 0 . DP=33;I16=15,18,0,0,1160,41686,0,0,1887,110523,0,0,531,11227,0,0;QS=3,0;MQSB=0.930476;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,36,253:12:0 0,18,167:6:0 +X 1432 . A <*> 0 . DP=33;I16=15,18,0,0,1118,39032,0,0,1887,110523,0,0,533,11297,0,0;QS=3,0;MQSB=0.930476;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,36,255:12:0 0,18,169:6:0 +X 1433 . T <*> 0 . DP=34;I16=15,19,0,0,1238,45602,0,0,1947,114123,0,0,535,11403,0,0;QS=3,0;MQSB=0.923533;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,36,255:12:0 0,18,174:6:0 +X 1434 . T <*> 0 . DP=35;I16=15,20,0,0,1269,46757,0,0,2007,117723,0,0,537,11495,0,0;QS=3,0;MQSB=0.916855;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,36,255:12:0 0,18,179:6:0 +X 1435 . T <*> 0 . DP=35;I16=14,20,0,0,1256,46868,0,0,1947,114123,0,0,515,10999,0,0;QS=3,0;MQSB=0.901704;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,36,255:12:0 0,18,180:6:0 +X 1436 . C <*> 0 . DP=34;I16=14,20,0,0,1250,46978,0,0,1947,114123,0,0,544,11790,0,0;QS=3,0;MQSB=0.901704;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,36,255:12:0 0,18,165:6:0 +X 1437 . T <*> 0 . DP=32;I16=13,19,0,0,1222,47206,0,0,1858,109682,0,0,548,11892,0,0;QS=3,0;MQSB=0.993397;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,33,255:11:0 0,15,161:5:0 +X 1438 . C <*> 0 . DP=30;I16=13,17,0,0,1132,43284,0,0,1738,102482,0,0,554,12028,0,0;QS=3,0;MQSB=0.996503;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,30,251:10:0 0,15,159:5:0 +X 1439 . T <*> 0 . DP=30;I16=13,17,0,0,1110,41602,0,0,1738,102482,0,0,560,12196,0,0;QS=3,0;MQSB=0.996503;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,30,255:10:0 0,15,156:5:0 +X 1440 . A <*> 0 . DP=30;I16=12,16,0,0,1062,41028,0,0,1618,95282,0,0,550,12106,0,0;QS=3,0;MQSB=0.995699;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,27,255:9:0 0,12,144:4:0 +X 1441 . G <*> 0 . DP=30;I16=13,17,0,0,1138,44104,0,0,1738,102482,0,0,574,12576,0,0;QS=3,0;MQSB=0.996503;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,30,244:10:0 0,12,137:4:0 +X 1442 . G <*> 0 . DP=30;I16=13,17,0,0,1064,38534,0,0,1738,102482,0,0,580,12740,0,0;QS=3,0;MQSB=0.996503;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,30,242:10:0 0,12,128:4:0 +X 1443 . T <*> 0 . DP=30;I16=12,17,0,0,1013,36225,0,0,1678,98882,0,0,568,12598,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,30,230:10:0 0,12,133:4:0 +X 1444 . A <*> 0 . DP=30;I16=12,17,0,0,968,33936,0,0,1678,98882,0,0,569,12627,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,27,205:9:0 0,12,132:4:0 +X 1445 . T <*> 0 . DP=30;I16=14,15,0,0,1053,39129,0,0,1678,98882,0,0,585,13161,0,0;QS=3,0;MQSB=0.999762;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,27,237:9:0 0,15,169:5:0 +X 1446 . T <*> 0 . DP=30;I16=13,16,0,0,1051,38675,0,0,1678,98882,0,0,579,12951,0,0;QS=3,0;MQSB=0.997839;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,229:8:0 0,15,164:5:0 +X 1447 . G <*> 0 . DP=30;I16=14,16,0,0,1110,42692,0,0,1738,102482,0,0,606,13612,0,0;QS=3,0;MQSB=0.999136;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,27,229:9:0 0,15,157:5:0 +X 1448 . G <*> 0 . DP=30;I16=13,16,0,0,1037,37759,0,0,1678,98882,0,0,585,13151,0,0;QS=3,0;MQSB=0.997839;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,217:8:0 0,15,150:5:0 +X 1449 . T <*> 0 . DP=30;I16=14,16,0,0,1051,37869,0,0,1738,102482,0,0,612,13870,0,0;QS=3,0;MQSB=0.999136;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,27,230:9:0 0,15,152:5:0 +X 1450 . A <*> 0 . DP=29;I16=13,15,0,0,1039,38785,0,0,1649,98041,0,0,604,13842,0,0;QS=3,0;MQSB=0.956162;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,24,224:8:0 0,15,165:5:0 +X 1451 . T <*> 0 . DP=29;I16=13,16,0,0,1046,38586,0,0,1709,101641,0,0,616,14042,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,228:8:0 0,15,158:5:0 +X 1452 . A <*> 0 . DP=31;I16=14,16,0,0,1066,38696,0,0,1769,105241,0,0,604,13924,0,0;QS=3,0;MQSB=0.958545;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,218:8:0 0,15,147:5:0 +X 1453 . T <*> 0 . DP=31;I16=13,17,0,0,1107,42059,0,0,1769,105241,0,0,592,13444,0,0;QS=3,0;MQSB=0.963674;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,199:7:0 0,15,165:5:0 +X 1454 . T <*> 0 . DP=31;I16=14,17,0,0,1139,42711,0,0,1829,108841,0,0,617,14045,0,0;QS=3,0;MQSB=0.962133;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,24,234:8:0 0,15,166:5:0 +X 1455 . G <*> 0 . DP=31;I16=13,17,0,0,1107,41765,0,0,1769,105241,0,0,592,13420,0,0;QS=3,0;MQSB=0.963674;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,197:7:0 0,15,148:5:0 +X 1456 . T <*> 0 . DP=31;I16=14,17,0,0,1139,42717,0,0,1829,108841,0,0,617,14069,0,0;QS=3,0;MQSB=0.962133;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,24,215:8:0 0,15,170:5:0 +X 1457 . G <*> 0 . DP=31;I16=14,17,0,0,1129,42071,0,0,1829,108841,0,0,615,14019,0,0;QS=3,0;MQSB=0.962133;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,24,212:8:0 0,15,164:5:0 +X 1458 . T <*> 0 . DP=31;I16=14,17,0,0,1101,40243,0,0,1829,108841,0,0,613,13997,0,0;QS=3,0;MQSB=0.962133;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,24,220:8:0 0,15,165:5:0 +X 1459 . C A,<*> 0 . DP=31;I16=14,16,0,1,1164,45842,24,576,1769,105241,60,3600,608,13948,2,4;QS=2.87234,0.12766,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.962133;BQB=1;MQ0F=0 PL:DP:DV 0,54,255,54,255,255:18:0 0,24,224,24,224,224:8:0 9,0,135,21,138,152:5:1 +X 1460 . T <*> 0 . DP=32;I16=15,17,0,0,1243,48813,0,0,1889,112441,0,0,605,13833,0,0;QS=3,0;MQSB=0.960687;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,24,240:8:0 0,15,170:5:0 +X 1461 . G <*> 0 . DP=32;I16=15,17,0,0,1171,44033,0,0,1889,112441,0,0,600,13692,0,0;QS=3,0;MQSB=0.960687;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,24,224:8:0 0,15,157:5:0 +X 1462 . C <*> 0 . DP=30;I16=14,15,0,0,1102,42216,0,0,1709,101641,0,0,579,13241,0,0;QS=3,0;MQSB=0.954405;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,202:7:0 0,9,112:3:0 +X 1463 . T <*> 0 . DP=30;I16=15,15,0,0,1128,43348,0,0,1769,105241,0,0,592,13396,0,0;QS=3,0;MQSB=0.952765;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,209:7:0 0,12,139:4:0 +X 1464 . G <*> 0 . DP=31;I16=14,16,0,0,1095,40557,0,0,1769,105241,0,0,563,12665,0,0;QS=3,0;MQSB=0.958545;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,186:6:0 0,15,144:5:0 +X 1465 . T <*> 0 . DP=31;I16=15,16,0,0,1143,42557,0,0,1829,108841,0,0,584,13164,0,0;QS=3,0;MQSB=0.957006;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,204:7:0 0,15,166:5:0 +X 1466 . G <*> 0 . DP=31;I16=15,16,0,0,1122,42294,0,0,1829,108841,0,0,580,13018,0,0;QS=3,0;MQSB=0.957006;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,206:7:0 0,15,163:5:0 +X 1467 . A <*> 0 . DP=31;I16=14,16,0,0,1031,36341,0,0,1769,105241,0,0,569,12803,0,0;QS=3,0;MQSB=0.958545;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,195:7:0 0,15,155:5:0 +X 1468 . A <*> 0 . DP=30;I16=15,15,0,0,991,34477,0,0,1769,105241,0,0,573,12717,0,0;QS=3,0;MQSB=0.952765;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,177:7:0 0,15,158:5:0 +X 1469 . C T,<*> 0 . DP=31;I16=13,15,1,0,1013,37887,38,1444,1649,98041,60,3600,536,12106,9,81;QS=2.94025,0.0597484,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.954405;BQB=1;MQ0F=0 PL:DP:DV 0,16,255,51,255,255:18:1 0,18,178,18,178,178:6:0 0,15,160,15,160,160:5:0 +X 1470 . T <*> 0 . DP=31;I16=16,15,0,0,1110,41070,0,0,1829,108841,0,0,567,12489,0,0;QS=3,0;MQSB=0.951229;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,210:7:0 0,15,165:5:0 +X 1471 . G <*> 0 . DP=30;I16=16,14,0,0,1051,38425,0,0,1769,105241,0,0,564,12348,0,0;QS=3,0;MQSB=0.946202;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,192:7:0 0,12,128:4:0 +X 1472 . T <*> 0 . DP=30;I16=16,14,0,0,1049,38097,0,0,1769,105241,0,0,561,12237,0,0;QS=3,0;MQSB=0.946202;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,200:7:0 0,12,134:4:0 +X 1473 . C <*> 0 . DP=30;I16=16,14,0,0,1058,38526,0,0,1769,105241,0,0,558,12156,0,0;QS=3,0;MQSB=0.946202;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,175:7:0 0,12,140:4:0 +X 1474 . C <*> 0 . DP=30;I16=16,14,0,0,1120,42756,0,0,1769,105241,0,0,555,12105,0,0;QS=3,0;MQSB=0.946202;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,202:7:0 0,12,141:4:0 +X 1475 . T <*> 0 . DP=29;I16=14,14,0,0,1047,40395,0,0,1649,98041,0,0,537,11827,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,208:7:0 0,12,155:4:0 +X 1476 . T G,<*> 0 . DP=31;I16=15,15,1,0,1056,37884,14,196,1769,105241,60,3600,566,12614,10,100;QS=2.944,0.056,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.951229;BQB=1;MQ0F=0 PL:DP:DV 0,57,255,57,255,255:19:0 0,9,177,21,180,183:8:1 0,12,140,12,140,140:4:0 +X 1477 . G <*> 0 . DP=31;I16=16,15,0,0,1150,43390,0,0,1829,108841,0,0,574,12700,0,0;QS=3,0;MQSB=0.951229;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,24,217:8:0 0,12,138:4:0 +X 1478 . G <*> 0 . DP=31;I16=14,15,0,0,1008,36638,0,0,1709,101641,0,0,542,11982,0,0;QS=3,0;MQSB=0.954405;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,24,208:8:0 0,9,109:3:0 +X 1479 . C <*> 0 . DP=30;I16=15,15,0,0,1061,38671,0,0,1769,105241,0,0,564,12556,0,0;QS=3,0;MQSB=0.952765;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,24,211:8:0 0,9,106:3:0 +X 1480 . C <*> 0 . DP=30;I16=15,15,0,0,1083,40355,0,0,1769,105241,0,0,561,12531,0,0;QS=3,0;MQSB=0.952765;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,24,220:8:0 0,9,103:3:0 +X 1481 . T <*> 0 . DP=30;I16=15,15,0,0,1102,41308,0,0,1769,105241,0,0,558,12532,0,0;QS=3,0;MQSB=0.952765;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,24,235:8:0 0,9,105:3:0 +X 1482 . G <*> 0 . DP=29;I16=15,14,0,0,1044,38550,0,0,1709,101641,0,0,556,12558,0,0;QS=3,0;MQSB=0.947838;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,24,210:8:0 0,6,75:2:0 +X 1483 . T <*> 0 . DP=31;I16=14,16,0,0,1042,37190,0,0,1769,105241,0,0,521,11919,0,0;QS=3,0;MQSB=0.958545;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,21,215:7:0 0,9,100:3:0 +X 1484 . T <*> 0 . DP=31;I16=15,16,0,0,1067,37837,0,0,1829,108841,0,0,547,12587,0,0;QS=3,0;MQSB=0.957006;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,24,216:8:0 0,9,106:3:0 +X 1485 . T <*> 0 . DP=30;I16=15,15,0,0,1027,35863,0,0,1769,105241,0,0,549,12659,0,0;QS=3,0;MQSB=0.952765;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,24,209:8:0 0,9,93:3:0 +X 1486 . G <*> 0 . DP=29;I16=15,14,0,0,1089,41679,0,0,1709,101641,0,0,551,12707,0,0;QS=3,0;MQSB=0.947838;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,198:7:0 0,9,108:3:0 +X 1487 . G <*> 0 . DP=28;I16=14,14,0,0,973,34723,0,0,1649,98041,0,0,554,12778,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,196:7:0 0,9,97:3:0 +X 1488 . T <*> 0 . DP=28;I16=13,14,0,0,928,32432,0,0,1589,94441,0,0,532,12246,0,0;QS=3,0;MQSB=0.951472;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,176:6:0 0,9,102:3:0 +X 1489 . G <*> 0 . DP=27;I16=13,14,0,0,958,35292,0,0,1589,94441,0,0,535,12361,0,0;QS=3,0;MQSB=0.951472;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,174:6:0 0,9,93:3:0 +X 1490 . A <*> 0 . DP=27;I16=13,14,0,0,928,33108,0,0,1589,94441,0,0,538,12446,0,0;QS=3,0;MQSB=0.951472;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,160:5:0 0,9,94:3:0 +X 1491 . C <*> 0 . DP=27;I16=12,13,0,0,798,26812,0,0,1469,87241,0,0,499,11587,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,12,108:4:0 0,9,79:3:0 +X 1492 . G <*> 0 . DP=27;I16=13,14,0,0,893,30927,0,0,1589,94441,0,0,543,12527,0,0;QS=3,0;MQSB=0.951472;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,136:5:0 0,9,100:3:0 +X 1493 . G <*> 0 . DP=27;I16=13,13,0,0,907,32761,0,0,1529,90841,0,0,520,11948,0,0;QS=3,0;MQSB=0.945959;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,155:5:0 0,9,106:3:0 +X 1494 . G <*> 0 . DP=27;I16=13,14,0,0,939,33599,0,0,1589,94441,0,0,547,12639,0,0;QS=3,0;MQSB=0.951472;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,156:5:0 0,9,107:3:0 +X 1495 . T <*> 0 . DP=26;I16=12,13,0,0,814,27700,0,0,1469,87241,0,0,524,12048,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,143:5:0 0,9,105:3:0 +X 1496 . G <*> 0 . DP=26;I16=13,13,0,0,969,36751,0,0,1529,90841,0,0,550,12674,0,0;QS=3,0;MQSB=0.945959;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,157:5:0 0,9,107:3:0 +X 1497 . A <*> 0 . DP=27;I16=12,14,0,0,904,32740,0,0,1529,90841,0,0,525,12019,0,0;QS=3,0;MQSB=0.953497;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,166:5:0 0,9,113:3:0 +X 1498 . G <*> 0 . DP=27;I16=13,14,0,0,1002,37852,0,0,1589,94441,0,0,551,12635,0,0;QS=3,0;MQSB=0.951472;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,153:5:0 0,9,112:3:0 +X 1499 . G <*> 0 . DP=28;I16=14,14,0,0,973,34891,0,0,1649,98041,0,0,551,12599,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,15,146:5:0 0,9,108:3:0 +X 1500 . A <*> 0 . DP=28;I16=14,14,0,0,1023,38115,0,0,1649,98041,0,0,552,12588,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,15,165:5:0 0,9,115:3:0 +X 1501 . G <*> 0 . DP=28;I16=14,14,0,0,1051,40105,0,0,1649,98041,0,0,551,12505,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,15,163:5:0 0,9,100:3:0 +X 1502 . C <*> 0 . DP=27;I16=13,14,0,0,963,35241,0,0,1589,94441,0,0,549,12351,0,0;QS=3,0;MQSB=0.951472;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,140:5:0 0,9,105:3:0 +X 1503 . A <*> 0 . DP=28;I16=14,14,0,0,1026,38252,0,0,1649,98041,0,0,546,12176,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,15,171:5:0 0,9,109:3:0 +X 1504 . G <*> 0 . DP=28;I16=13,14,0,0,1052,41226,0,0,1589,94441,0,0,523,11591,0,0;QS=3,0;MQSB=0.951472;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,163:5:0 0,9,111:3:0 +X 1505 . G <*> 0 . DP=28;I16=14,13,0,0,959,35545,0,0,1589,94441,0,0,517,11295,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,155:5:0 0,9,114:3:0 +X 1506 . G <*> 0 . DP=28;I16=14,14,0,0,1013,37355,0,0,1649,98041,0,0,540,11840,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,15,139:5:0 0,9,112:3:0 +X 1507 . A <*> 0 . DP=28;I16=14,14,0,0,987,35217,0,0,1649,98041,0,0,538,11792,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,15,162:5:0 0,9,114:3:0 +X 1508 . C <*> 0 . DP=28;I16=14,14,0,0,1033,38663,0,0,1649,98041,0,0,535,11727,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,15,137:5:0 0,9,112:3:0 +X 1509 . A <*> 0 . DP=28;I16=15,13,0,0,1028,38610,0,0,1649,98041,0,0,529,11493,0,0;QS=3,0;MQSB=0.942064;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,12,128:4:0 0,9,122:3:0 +X 1510 . G <*> 0 . DP=28;I16=15,13,0,0,1064,40824,0,0,1649,98041,0,0,524,11288,0,0;QS=3,0;MQSB=0.942064;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,12,132:4:0 0,9,111:3:0 +X 1511 . A <*> 0 . DP=28;I16=15,13,0,0,976,34794,0,0,1649,98041,0,0,519,11113,0,0;QS=3,0;MQSB=0.942064;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,12,136:4:0 0,9,110:3:0 +X 1512 . A <*> 0 . DP=28;I16=15,12,0,0,998,37460,0,0,1589,94441,0,0,489,10343,0,0;QS=3,0;MQSB=0.935229;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,12,142:4:0 0,9,110:3:0 +X 1513 . G <*> 0 . DP=28;I16=14,13,0,0,1014,38940,0,0,1589,94441,0,0,497,10709,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,12,134:4:0 0,9,108:3:0 +X 1514 . G <*> 0 . DP=28;I16=15,13,0,0,1054,39954,0,0,1649,98041,0,0,504,10768,0,0;QS=3,0;MQSB=0.942064;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,12,134:4:0 0,9,108:3:0 +X 1515 . G <*> 0 . DP=28;I16=14,13,0,0,948,34152,0,0,1589,94441,0,0,488,10564,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,12,133:4:0 0,9,101:3:0 +X 1516 . T <*> 0 . DP=27;I16=12,13,0,0,811,27385,0,0,1469,87241,0,0,472,10338,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,12,117:4:0 0,9,106:3:0 +X 1517 . C <*> 0 . DP=27;I16=13,13,0,0,943,35153,0,0,1529,90841,0,0,478,10380,0,0;QS=3,0;MQSB=0.945959;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,12,134:4:0 0,9,97:3:0 +X 1518 . C <*> 0 . DP=28;I16=13,12,0,0,908,33852,0,0,1469,87241,0,0,427,9261,0,0;QS=3,0;MQSB=0.939413;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,12,132:4:0 0,9,96:3:0 +X 1519 . T <*> 0 . DP=28;I16=15,13,0,0,988,35808,0,0,1649,98041,0,0,475,10337,0,0;QS=3,0;MQSB=0.942064;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,15,154:5:0 0,9,110:3:0 +X 1520 . G <*> 0 . DP=29;I16=16,13,0,0,1005,36307,0,0,1709,101641,0,0,470,10328,0,0;QS=3,0;MQSB=0.940317;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,18,150:6:0 0,9,104:3:0 +X 1521 . C <*> 0 . DP=28;I16=16,12,0,0,900,30324,0,0,1649,98041,0,0,466,10300,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,164:6:0 0,9,88:3:0 +X 1522 . G <*> 0 . DP=27;I16=15,10,0,0,784,25144,0,0,1469,87241,0,0,442,9956,0,0;QS=3,0;MQSB=0.9171;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,110:5:0 0,9,91:3:0 +X 1523 . T <*> 0 . DP=27;I16=16,11,0,0,921,32001,0,0,1589,94441,0,0,457,10189,0,0;QS=3,0;MQSB=0.925036;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,136:5:0 0,9,108:3:0 +X 1524 . G <*> 0 . DP=27;I16=16,10,0,0,932,34140,0,0,1529,90841,0,0,453,10153,0,0;QS=3,0;MQSB=0.914947;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,12,108:4:0 0,9,103:3:0 +X 1525 . C <*> 0 . DP=27;I16=16,11,0,0,972,35704,0,0,1589,94441,0,0,473,10719,0,0;QS=3,0;MQSB=0.925036;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,12,113:4:0 0,9,112:3:0 +X 1526 . C <*> 0 . DP=25;I16=14,11,0,0,883,31843,0,0,1469,87241,0,0,470,10684,0,0;QS=3,0;MQSB=0.929204;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,12,109:4:0 0,9,106:3:0 +X 1527 . C <*> 0 . DP=24;I16=14,10,0,0,867,31999,0,0,1440,86400,0,0,466,10572,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,107:4:0 0,9,112:3:0 +X 1528 . T <*> 0 . DP=23;I16=13,10,0,0,869,33133,0,0,1380,82800,0,0,463,10483,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,114:4:0 0,9,113:3:0 +X 1529 . G <*> 0 . DP=23;I16=13,10,0,0,812,29432,0,0,1380,82800,0,0,459,10365,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,108:4:0 0,9,104:3:0 +X 1530 . C <*> 0 . DP=24;I16=13,10,0,0,819,30073,0,0,1380,82800,0,0,446,10186,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,137:5:0 0,9,106:3:0 +X 1531 . C <*> 0 . DP=24;I16=13,11,0,0,877,32969,0,0,1440,86400,0,0,452,10190,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,144:5:0 0,9,105:3:0 +X 1532 . T <*> 0 . DP=24;I16=13,11,0,0,887,33721,0,0,1440,86400,0,0,449,10135,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,165:5:0 0,9,120:3:0 +X 1533 . T <*> 0 . DP=23;I16=13,10,0,0,793,27987,0,0,1380,82800,0,0,447,10101,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,146:5:0 0,9,107:3:0 +X 1534 . C <*> 0 . DP=23;I16=14,9,0,0,847,31627,0,0,1380,82800,0,0,446,10086,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,153:5:0 0,9,109:3:0 +X 1535 . A <*> 0 . DP=23;I16=14,9,0,0,770,26604,0,0,1380,82800,0,0,444,9990,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,144:5:0 0,9,99:3:0 +X 1536 . C <*> 0 . DP=24;I16=15,9,0,0,826,28984,0,0,1440,86400,0,0,442,9914,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,138:5:0 0,9,110:3:0 +X 1537 . A <*> 0 . DP=24;I16=14,9,0,0,844,31384,0,0,1380,82800,0,0,416,9234,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,149:5:0 0,9,115:3:0 +X 1538 . A <*> 0 . DP=24;I16=15,9,0,0,909,34727,0,0,1440,86400,0,0,440,9826,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,154:5:0 0,9,112:3:0 +X 1539 . G <*> 0 . DP=24;I16=15,9,0,0,913,35327,0,0,1440,86400,0,0,439,9815,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,149:5:0 0,9,117:3:0 +X 1540 . C <*> 0 . DP=23;I16=15,8,0,0,828,30260,0,0,1380,82800,0,0,438,9776,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,146:5:0 0,9,102:3:0 +X 1541 . C <*> 0 . DP=23;I16=15,8,0,0,823,30615,0,0,1380,82800,0,0,437,9759,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,142:5:0 0,9,108:3:0 +X 1542 . C <*> 0 . DP=25;I16=16,8,0,0,893,33843,0,0,1440,86400,0,0,435,9715,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,147:5:0 0,12,131:4:0 +X 1543 . C <*> 0 . DP=25;I16=16,8,0,0,880,33206,0,0,1440,86400,0,0,434,9696,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,141:5:0 0,12,136:4:0 +X 1544 . T <*> 0 . DP=25;I16=16,8,0,0,899,34405,0,0,1440,86400,0,0,431,9603,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,150:5:0 0,12,148:4:0 +X 1545 . G <*> 0 . DP=25;I16=16,8,0,0,874,32636,0,0,1440,86400,0,0,428,9536,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,146:5:0 0,12,129:4:0 +X 1546 . G <*> 0 . DP=24;I16=15,8,0,0,796,28796,0,0,1380,82800,0,0,425,9443,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,130:5:0 0,9,110:3:0 +X 1547 . A <*> 0 . DP=23;I16=15,8,0,0,837,30945,0,0,1380,82800,0,0,448,9996,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,176:6:0 0,9,112:3:0 +X 1548 . A <*> 0 . DP=23;I16=14,8,0,0,812,30830,0,0,1320,79200,0,0,421,9319,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,173:5:0 0,9,115:3:0 +X 1549 . G <*> 0 . DP=23;I16=15,8,0,0,870,33642,0,0,1380,82800,0,0,444,9912,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,174:6:0 0,9,114:3:0 +X 1550 . G <*> 0 . DP=23;I16=15,8,0,0,790,28502,0,0,1380,82800,0,0,442,9900,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,154:6:0 0,9,109:3:0 +X 1551 . A <*> 0 . DP=23;I16=15,8,0,0,802,28596,0,0,1380,82800,0,0,440,9908,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,173:6:0 0,9,107:3:0 +X 1552 . A <*> 0 . DP=21;I16=14,7,0,0,792,30156,0,0,1260,75600,0,0,438,9836,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,196:6:0 0,9,110:3:0 +X 1553 . A <*> 0 . DP=21;I16=13,7,0,0,738,28112,0,0,1200,72000,0,0,411,9159,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,251:11:0 0,18,192:6:0 0,9,115:3:0 +X 1554 . G <*> 0 . DP=21;I16=14,7,0,0,763,28221,0,0,1260,75600,0,0,434,9752,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,171:6:0 0,9,101:3:0 +X 1555 . T <*> 0 . DP=21;I16=14,7,0,0,726,26234,0,0,1260,75600,0,0,432,9740,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,252:12:0 0,18,169:6:0 0,9,108:3:0 +X 1556 . T <*> 0 . DP=21;I16=14,7,0,0,745,26971,0,0,1260,75600,0,0,429,9697,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,253:12:0 0,18,177:6:0 0,9,110:3:0 +X 1557 . G <*> 0 . DP=22;I16=15,7,0,0,801,29689,0,0,1320,79200,0,0,426,9672,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,166:6:0 0,9,101:3:0 +X 1558 . T <*> 0 . DP=22;I16=15,6,0,0,720,25620,0,0,1260,75600,0,0,404,9244,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,131:5:0 0,9,112:3:0 +X 1559 . T <*> 0 . DP=22;I16=15,7,0,0,712,24690,0,0,1320,79200,0,0,417,9439,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,248:13:0 0,18,158:6:0 0,9,103:3:0 +X 1560 . T <*> 0 . DP=21;I16=14,7,0,0,736,26560,0,0,1260,75600,0,0,412,9284,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,251:12:0 0,18,170:6:0 0,9,112:3:0 +X 1561 . T <*> 0 . DP=21;I16=14,7,0,0,706,24776,0,0,1260,75600,0,0,406,9102,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,241:12:0 0,18,174:6:0 0,9,106:3:0 +X 1562 . G <*> 0 . DP=21;I16=14,7,0,0,765,28655,0,0,1260,75600,0,0,399,8893,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,181:6:0 0,9,108:3:0 +X 1563 . G <*> 0 . DP=22;I16=13,7,0,0,713,26255,0,0,1200,72000,0,0,360,8176,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,147:5:0 0,9,108:3:0 +X 1564 . G <*> 0 . DP=22;I16=13,8,0,0,721,25457,0,0,1260,75600,0,0,368,8218,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,173:6:0 0,9,95:3:0 +X 1565 . A <*> 0 . DP=21;I16=14,7,0,0,724,25888,0,0,1260,75600,0,0,380,8352,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,162:6:0 0,6,71:2:0 +X 1566 . T <*> 0 . DP=21;I16=13,7,0,0,698,25286,0,0,1200,72000,0,0,364,8086,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,143:5:0 0,6,78:2:0 +X 1567 . C <*> 0 . DP=20;I16=12,6,0,0,652,24422,0,0,1080,64800,0,0,351,7881,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,104:3:0 0,6,72:2:0 +X 1568 . T <*> 0 . DP=20;I16=13,7,0,0,711,26125,0,0,1200,72000,0,0,363,7871,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,157:5:0 0,6,74:2:0 +X 1569 . C <*> 0 . DP=19;I16=12,6,0,0,676,25850,0,0,1080,64800,0,0,351,7669,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,128:4:0 0,6,76:2:0 +X 1570 . T <*> 0 . DP=19;I16=12,7,0,0,700,26750,0,0,1140,68400,0,0,353,7583,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,149:5:0 0,6,71:2:0 +X 1571 . G <*> 0 . DP=19;I16=12,6,0,0,639,23361,0,0,1080,64800,0,0,343,7441,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,125:4:0 0,6,70:2:0 +X 1572 . C <*> 0 . DP=19;I16=11,6,0,0,640,24568,0,0,1020,61200,0,0,328,7202,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,125:4:0 0,6,70:2:0 +X 1573 . A <*> 0 . DP=19;I16=11,4,0,0,565,21475,0,0,900,54000,0,0,304,6900,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,132:4:0 0,3,40:1:0 +X 1574 . C <*> 0 . DP=19;I16=12,5,0,0,636,24076,0,0,1020,61200,0,0,318,6948,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,128:4:0 0,3,38:1:0 +X 1575 . C <*> 0 . DP=19;I16=11,6,0,0,610,22742,0,0,1020,61200,0,0,296,6272,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,125:4:0 0,6,71:2:0 +X 1576 . C <*> 0 . DP=19;I16=12,6,0,0,675,25821,0,0,1080,64800,0,0,315,6785,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,133:4:0 0,6,78:2:0 +X 1577 . T <*> 0 . DP=17;I16=11,6,0,0,650,25330,0,0,1020,61200,0,0,310,6692,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,118:3:0 0,6,77:2:0 +X 1578 . C <*> 0 . DP=17;I16=10,6,0,0,622,24364,0,0,960,57600,0,0,279,5943,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,84:2:0 0,6,77:2:0 +X 1579 . A <*> 0 . DP=17;I16=11,6,0,0,596,22326,0,0,1020,61200,0,0,298,6464,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,116:3:0 0,6,80:2:0 +X 1580 . G <*> 0 . DP=17;I16=11,6,0,0,651,25195,0,0,1020,61200,0,0,292,6380,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,109:3:0 0,6,77:2:0 +X 1581 . C <*> 0 . DP=17;I16=11,6,0,0,586,21418,0,0,1020,61200,0,0,286,6316,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,103:3:0 0,6,71:2:0 +X 1582 . C <*> 0 . DP=18;I16=11,7,0,0,639,23491,0,0,1080,64800,0,0,280,6272,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,109:3:0 0,6,75:2:0 +X 1583 . T <*> 0 . DP=16;I16=10,6,0,0,591,22349,0,0,960,57600,0,0,276,6196,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,112:3:0 0,6,74:2:0 +X 1584 . G <*> 0 . DP=15;I16=10,5,0,0,563,21283,0,0,900,54000,0,0,272,6086,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,105:3:0 0,3,39:1:0 +X 1585 . G <*> 0 . DP=16;I16=10,5,0,0,494,17160,0,0,900,54000,0,0,251,5703,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,244:11:0 0,9,103:3:0 0,3,30:1:0 +X 1586 . A <*> 0 . DP=15;I16=10,3,0,0,470,17200,0,0,780,46800,0,0,237,5273,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,223:10:0 0,6,79:2:0 0,3,42:1:0 +X 1587 . C <*> 0 . DP=15;I16=11,4,0,0,508,17900,0,0,900,54000,0,0,264,5852,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,247:11:0 0,9,94:3:0 0,3,31:1:0 +X 1588 . A <*> 0 . DP=15;I16=11,4,0,0,511,17939,0,0,900,54000,0,0,262,5806,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,232:11:0 0,9,105:3:0 0,3,41:1:0 +X 1589 . A <*> 0 . DP=15;I16=11,4,0,0,536,19584,0,0,900,54000,0,0,259,5725,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,249:11:0 0,9,106:3:0 0,3,42:1:0 +X 1590 . C <*> 0 . DP=15;I16=10,5,0,0,514,18228,0,0,900,54000,0,0,257,5657,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,231:10:0 0,9,104:3:0 0,6,71:2:0 +X 1591 . T <*> 0 . DP=15;I16=10,5,0,0,515,18559,0,0,900,54000,0,0,256,5602,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,241:10:0 0,9,85:3:0 0,6,73:2:0 +X 1592 . T <*> 0 . DP=15;I16=10,5,0,0,503,17345,0,0,900,54000,0,0,255,5561,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,225:10:0 0,9,107:3:0 0,6,62:2:0 +X 1593 . G <*> 0 . DP=15;I16=10,5,0,0,540,19930,0,0,900,54000,0,0,254,5534,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,250:10:0 0,9,106:3:0 0,6,60:2:0 +X 1594 . T <*> 0 . DP=15;I16=10,5,0,0,535,19445,0,0,900,54000,0,0,252,5472,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,234:10:0 0,9,106:3:0 0,6,80:2:0 +X 1595 . G <*> 0 . DP=15;I16=10,4,0,0,494,17940,0,0,840,50400,0,0,225,4801,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,213:9:0 0,9,105:3:0 0,6,69:2:0 +X 1596 . C <*> 0 . DP=15;I16=10,4,0,0,479,17011,0,0,840,50400,0,0,233,5151,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,200:9:0 0,9,111:3:0 0,6,74:2:0 +X 1597 . C <*> 0 . DP=15;I16=10,5,0,0,489,16941,0,0,900,54000,0,0,245,5285,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,195:9:0 0,12,127:4:0 0,6,73:2:0 +X 1598 . C <*> 0 . DP=15;I16=10,5,0,0,514,18282,0,0,900,54000,0,0,244,5240,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,207:9:0 0,12,133:4:0 0,6,68:2:0 +X 1599 . A <*> 0 . DP=14;I16=8,5,0,0,436,15330,0,0,780,46800,0,0,225,4851,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,182:8:0 0,9,103:3:0 0,6,76:2:0 +X 1600 . T <*> 0 . DP=13;I16=8,5,0,0,456,16430,0,0,780,46800,0,0,226,4876,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,193:8:0 0,9,105:3:0 0,6,79:2:0 +X 1601 . C <*> 0 . DP=13;I16=8,4,0,0,431,15861,0,0,720,43200,0,0,208,4554,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,171:7:0 0,9,108:3:0 0,6,78:2:0 +X 1602 . T <*> 0 . DP=13;I16=7,5,0,0,439,16867,0,0,720,43200,0,0,228,4968,0,0;QS=3,0;MQSB=0.95494;MQ0F=0 PL:DP:DV 0,21,179:7:0 0,9,115:3:0 0,6,85:2:0 +X 1603 . G <*> 0 . DP=12;I16=7,5,0,0,455,17407,0,0,720,43200,0,0,230,5034,0,0;QS=3,0;MQSB=0.95494;MQ0F=0 PL:DP:DV 0,21,202:7:0 0,9,111:3:0 0,6,75:2:0 +X 1604 . G <*> 0 . DP=12;I16=7,5,0,0,362,11620,0,0,720,43200,0,0,232,5112,0,0;QS=3,0;MQSB=0.95494;MQ0F=0 PL:DP:DV 0,21,163:7:0 0,9,84:3:0 0,6,66:2:0 +X 1605 . T <*> 0 . DP=12;I16=7,5,0,0,410,14230,0,0,720,43200,0,0,234,5202,0,0;QS=3,0;MQSB=0.95494;MQ0F=0 PL:DP:DV 0,21,190:7:0 0,9,97:3:0 0,6,61:2:0 +X 1606 . G <*> 0 . DP=12;I16=7,4,0,0,370,12738,0,0,660,39600,0,0,211,4679,0,0;QS=3,0;MQSB=0.964642;MQ0F=0 PL:DP:DV 0,18,165:6:0 0,9,91:3:0 0,6,56:2:0 +X 1607 . A <*> 0 . DP=12;I16=7,4,0,0,337,11369,0,0,660,39600,0,0,226,5222,0,0;QS=3,0;MQSB=0.964642;MQ0F=0 PL:DP:DV 0,21,161:7:0 0,6,70:2:0 0,6,55:2:0 +X 1608 . C <*> 0 . DP=12;I16=7,4,0,0,366,12898,0,0,660,39600,0,0,211,4727,0,0;QS=3,0;MQSB=0.964642;MQ0F=0 PL:DP:DV 0,18,141:6:0 0,9,111:3:0 0,6,62:2:0 +X 1609 . C <*> 0 . DP=11;I16=6,5,0,0,365,12889,0,0,660,39600,0,0,237,5393,0,0;QS=3,0;MQSB=0.950952;MQ0F=0 PL:DP:DV 0,18,149:6:0 0,9,110:3:0 0,6,71:2:0 +X 1610 . C <*> 0 . DP=11;I16=5,5,0,0,313,10713,0,0,600,36000,0,0,213,4819,0,0;QS=3,0;MQSB=0.952347;MQ0F=0 PL:DP:DV 0,15,127:5:0 0,9,106:3:0 0,6,57:2:0 +X 1611 . C <*> 0 . DP=11;I16=6,5,0,0,398,14904,0,0,660,39600,0,0,238,5454,0,0;QS=3,0;MQSB=0.950952;MQ0F=0 PL:DP:DV 0,18,180:6:0 0,9,110:3:0 0,6,67:2:0 +X 1612 . T <*> 0 . DP=11;I16=6,5,0,0,409,15421,0,0,660,39600,0,0,238,5472,0,0;QS=3,0;MQSB=0.950952;MQ0F=0 PL:DP:DV 0,18,174:6:0 0,9,107:3:0 0,6,83:2:0 +X 1613 . C <*> 0 . DP=11;I16=6,5,0,0,372,12904,0,0,660,39600,0,0,238,5498,0,0;QS=3,0;MQSB=0.950952;MQ0F=0 PL:DP:DV 0,18,169:6:0 0,9,99:3:0 0,6,63:2:0 +X 1614 . A <*> 0 . DP=11;I16=6,5,0,0,353,12139,0,0,660,39600,0,0,238,5532,0,0;QS=3,0;MQSB=0.950952;MQ0F=0 PL:DP:DV 0,18,147:6:0 0,9,98:3:0 0,6,69:2:0 +X 1615 . C <*> 0 . DP=11;I16=6,5,0,0,366,13080,0,0,660,39600,0,0,238,5574,0,0;QS=3,0;MQSB=0.950952;MQ0F=0 PL:DP:DV 0,18,171:6:0 0,9,105:3:0 0,6,51:2:0 +X 1616 . T <*> 0 . DP=11;I16=6,3,0,0,348,13606,0,0,540,32400,0,0,187,4323,0,0;QS=3,0;MQSB=0.924584;MQ0F=0 PL:DP:DV 0,15,159:5:0 0,9,105:3:0 0,3,42:1:0 +X 1617 . C <*> 0 . DP=12;I16=6,3,0,0,330,12316,0,0,540,32400,0,0,185,4279,0,0;QS=3,0;MQSB=0.924584;MQ0F=0 PL:DP:DV 0,15,146:5:0 0,9,105:3:0 0,3,42:1:0 +X 1618 . A <*> 0 . DP=12;I16=5,6,0,0,385,14199,0,0,629,36841,0,0,244,5636,0,0;QS=3,0;MQSB=0.891517;MQ0F=0 PL:DP:DV 0,18,151:6:0 0,9,93:3:0 0,6,81:2:0 +X 1619 . G <*> 0 . DP=11;I16=5,6,0,0,377,13119,0,0,629,36841,0,0,242,5544,0,0;QS=3,0;MQSB=0.891517;MQ0F=0 PL:DP:DV 0,18,166:6:0 0,9,84:3:0 0,6,67:2:0 +X 1620 . C <*> 0 . DP=11;I16=5,5,0,0,323,10965,0,0,569,33241,0,0,215,4839,0,0;QS=3,0;MQSB=0.857112;MQ0F=0 PL:DP:DV 0,15,142:5:0 0,9,78:3:0 0,6,56:2:0 +X 1621 . C <*> 0 . DP=12;I16=5,7,0,0,363,11779,0,0,689,40441,0,0,263,6021,0,0;QS=3,0;MQSB=0.896474;MQ0F=0 PL:DP:DV 0,21,174:7:0 0,9,80:3:0 0,6,56:2:0 +X 1622 . A <*> 0 . DP=12;I16=5,7,0,0,365,12105,0,0,689,40441,0,0,261,5965,0,0;QS=3,0;MQSB=0.896474;MQ0F=0 PL:DP:DV 0,21,176:7:0 0,9,81:3:0 0,6,52:2:0 +X 1623 . C <*> 0 . DP=12;I16=5,5,0,0,325,10979,0,0,569,33241,0,0,208,4620,0,0;QS=3,0;MQSB=0.857112;MQ0F=0 PL:DP:DV 0,18,155:6:0 0,9,84:3:0 0,3,37:1:0 +X 1624 . C <*> 0 . DP=12;I16=4,6,0,0,336,11718,0,0,569,33241,0,0,211,4799,0,0;QS=3,0;MQSB=0.895781;MQ0F=0 PL:DP:DV 0,18,162:6:0 0,9,88:3:0 0,3,39:1:0 +X 1625 . A <*> 0 . DP=12;I16=4,7,0,0,375,13503,0,0,629,36841,0,0,234,5386,0,0;QS=3,0;MQSB=0.924449;MQ0F=0 PL:DP:DV 0,18,158:6:0 0,9,93:3:0 0,6,80:2:0 +X 1626 . G <*> 0 . DP=12;I16=5,7,0,0,358,11490,0,0,689,40441,0,0,249,5645,0,0;QS=3,0;MQSB=0.896474;MQ0F=0 PL:DP:DV 0,21,158:7:0 0,9,83:3:0 0,6,63:2:0 +X 1627 . A <*> 0 . DP=12;I16=5,7,0,0,363,11609,0,0,689,40441,0,0,246,5590,0,0;QS=3,0;MQSB=0.896474;MQ0F=0 PL:DP:DV 0,21,165:7:0 0,9,75:3:0 0,6,72:2:0 +X 1628 . C <*> 0 . DP=12;I16=5,7,0,0,357,11583,0,0,689,40441,0,0,243,5545,0,0;QS=3,0;MQSB=0.896474;MQ0F=0 PL:DP:DV 0,21,165:7:0 0,9,80:3:0 0,6,57:2:0 +X 1629 . T <*> 0 . DP=13;I16=6,7,0,0,451,16079,0,0,749,44041,0,0,240,5510,0,0;QS=3,0;MQSB=0.899815;MQ0F=0 PL:DP:DV 0,21,187:7:0 0,12,120:4:0 0,6,79:2:0 +X 1630 . T <*> 0 . DP=13;I16=6,7,0,0,403,13323,0,0,749,44041,0,0,237,5435,0,0;QS=3,0;MQSB=0.899815;MQ0F=0 PL:DP:DV 0,21,169:7:0 0,12,111:4:0 0,6,73:2:0 +X 1631 . C <*> 0 . DP=12;I16=6,5,0,0,354,12046,0,0,660,39600,0,0,210,4744,0,0;QS=3,0;MQSB=0.950952;MQ0F=0 PL:DP:DV 0,21,184:7:0 0,6,67:2:0 0,6,61:2:0 +X 1632 . C <*> 0 . DP=13;I16=6,7,0,0,387,12175,0,0,749,44041,0,0,232,5262,0,0;QS=3,0;MQSB=0.899815;MQ0F=0 PL:DP:DV 0,24,188:8:0 0,9,82:3:0 0,6,61:2:0 +X 1633 . A <*> 0 . DP=13;I16=6,7,0,0,404,13272,0,0,749,44041,0,0,230,5166,0,0;QS=3,0;MQSB=0.899815;MQ0F=0 PL:DP:DV 0,24,183:8:0 0,9,86:3:0 0,6,73:2:0 +X 1634 . C <*> 0 . DP=13;I16=6,6,0,0,328,9716,0,0,689,40441,0,0,203,4457,0,0;QS=3,0;MQSB=0.864013;MQ0F=0 PL:DP:DV 0,21,151:7:0 0,9,80:3:0 0,6,59:2:0 +X 1635 . G <*> 0 . DP=14;I16=6,8,0,0,419,12831,0,0,809,47641,0,0,226,5010,0,0;QS=3,0;MQSB=0.927743;MQ0F=0 PL:DP:DV 0,24,180:8:0 0,12,108:4:0 0,6,59:2:0 +X 1636 . A <*> 0 . DP=14;I16=6,8,0,0,418,13400,0,0,809,47641,0,0,225,4951,0,0;QS=3,0;MQSB=0.927743;MQ0F=0 PL:DP:DV 0,24,179:8:0 0,12,110:4:0 0,6,66:2:0 +X 1637 . C <*> 0 . DP=14;I16=6,8,0,0,422,13498,0,0,809,47641,0,0,224,4906,0,0;QS=3,0;MQSB=0.927743;MQ0F=0 PL:DP:DV 0,24,185:8:0 0,12,110:4:0 0,6,60:2:0 +X 1638 . A <*> 0 . DP=17;I16=9,7,0,0,513,17167,0,0,929,54841,0,0,216,4790,0,0;QS=3,0;MQSB=0.892753;MQ0F=0 PL:DP:DV 0,24,191:8:0 0,18,149:6:0 0,6,78:2:0 +X 1639 . G <*> 0 . DP=17;I16=9,8,0,0,552,18844,0,0,989,58441,0,0,223,4765,0,0;QS=3,0;MQSB=0.91051;MQ0F=0 PL:DP:DV 0,27,228:9:0 0,18,150:6:0 0,6,68:2:0 +X 1640 . G <*> 0 . DP=17;I16=8,6,0,0,414,13296,0,0,809,47641,0,0,171,3467,0,0;QS=3,0;MQSB=0.875173;MQ0F=0 PL:DP:DV 0,18,150:6:0 0,18,151:6:0 0,6,51:2:0 +X 1641 . C <*> 0 . DP=18;I16=9,8,0,0,511,16289,0,0,989,58441,0,0,225,4709,0,0;QS=3,0;MQSB=0.91051;MQ0F=0 PL:DP:DV 0,27,188:9:0 0,18,167:6:0 0,6,65:2:0 +X 1642 . T <*> 0 . DP=17;I16=8,7,0,0,519,18513,0,0,869,51241,0,0,217,4613,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,18,170:6:0 0,18,168:6:0 0,9,102:3:0 +X 1643 . C <*> 0 . DP=16;I16=7,9,0,0,508,16910,0,0,929,54841,0,0,255,5361,0,0;QS=3,0;MQSB=0.933674;MQ0F=0 PL:DP:DV 0,24,193:8:0 0,18,169:6:0 0,6,56:2:0 +X 1644 . C <*> 0 . DP=15;I16=6,9,0,0,514,18056,0,0,869,51241,0,0,259,5401,0,0;QS=3,0;MQSB=0.939413;MQ0F=0 PL:DP:DV 0,21,209:7:0 0,18,165:6:0 0,6,54:2:0 +X 1645 . A <*> 0 . DP=15;I16=6,9,0,0,520,18852,0,0,869,51241,0,0,263,5457,0,0;QS=3,0;MQSB=0.939413;MQ0F=0 PL:DP:DV 0,21,213:7:0 0,18,173:6:0 0,6,49:2:0 +X 1646 . G <*> 0 . DP=15;I16=6,7,0,0,440,15526,0,0,780,46800,0,0,217,4279,0,0;QS=3,0;MQSB=0.961166;MQ0F=0 PL:DP:DV 0,18,185:6:0 0,15,148:5:0 0,6,48:2:0 +X 1647 . C <*> 0 . DP=15;I16=6,9,0,0,433,13883,0,0,869,51241,0,0,271,5617,0,0;QS=3,0;MQSB=0.939413;MQ0F=0 PL:DP:DV 0,21,190:7:0 0,18,139:6:0 0,6,35:2:0 +X 1648 . C <*> 0 . DP=15;I16=6,9,0,0,495,16965,0,0,869,51241,0,0,275,5721,0,0;QS=3,0;MQSB=0.939413;MQ0F=0 PL:DP:DV 0,21,203:7:0 0,18,159:6:0 0,6,44:2:0 +X 1649 . T <*> 0 . DP=15;I16=6,9,0,0,516,18122,0,0,869,51241,0,0,279,5841,0,0;QS=3,0;MQSB=0.939413;MQ0F=0 PL:DP:DV 0,21,187:7:0 0,18,182:6:0 0,6,56:2:0 +X 1650 . C <*> 0 . DP=15;I16=6,7,0,0,405,13551,0,0,749,44041,0,0,240,5028,0,0;QS=3,0;MQSB=0.899815;MQ0F=0 PL:DP:DV 0,18,161:6:0 0,18,169:6:0 0,3,13:1:0 +X 1651 . G <*> 0 . DP=17;I16=5,9,0,0,424,13328,0,0,778,44882,0,0,249,5335,0,0;QS=3,0;MQSB=0.965069;MQ0F=0 PL:DP:DV 0,18,150:6:0 0,15,128:5:0 0,9,86:3:0 +X 1652 . G <*> 0 . DP=18;I16=7,9,0,0,532,18602,0,0,898,52082,0,0,267,5673,0,0;QS=3,0;MQSB=0.994413;MQ0F=0 PL:DP:DV 0,24,212:8:0 0,18,168:6:0 0,6,54:2:0 +X 1653 . C <*> 0 . DP=18;I16=8,10,0,0,581,19565,0,0,1018,59282,0,0,300,6490,0,0;QS=3,0;MQSB=0.99606;MQ0F=0 PL:DP:DV 0,24,208:8:0 0,21,175:7:0 0,9,82:3:0 +X 1654 . A T,<*> 0 . DP=18;I16=8,9,0,1,516,16718,15,225,958,55682,60,3600,285,6219,22,484;QS=2.93213,0.0678733,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.99606;BQB=1;MQ0F=0 PL:DP:DV 0,9,155,21,158,162:8:1 0,21,179,21,179,179:7:0 0,9,78,9,78,78:3:0 +X 1655 . C <*> 0 . DP=18;I16=8,10,0,0,565,19017,0,0,1018,59282,0,0,313,6887,0,0;QS=3,0;MQSB=0.99606;MQ0F=0 PL:DP:DV 0,24,198:8:0 0,21,180:7:0 0,9,79:3:0 +X 1656 . C <*> 0 . DP=19;I16=9,9,0,0,557,18013,0,0,1018,59282,0,0,295,6515,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,202:8:0 0,21,165:7:0 0,9,80:3:0 +X 1657 . T A,<*> 0 . DP=18;I16=8,9,0,1,580,20362,15,225,989,58441,29,841,301,6641,25,625;QS=2.93243,0.0675676,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.99606;BQB=1;MQ0F=0 PL:DP:DV 0,24,206,24,206,206:8:0 0,6,158,18,161,165:7:1 0,9,85,9,85,85:3:0 +X 1658 . T <*> 0 . DP=19;I16=8,10,0,0,573,19127,0,0,1018,59282,0,0,332,7412,0,0;QS=3,0;MQSB=0.99606;MQ0F=0 PL:DP:DV 0,24,187:8:0 0,21,189:7:0 0,9,91:3:0 +X 1659 . C <*> 0 . DP=20;I16=8,10,0,0,609,21517,0,0,1049,62041,0,0,338,7578,0,0;QS=3,0;MQSB=0.906029;MQ0F=0 PL:DP:DV 0,24,219:8:0 0,21,189:7:0 0,9,80:3:0 +X 1660 . A <*> 0 . DP=21;I16=8,11,0,0,641,23219,0,0,1078,62882,0,0,385,8901,0,0;QS=3,0;MQSB=0.992359;MQ0F=0 PL:DP:DV 0,21,172:7:0 0,24,219:8:0 0,12,127:4:0 +X 1661 . G <*> 0 . DP=21;I16=7,13,0,0,639,21739,0,0,1107,63723,0,0,412,9598,0,0;QS=3,0;MQSB=0.999215;MQ0F=0 PL:DP:DV 0,24,209:8:0 0,24,193:8:0 0,12,98:4:0 +X 1662 . C <*> 0 . DP=21;I16=8,12,0,0,641,21423,0,0,1107,63723,0,0,407,9465,0,0;QS=3,0;MQSB=0.988166;MQ0F=0 PL:DP:DV 0,21,192:7:0 0,27,211:9:0 0,12,100:4:0 +X 1663 . C <*> 0 . DP=20;I16=7,11,0,0,577,19507,0,0,1018,59282,0,0,394,9204,0,0;QS=3,0;MQSB=0.983729;MQ0F=0 PL:DP:DV 0,21,178:7:0 0,21,192:7:0 0,12,101:4:0 +X 1664 . A C,<*> 0 . DP=20;I16=6,10,0,1,530,17982,13,169,898,52082,29,841,358,8422,25,625;QS=2.93953,0.0604651,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.998738;BQB=1;MQ0F=0 PL:DP:DV 0,18,167,18,167,167:6:0 0,7,154,18,157,159:7:1 0,12,109,12,109,109:4:0 +X 1665 . T C,<*> 0 . DP=20;I16=7,11,1,1,592,20170,58,1924,1018,59282,89,4441,396,9188,39,821;QS=2.5913,0.408696,0;VDB=0.1;SGB=0.346553;RPB=0.222222;MQB=0.611111;MQSB=0.988166;BQB=0.944444;MQ0F=0 PL:DP:DV 0,21,185,21,185,185:7:0 0,27,222,27,222,222:9:0 35,0,51,41,57,90:4:2 +X 1666 . G <*> 0 . DP=20;I16=8,12,0,0,614,19760,0,0,1107,63723,0,0,435,9947,0,0;QS=3,0;MQSB=0.988166;MQ0F=0 PL:DP:DV 0,21,173:7:0 0,27,206:9:0 0,12,111:4:0 +X 1667 . G <*> 0 . DP=20;I16=8,11,0,0,617,21033,0,0,1078,62882,0,0,410,9276,0,0;QS=3,0;MQSB=0.992359;MQ0F=0 PL:DP:DV 0,21,183:7:0 0,24,195:8:0 0,12,115:4:0 +X 1668 . A <*> 0 . DP=20;I16=7,10,0,0,570,19908,0,0,958,55682,0,0,369,8365,0,0;QS=3,0;MQSB=0.989343;MQ0F=0 PL:DP:DV 0,18,158:6:0 0,21,186:7:0 0,12,124:4:0 +X 1669 . C <*> 0 . DP=20;I16=8,12,0,0,640,21336,0,0,1107,63723,0,0,435,9857,0,0;QS=3,0;MQSB=0.988166;MQ0F=0 PL:DP:DV 0,21,172:7:0 0,27,216:9:0 0,12,115:4:0 +X 1670 . A <*> 0 . DP=23;I16=9,13,0,0,765,27363,0,0,1258,73682,0,0,410,9234,0,0;QS=3,0;MQSB=0.991121;MQ0F=0 PL:DP:DV 0,27,215:9:0 0,27,233:9:0 0,12,129:4:0 +X 1671 . G <*> 0 . DP=23;I16=9,13,0,0,703,23631,0,0,1258,73682,0,0,412,9206,0,0;QS=3,0;MQSB=0.991121;MQ0F=0 PL:DP:DV 0,27,214:9:0 0,27,210:9:0 0,12,106:4:0 +X 1672 . T <*> 0 . DP=23;I16=9,13,0,0,724,24700,0,0,1258,73682,0,0,414,9202,0,0;QS=3,0;MQSB=0.991121;MQ0F=0 PL:DP:DV 0,27,203:9:0 0,27,232:9:0 0,12,111:4:0 +X 1673 . T <*> 0 . DP=25;I16=8,13,0,0,719,25183,0,0,1198,70082,0,0,372,8248,0,0;QS=3,0;MQSB=0.983744;MQ0F=0 PL:DP:DV 0,27,221:9:0 0,24,212:8:0 0,12,112:4:0 +X 1674 . C <*> 0 . DP=25;I16=8,14,0,0,755,26561,0,0,1289,76441,0,0,389,8417,0,0;QS=3,0;MQSB=0.892142;MQ0F=0 PL:DP:DV 0,33,244:11:0 0,21,206:7:0 0,12,96:4:0 +X 1675 . C <*> 0 . DP=25;I16=9,15,0,0,705,22355,0,0,1347,78123,0,0,447,9897,0,0;QS=3,0;MQSB=0.996008;MQ0F=0 PL:DP:DV 0,33,222:11:0 0,30,212:10:0 0,9,65:3:0 +X 1676 . G <*> 0 . DP=25;I16=6,15,0,0,660,21708,0,0,1167,67323,0,0,383,8265,0,0;QS=3,0;MQSB=0.993205;MQ0F=0 PL:DP:DV 0,33,222:11:0 0,21,170:7:0 0,9,96:3:0 +X 1677 . C <*> 0 . DP=25;I16=9,13,0,0,681,22869,0,0,1289,76441,0,0,394,8510,0,0;QS=3,0;MQSB=0.910098;MQ0F=0 PL:DP:DV 0,33,225:11:0 0,24,198:8:0 0,9,74:3:0 +X 1678 . C <*> 0 . DP=25;I16=9,15,0,0,775,26785,0,0,1347,78123,0,0,438,9496,0,0;QS=3,0;MQSB=0.996008;MQ0F=0 PL:DP:DV 0,33,235:11:0 0,30,231:10:0 0,9,83:3:0 +X 1679 . A <*> 0 . DP=25;I16=8,15,0,0,762,27552,0,0,1287,74523,0,0,412,8858,0,0;QS=3,0;MQSB=0.999479;MQ0F=0 PL:DP:DV 0,33,235:11:0 0,27,219:9:0 0,9,106:3:0 +X 1680 . G <*> 0 . DP=26;I16=9,17,0,0,843,29213,0,0,1467,85323,0,0,459,10021,0,0;QS=3,0;MQSB=0.999637;MQ0F=0 PL:DP:DV 0,33,253:11:0 0,33,232:11:0 0,12,108:4:0 +X 1681 . C <*> 0 . DP=26;I16=8,15,0,0,681,21293,0,0,1318,77282,0,0,407,8999,0,0;QS=3,0;MQSB=0.974802;MQ0F=0 PL:DP:DV 0,33,223:11:0 0,27,191:9:0 0,9,69:3:0 +X 1682 . G <*> 0 . DP=25;I16=9,16,0,0,728,22560,0,0,1407,81723,0,0,455,9877,0,0;QS=3,0;MQSB=0.998399;MQ0F=0 PL:DP:DV 0,30,222:10:0 0,33,208:11:0 0,12,98:4:0 +X 1683 . T <*> 0 . DP=25;I16=8,15,0,0,807,29159,0,0,1287,74523,0,0,403,8567,0,0;QS=3,0;MQSB=0.999479;MQ0F=0 PL:DP:DV 0,30,250:10:0 0,30,235:10:0 0,9,91:3:0 +X 1684 . T <*> 0 . DP=25;I16=8,15,0,0,802,28774,0,0,1318,77282,0,0,438,9612,0,0;QS=3,0;MQSB=0.974802;MQ0F=0 PL:DP:DV 0,27,227:9:0 0,30,237:10:0 0,12,107:4:0 +X 1685 . G <*> 0 . DP=24;I16=8,14,0,0,759,27319,0,0,1258,73682,0,0,413,8999,0,0;QS=3,0;MQSB=0.979255;MQ0F=0 PL:DP:DV 0,24,216:8:0 0,30,242:10:0 0,12,110:4:0 +X 1686 . C <*> 0 . DP=24;I16=8,15,0,0,793,28073,0,0,1318,77282,0,0,438,9656,0,0;QS=3,0;MQSB=0.974802;MQ0F=0 PL:DP:DV 0,27,225:9:0 0,30,241:10:0 0,12,103:4:0 +X 1687 . C <*> 0 . DP=24;I16=7,14,0,0,741,26765,0,0,1198,70082,0,0,388,8458,0,0;QS=3,0;MQSB=0.966484;MQ0F=0 PL:DP:DV 0,24,221:8:0 0,27,229:9:0 0,12,106:4:0 +X 1688 . C <*> 0 . DP=24;I16=8,15,0,0,794,28736,0,0,1318,77282,0,0,431,9605,0,0;QS=3,0;MQSB=0.974802;MQ0F=0 PL:DP:DV 0,27,239:9:0 0,30,221:10:0 0,12,120:4:0 +X 1689 . T A,<*> 0 . DP=24;I16=8,15,0,1,805,29443,33,1089,1287,74523,60,3600,421,9311,25,625;QS=2.74419,0.255814,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=1;BQB=1;MQ0F=0 PL:DP:DV 0,27,224,27,224,224:9:0 0,33,255,33,255,255:11:0 21,0,79,30,82,106:4:1 +X 1690 . C <*> 0 . DP=24;I16=8,16,0,0,864,32420,0,0,1347,78123,0,0,445,10033,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,242:9:0 0,33,255:11:0 0,12,95:4:0 +X 1691 . T <*> 0 . DP=22;I16=7,14,0,0,734,27150,0,0,1167,67323,0,0,421,9525,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,225:9:0 0,30,242:10:0 0,6,57:2:0 +X 1692 . G <*> 0 . DP=22;I16=7,13,0,0,678,24110,0,0,1107,63723,0,0,400,9176,0,0;QS=3,0;MQSB=0.999215;MQ0F=0 PL:DP:DV 0,24,218:8:0 0,30,218:10:0 0,6,61:2:0 +X 1693 . T <*> 0 . DP=24;I16=10,13,0,0,795,28363,0,0,1318,77282,0,0,444,10422,0,0;QS=3,0;MQSB=0.995682;MQ0F=0 PL:DP:DV 0,27,227:9:0 0,30,235:10:0 0,12,104:4:0 +X 1694 . T <*> 0 . DP=24;I16=10,13,0,0,771,26775,0,0,1318,77282,0,0,448,10602,0,0;QS=3,0;MQSB=0.995682;MQ0F=0 PL:DP:DV 0,27,221:9:0 0,30,232:10:0 0,12,114:4:0 +X 1695 . C <*> 0 . DP=24;I16=10,14,0,0,811,28517,0,0,1347,78123,0,0,454,10806,0,0;QS=3,0;MQSB=0.98469;MQ0F=0 PL:DP:DV 0,27,227:9:0 0,33,239:11:0 0,12,121:4:0 +X 1696 . T <*> 0 . DP=23;I16=10,13,0,0,825,30819,0,0,1287,74523,0,0,455,10869,0,0;QS=3,0;MQSB=0.976718;MQ0F=0 PL:DP:DV 0,24,219:8:0 0,33,255:11:0 0,12,108:4:0 +X 1697 . G <*> 0 . DP=23;I16=10,13,0,0,767,26757,0,0,1287,74523,0,0,455,10897,0,0;QS=3,0;MQSB=0.976718;MQ0F=0 PL:DP:DV 0,24,208:8:0 0,33,246:11:0 0,12,112:4:0 +X 1698 . C A,<*> 0 . DP=21;I16=10,10,0,1,726,27088,27,729,1169,69241,29,841,451,10903,6,36;QS=2.91148,0.0885246,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.99938;BQB=1;MQ0F=0 PL:DP:DV 0,24,229,24,229,229:8:0 0,0,190,24,193,207:9:1 0,12,111,12,111,111:4:0 +X 1699 . T <*> 0 . DP=21;I16=9,10,0,0,698,25826,0,0,1078,62882,0,0,408,9692,0,0;QS=3,0;MQSB=0.999167;MQ0F=0 PL:DP:DV 0,21,203:7:0 0,24,219:8:0 0,12,115:4:0 +X 1700 . G <*> 0 . DP=20;I16=9,10,0,0,696,25850,0,0,1078,62882,0,0,409,9705,0,0;QS=3,0;MQSB=0.999167;MQ0F=0 PL:DP:DV 0,21,216:7:0 0,24,215:8:0 0,12,110:4:0 +X 1701 . T <*> 0 . DP=20;I16=9,11,0,0,711,25539,0,0,1138,66482,0,0,435,10353,0,0;QS=3,0;MQSB=0.997118;MQ0F=0 PL:DP:DV 0,24,207:8:0 0,24,210:8:0 0,12,125:4:0 +X 1702 . T <*> 0 . DP=20;I16=8,11,0,0,671,24367,0,0,1078,62882,0,0,410,9712,0,0;QS=3,0;MQSB=0.992359;MQ0F=0 PL:DP:DV 0,24,214:8:0 0,21,193:7:0 0,12,115:4:0 +X 1703 . T <*> 0 . DP=20;I16=9,10,0,0,648,22696,0,0,1078,62882,0,0,410,9708,0,0;QS=3,0;MQSB=0.999167;MQ0F=0 PL:DP:DV 0,21,197:7:0 0,24,195:8:0 0,12,114:4:0 +X 1704 . T <*> 0 . DP=20;I16=10,10,0,0,711,25771,0,0,1169,69241,0,0,435,10341,0,0;QS=3,0;MQSB=0.931063;MQ0F=0 PL:DP:DV 0,24,208:8:0 0,21,208:7:0 0,15,128:5:0 +X 1705 . C <*> 0 . DP=20;I16=10,10,0,0,744,28388,0,0,1169,69241,0,0,436,10312,0,0;QS=3,0;MQSB=0.931063;MQ0F=0 PL:DP:DV 0,24,232:8:0 0,21,213:7:0 0,15,120:5:0 +X 1706 . T <*> 0 . DP=20;I16=10,10,0,0,775,30329,0,0,1169,69241,0,0,436,10246,0,0;QS=3,0;MQSB=0.931063;MQ0F=0 PL:DP:DV 0,24,221:8:0 0,21,219:7:0 0,15,145:5:0 +X 1707 . C <*> 0 . DP=21;I16=9,11,0,0,724,26998,0,0,1169,69241,0,0,410,9518,0,0;QS=3,0;MQSB=0.916401;MQ0F=0 PL:DP:DV 0,27,235:9:0 0,18,180:6:0 0,15,134:5:0 +X 1708 . T <*> 0 . DP=21;I16=9,12,0,0,740,27282,0,0,1229,72841,0,0,410,9430,0,0;QS=3,0;MQSB=0.913101;MQ0F=0 PL:DP:DV 0,30,229:10:0 0,18,187:6:0 0,15,132:5:0 +X 1709 . A <*> 0 . DP=21;I16=9,11,0,0,675,23509,0,0,1169,69241,0,0,386,8734,0,0;QS=3,0;MQSB=0.916401;MQ0F=0 PL:DP:DV 0,27,210:9:0 0,18,166:6:0 0,15,131:5:0 +X 1710 . C <*> 0 . DP=22;I16=9,13,0,0,755,26817,0,0,1289,76441,0,0,412,9306,0,0;QS=3,0;MQSB=0.910098;MQ0F=0 PL:DP:DV 0,33,236:11:0 0,18,181:6:0 0,15,128:5:0 +X 1711 . C <*> 0 . DP=22;I16=9,13,0,0,786,28790,0,0,1289,76441,0,0,413,9223,0,0;QS=3,0;MQSB=0.910098;MQ0F=0 PL:DP:DV 0,33,250:11:0 0,18,169:6:0 0,15,138:5:0 +X 1712 . A <*> 0 . DP=22;I16=9,13,0,0,824,31342,0,0,1289,76441,0,0,414,9162,0,0;QS=3,0;MQSB=0.910098;MQ0F=0 PL:DP:DV 0,33,252:11:0 0,18,198:6:0 0,15,136:5:0 +X 1713 . G <*> 0 . DP=23;I16=8,14,0,0,823,31285,0,0,1289,76441,0,0,405,8993,0,0;QS=3,0;MQSB=0.892142;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,189:6:0 0,12,118:4:0 +X 1714 . A <*> 0 . DP=23;I16=9,13,0,0,763,27439,0,0,1289,76441,0,0,402,8818,0,0;QS=3,0;MQSB=0.910098;MQ0F=0 PL:DP:DV 0,36,234:12:0 0,18,190:6:0 0,12,101:4:0 +X 1715 . A <*> 0 . DP=23;I16=9,14,0,0,900,35416,0,0,1349,80041,0,0,414,8878,0,0;QS=3,0;MQSB=0.907354;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,206:6:0 0,15,145:5:0 +X 1716 . G <*> 0 . DP=23;I16=9,14,0,0,844,31500,0,0,1349,80041,0,0,414,8822,0,0;QS=3,0;MQSB=0.907354;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,188:6:0 0,15,129:5:0 +X 1717 . T <*> 0 . DP=24;I16=9,15,0,0,854,30878,0,0,1409,83641,0,0,414,8794,0,0;QS=3,0;MQSB=0.904837;MQ0F=0 PL:DP:DV 0,39,253:13:0 0,18,185:6:0 0,15,122:5:0 +X 1718 . G <*> 0 . DP=24;I16=9,14,0,0,806,29332,0,0,1349,80041,0,0,390,8170,0,0;QS=3,0;MQSB=0.907354;MQ0F=0 PL:DP:DV 0,36,249:12:0 0,18,188:6:0 0,15,124:5:0 +X 1719 . C <*> 0 . DP=26;I16=11,14,0,0,857,30717,0,0,1469,87241,0,0,407,8675,0,0;QS=3,0;MQSB=0.929204;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,173:6:0 0,12,98:4:0 +X 1720 . C <*> 0 . DP=26;I16=11,14,0,0,898,33274,0,0,1469,87241,0,0,409,8645,0,0;QS=3,0;MQSB=0.929204;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,166:6:0 0,12,99:4:0 +X 1721 . C <*> 0 . DP=26;I16=10,14,0,0,846,30642,0,0,1409,83641,0,0,388,8258,0,0;QS=3,0;MQSB=0.919431;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,187:6:0 0,12,119:4:0 +X 1722 . T <*> 0 . DP=25;I16=11,13,0,0,876,33054,0,0,1409,83641,0,0,406,8540,0,0;QS=3,0;MQSB=0.931547;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,174:5:0 0,15,123:5:0 +X 1723 . T <*> 0 . DP=25;I16=11,14,0,0,835,28861,0,0,1469,87241,0,0,420,8728,0,0;QS=3,0;MQSB=0.929204;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,167:5:0 0,15,130:5:0 +X 1724 . C <*> 0 . DP=25;I16=11,14,0,0,903,33735,0,0,1469,87241,0,0,422,8800,0,0;QS=3,0;MQSB=0.929204;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,164:5:0 0,15,139:5:0 +X 1725 . C G,<*> 0 . DP=25;I16=11,13,0,1,835,29699,25,625,1409,83641,60,3600,406,8576,18,324;QS=2.95164,0.0483559,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.929204;BQB=1;MQ0F=0 PL:DP:DV 0,20,255,42,255,255:15:1 0,15,153,15,153,153:5:0 0,15,132,15,132,132:5:0 +X 1726 . C <*> 0 . DP=25;I16=11,14,0,0,932,35588,0,0,1469,87241,0,0,426,9028,0,0;QS=3,0;MQSB=0.929204;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,165:5:0 0,15,122:5:0 +X 1727 . T <*> 0 . DP=25;I16=10,14,0,0,862,32080,0,0,1409,83641,0,0,404,8556,0,0;QS=3,0;MQSB=0.919431;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,167:5:0 0,12,120:4:0 +X 1728 . C <*> 0 . DP=25;I16=11,14,0,0,915,33845,0,0,1469,87241,0,0,429,9173,0,0;QS=3,0;MQSB=0.929204;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,156:5:0 0,15,144:5:0 +X 1729 . C <*> 0 . DP=25;I16=10,14,0,0,919,35797,0,0,1409,83641,0,0,406,8668,0,0;QS=3,0;MQSB=0.919431;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,142:5:0 0,12,128:4:0 +X 1730 . T <*> 0 . DP=24;I16=10,14,0,0,849,30711,0,0,1409,83641,0,0,433,9393,0,0;QS=3,0;MQSB=0.919431;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,138:4:0 0,15,148:5:0 +X 1731 . C <*> 0 . DP=24;I16=10,14,0,0,907,34875,0,0,1409,83641,0,0,434,9472,0,0;QS=3,0;MQSB=0.919431;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,123:4:0 0,15,140:5:0 +X 1732 . A <*> 0 . DP=24;I16=11,13,0,0,816,28582,0,0,1409,83641,0,0,436,9580,0,0;QS=3,0;MQSB=0.931547;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,123:4:0 0,15,143:5:0 +X 1733 . C <*> 0 . DP=25;I16=12,13,0,0,869,31451,0,0,1469,87241,0,0,438,9666,0,0;QS=3,0;MQSB=0.939413;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,116:4:0 0,15,136:5:0 +X 1734 . C <*> 0 . DP=25;I16=12,13,0,0,926,35482,0,0,1469,87241,0,0,440,9730,0,0;QS=3,0;MQSB=0.939413;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,122:4:0 0,15,141:5:0 +X 1735 . T <*> 0 . DP=26;I16=13,13,0,0,935,35169,0,0,1529,90841,0,0,442,9822,0,0;QS=3,0;MQSB=0.945959;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,112:4:0 0,15,148:5:0 +X 1736 . G <*> 0 . DP=25;I16=11,11,0,0,829,31469,0,0,1289,76441,0,0,380,8416,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,72:2:0 0,12,118:4:0 +X 1737 . A <*> 0 . DP=25;I16=12,12,0,0,842,30606,0,0,1409,83641,0,0,422,9312,0,0;QS=3,0;MQSB=0.941765;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,76:2:0 0,15,131:5:0 +X 1738 . C <*> 0 . DP=24;I16=12,12,0,0,835,30251,0,0,1409,83641,0,0,450,10010,0,0;QS=3,0;MQSB=0.941765;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,78:3:0 0,15,130:5:0 +X 1739 . C <*> 0 . DP=23;I16=10,12,0,0,831,32123,0,0,1289,76441,0,0,428,9432,0,0;QS=3,0;MQSB=0.924723;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,55:2:0 0,12,135:4:0 +X 1740 . A <*> 0 . DP=23;I16=11,12,0,0,774,27126,0,0,1349,80041,0,0,456,10126,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,56:2:0 0,15,139:5:0 +X 1741 . C <*> 0 . DP=23;I16=11,12,0,0,850,32314,0,0,1349,80041,0,0,459,10217,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,70:2:0 0,15,136:5:0 +X 1742 . T <*> 0 . DP=23;I16=11,12,0,0,866,33204,0,0,1349,80041,0,0,462,10330,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,72:2:0 0,15,144:5:0 +X 1743 . C <*> 0 . DP=23;I16=11,12,0,0,894,35176,0,0,1349,80041,0,0,464,10414,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,74:2:0 0,15,138:5:0 +X 1744 . T <*> 0 . DP=23;I16=11,11,0,0,857,33579,0,0,1289,76441,0,0,459,10469,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,80:2:0 0,15,156:5:0 +X 1745 . G <*> 0 . DP=23;I16=11,12,0,0,882,34572,0,0,1349,80041,0,0,464,10442,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,78:2:0 0,15,142:5:0 +X 1746 . G <*> 0 . DP=24;I16=12,11,0,0,836,31102,0,0,1349,80041,0,0,456,10312,0,0;QS=3,0;MQSB=0.944319;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,69:2:0 0,18,151:6:0 +X 1747 . G <*> 0 . DP=24;I16=12,11,0,0,839,31729,0,0,1349,80041,0,0,455,10239,0,0;QS=3,0;MQSB=0.944319;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,75:2:0 0,18,154:6:0 +X 1748 . G <*> 0 . DP=24;I16=11,12,0,0,843,31857,0,0,1349,80041,0,0,434,9664,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,3,42:1:0 0,18,154:6:0 +X 1749 . A <*> 0 . DP=25;I16=13,11,0,0,864,31748,0,0,1409,83641,0,0,451,10063,0,0;QS=3,0;MQSB=0.950498;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,72:2:0 0,21,172:7:0 +X 1750 . A <*> 0 . DP=25;I16=13,12,0,0,905,33667,0,0,1469,87241,0,0,451,10013,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,56:2:0 0,21,187:7:0 +X 1751 . A <*> 0 . DP=25;I16=13,12,0,0,908,33658,0,0,1469,87241,0,0,449,9987,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,67:2:0 0,21,183:7:0 +X 1752 . T <*> 0 . DP=23;I16=12,11,0,0,838,31088,0,0,1380,82800,0,0,449,9987,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,71:2:0 0,18,170:6:0 +X 1753 . C <*> 0 . DP=23;I16=12,11,0,0,869,33595,0,0,1380,82800,0,0,448,9960,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,77:2:0 0,18,163:6:0 +X 1754 . C <*> 0 . DP=23;I16=11,11,0,0,830,31628,0,0,1320,79200,0,0,431,9699,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,3,42:1:0 0,18,163:6:0 +X 1755 . C <*> 0 . DP=23;I16=12,11,0,0,856,33082,0,0,1380,82800,0,0,446,9972,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,61:2:0 0,18,165:6:0 +X 1756 . T <*> 0 . DP=22;I16=11,11,0,0,858,33720,0,0,1320,79200,0,0,445,9961,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,77:2:0 0,18,179:6:0 +X 1757 . C <*> 0 . DP=22;I16=11,11,0,0,869,34651,0,0,1320,79200,0,0,444,9972,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,78:2:0 0,18,176:6:0 +X 1758 . A <*> 0 . DP=22;I16=11,11,0,0,865,34205,0,0,1320,79200,0,0,442,9954,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,81:2:0 0,18,177:6:0 +X 1759 . G <*> 0 . DP=22;I16=11,11,0,0,833,31965,0,0,1320,79200,0,0,439,9905,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,77:2:0 0,18,159:6:0 +X 1760 . C <*> 0 . DP=22;I16=11,11,0,0,849,33441,0,0,1320,79200,0,0,436,9874,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,79:2:0 0,18,159:6:0 +X 1761 . A <*> 0 . DP=22;I16=11,11,0,0,730,25766,0,0,1320,79200,0,0,432,9810,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,75:2:0 0,18,153:6:0 +X 1762 . C <*> 0 . DP=21;I16=11,10,0,0,767,28667,0,0,1260,75600,0,0,429,9761,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,76:2:0 0,18,160:6:0 +X 1763 . C <*> 0 . DP=21;I16=11,10,0,0,789,30115,0,0,1260,75600,0,0,426,9726,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,72:2:0 0,18,162:6:0 +X 1764 . C <*> 0 . DP=21;I16=11,10,0,0,821,32443,0,0,1260,75600,0,0,423,9705,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,72:2:0 0,18,167:6:0 +X 1765 . T <*> 0 . DP=21;I16=11,10,0,0,814,31746,0,0,1260,75600,0,0,420,9698,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,83:2:0 0,18,179:6:0 +X 1766 . C <*> 0 . DP=21;I16=11,10,0,0,796,30564,0,0,1260,75600,0,0,417,9705,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,71:2:0 0,18,162:6:0 +X 1767 . C <*> 0 . DP=21;I16=11,10,0,0,779,29559,0,0,1260,75600,0,0,414,9726,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,73:2:0 0,18,163:6:0 +X 1768 . C <*> 0 . DP=21;I16=11,10,0,0,798,30670,0,0,1260,75600,0,0,411,9761,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,68:2:0 0,18,160:6:0 +X 1769 . T <*> 0 . DP=21;I16=11,10,0,0,819,32179,0,0,1260,75600,0,0,406,9712,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,77:2:0 0,18,184:6:0 +X 1770 . G <*> 0 . DP=19;I16=11,8,0,0,699,26453,0,0,1140,68400,0,0,403,9679,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,68:2:0 0,18,158:6:0 +X 1771 . A <*> 0 . DP=18;I16=10,8,0,0,707,27853,0,0,1080,64800,0,0,401,9659,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,3,42:1:0 0,18,177:6:0 +X 1772 . G <*> 0 . DP=18;I16=10,8,0,0,669,25513,0,0,1080,64800,0,0,398,9600,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,3,38:1:0 0,18,159:6:0 +X 1773 . C <*> 0 . DP=17;I16=10,7,0,0,675,26897,0,0,1020,61200,0,0,396,9550,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,3,39:1:0 0,18,172:6:0 +X 1774 . A <*> 0 . DP=17;I16=10,7,0,0,653,25153,0,0,1020,61200,0,0,394,9508,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,3,39:1:0 0,18,172:6:0 +X 1775 . T <*> 0 . DP=17;I16=10,7,0,0,605,22253,0,0,1020,61200,0,0,391,9423,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,3,38:1:0 0,18,156:6:0 +X 1776 . A <*> 0 . DP=17;I16=10,7,0,0,610,22124,0,0,1020,61200,0,0,388,9344,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,254:10:0 0,3,35:1:0 0,18,166:6:0 +X 1777 . C <*> 0 . DP=18;I16=11,7,0,0,661,24975,0,0,1080,64800,0,0,385,9271,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,3,35:1:0 0,18,158:6:0 +X 1778 . C <*> 0 . DP=18;I16=11,7,0,0,680,25970,0,0,1080,64800,0,0,383,9205,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,3,31:1:0 0,18,172:6:0 +X 1779 . C <*> 0 . DP=18;I16=11,7,0,0,703,27663,0,0,1080,64800,0,0,381,9147,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,3,34:1:0 0,18,174:6:0 +X 1780 . T <*> 0 . DP=18;I16=11,7,0,0,672,26000,0,0,1080,64800,0,0,378,9048,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,3,33:1:0 0,18,177:6:0 +X 1781 . A <*> 0 . DP=19;I16=10,6,0,0,579,21377,0,0,960,57600,0,0,328,7804,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,0,0:0:0 0,15,160:5:0 +X 1782 . C <*> 0 . DP=20;I16=11,9,0,0,715,26603,0,0,1200,72000,0,0,382,8892,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,47:2:0 0,18,156:6:0 +X 1783 . T <*> 0 . DP=20;I16=11,9,0,0,755,29057,0,0,1200,72000,0,0,381,8743,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,68:2:0 0,18,184:6:0 +X 1784 . C <*> 0 . DP=20;I16=10,9,0,0,723,28017,0,0,1140,68400,0,0,360,8212,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,62:2:0 0,15,151:5:0 +X 1785 . T <*> 0 . DP=20;I16=10,10,0,0,766,29878,0,0,1200,72000,0,0,359,8089,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,66:2:0 0,15,168:5:0 +X 1786 . G <*> 0 . DP=22;I16=11,11,0,0,841,32323,0,0,1320,79200,0,0,359,7985,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,68:2:0 0,15,158:5:0 +X 1787 . G <*> 0 . DP=22;I16=11,11,0,0,806,30294,0,0,1320,79200,0,0,361,7903,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,68:2:0 0,15,148:5:0 +X 1788 . C <*> 0 . DP=22;I16=11,11,0,0,858,33674,0,0,1320,79200,0,0,362,7796,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,67:2:0 0,15,158:5:0 +X 1789 . A <*> 0 . DP=23;I16=11,12,0,0,797,28705,0,0,1380,82800,0,0,363,7715,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,69:2:0 0,15,157:5:0 +X 1790 . C <*> 0 . DP=23;I16=11,12,0,0,852,31816,0,0,1380,82800,0,0,365,7661,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,63:2:0 0,15,153:5:0 +X 1791 . A <*> 0 . DP=23;I16=11,12,0,0,830,30484,0,0,1380,82800,0,0,367,7635,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,61:2:0 0,15,155:5:0 +X 1792 . A <*> 0 . DP=23;I16=11,12,0,0,862,32760,0,0,1380,82800,0,0,368,7588,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,67:2:0 0,15,161:5:0 +X 1793 . G <*> 0 . DP=23;I16=11,12,0,0,813,29603,0,0,1380,82800,0,0,369,7571,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,61:2:0 0,15,126:5:0 +X 1794 . C <*> 0 . DP=21;I16=9,12,0,0,736,26472,0,0,1260,75600,0,0,370,7484,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,48:2:0 0,9,96:3:0 +X 1795 . C <*> 0 . DP=21;I16=9,12,0,0,763,28807,0,0,1260,75600,0,0,371,7427,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,45:2:0 0,9,100:3:0 +X 1796 . C <*> 0 . DP=21;I16=9,12,0,0,782,29718,0,0,1260,75600,0,0,372,7400,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,52:2:0 0,9,102:3:0 +X 1797 . A <*> 0 . DP=21;I16=9,12,0,0,704,25190,0,0,1260,75600,0,0,373,7403,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,59:2:0 0,9,92:3:0 +X 1798 . C <*> 0 . DP=21;I16=9,12,0,0,759,28119,0,0,1260,75600,0,0,374,7436,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,49:2:0 0,9,99:3:0 +X 1799 . C <*> 0 . DP=22;I16=9,13,0,0,796,29520,0,0,1320,79200,0,0,375,7499,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,56:2:0 0,12,131:4:0 +X 1800 . C <*> 0 . DP=22;I16=9,13,0,0,866,34352,0,0,1320,79200,0,0,376,7542,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,63:2:0 0,12,138:4:0 +X 1801 . T <*> 0 . DP=22;I16=9,13,0,0,838,32282,0,0,1320,79200,0,0,377,7615,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,63:2:0 0,12,150:4:0 +X 1802 . G <*> 0 . DP=22;I16=9,13,0,0,844,32894,0,0,1320,79200,0,0,378,7718,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,60:2:0 0,12,137:4:0 +X 1803 . C <*> 0 . DP=22;I16=9,13,0,0,837,32691,0,0,1320,79200,0,0,377,7751,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,60:2:0 0,12,143:4:0 +X 1804 . A <*> 0 . DP=23;I16=9,14,0,0,793,28517,0,0,1380,82800,0,0,376,7814,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,54:2:0 0,12,144:4:0 +X 1805 . A <*> 0 . DP=23;I16=9,14,0,0,810,29148,0,0,1380,82800,0,0,376,7908,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,67:2:0 0,12,138:4:0 +X 1806 . A <*> 0 . DP=23;I16=9,14,0,0,816,29932,0,0,1380,82800,0,0,376,8034,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,61:2:0 0,12,139:4:0 +X 1807 . G <*> 0 . DP=22;I16=9,13,0,0,837,32299,0,0,1320,79200,0,0,375,8091,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,67:2:0 0,12,142:4:0 +X 1808 . C <*> 0 . DP=21;I16=9,11,0,0,705,25519,0,0,1200,72000,0,0,354,7716,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,53:2:0 0,12,140:4:0 +X 1809 . C <*> 0 . DP=22;I16=10,12,0,0,789,29123,0,0,1320,79200,0,0,371,8091,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,55:2:0 0,12,143:4:0 +X 1810 . C <*> 0 . DP=21;I16=10,11,0,0,754,27902,0,0,1260,75600,0,0,370,8084,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,51:2:0 0,12,145:4:0 +X 1811 . C <*> 0 . DP=22;I16=11,11,0,0,837,32353,0,0,1320,79200,0,0,368,8056,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,61:2:0 0,12,146:4:0 +X 1812 . T <*> 0 . DP=22;I16=11,11,0,0,830,31782,0,0,1320,79200,0,0,365,7955,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,60:2:0 0,12,151:4:0 +X 1813 . G <*> 0 . DP=21;I16=11,10,0,0,789,29971,0,0,1260,75600,0,0,363,7879,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,63:2:0 0,12,135:4:0 +X 1814 . A <*> 0 . DP=21;I16=11,10,0,0,780,29356,0,0,1260,75600,0,0,361,7827,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,63:2:0 0,12,148:4:0 +X 1815 . G <*> 0 . DP=21;I16=11,10,0,0,742,27064,0,0,1260,75600,0,0,358,7748,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,56:2:0 0,12,135:4:0 +X 1816 . G <*> 0 . DP=21;I16=11,10,0,0,702,24670,0,0,1260,75600,0,0,355,7691,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,49:2:0 0,12,124:4:0 +X 1817 . C <*> 0 . DP=20;I16=11,9,0,0,701,25263,0,0,1200,72000,0,0,353,7655,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,58:2:0 0,12,134:4:0 +X 1818 . C <*> 0 . DP=20;I16=11,8,0,0,665,23987,0,0,1140,68400,0,0,326,7014,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,53:2:0 0,12,132:4:0 +X 1819 . C <*> 0 . DP=18;I16=9,9,0,0,580,20092,0,0,1080,64800,0,0,351,7641,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,38:2:0 0,12,124:4:0 +X 1820 . G <*> 0 . DP=18;I16=9,9,0,0,589,19883,0,0,1080,64800,0,0,351,7659,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,58:2:0 0,12,117:4:0 +X 1821 . C <*> 0 . DP=18;I16=9,9,0,0,619,22131,0,0,1080,64800,0,0,351,7693,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,60:2:0 0,12,131:4:0 +X 1822 . C <*> 0 . DP=18;I16=9,9,0,0,655,24177,0,0,1080,64800,0,0,350,7694,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,58:2:0 0,12,131:4:0 +X 1823 . C <*> 0 . DP=19;I16=10,9,0,0,703,26765,0,0,1140,68400,0,0,349,7713,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,62:2:0 0,12,138:4:0 +X 1824 . T <*> 0 . DP=19;I16=10,9,0,0,714,27628,0,0,1140,68400,0,0,349,7751,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,69:2:0 0,12,149:4:0 +X 1825 . G <*> 0 . DP=19;I16=10,9,0,0,682,24804,0,0,1140,68400,0,0,347,7709,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,61:2:0 0,12,129:4:0 +X 1826 . T <*> 0 . DP=19;I16=10,9,0,0,643,22525,0,0,1140,68400,0,0,345,7687,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,62:2:0 0,12,141:4:0 +X 1827 . G <*> 0 . DP=19;I16=10,9,0,0,722,27844,0,0,1140,68400,0,0,343,7685,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,66:2:0 0,12,134:4:0 +X 1828 . G <*> 0 . DP=18;I16=10,8,0,0,619,21719,0,0,1080,64800,0,0,342,7702,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,61:2:0 0,9,100:3:0 +X 1829 . C <*> 0 . DP=19;I16=9,9,0,0,576,19228,0,0,1080,64800,0,0,323,7413,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,59:3:0 0,9,103:3:0 +X 1830 . G <*> 0 . DP=19;I16=9,9,0,0,582,19586,0,0,1080,64800,0,0,321,7379,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,82:3:0 0,9,80:3:0 +X 1831 . T <*> 0 . DP=20;I16=10,8,0,0,605,21015,0,0,1080,64800,0,0,294,6736,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,106:4:0 0,9,101:3:0 +X 1832 . C <*> 0 . DP=19;I16=9,9,0,0,675,25747,0,0,1080,64800,0,0,319,7359,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,110:4:0 0,9,105:3:0 +X 1833 . T <*> 0 . DP=18;I16=8,8,0,0,565,20733,0,0,960,57600,0,0,295,6747,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,248:10:0 0,9,105:3:0 0,9,106:3:0 +X 1834 . C <*> 0 . DP=19;I16=9,9,0,0,654,24424,0,0,1037,61489,0,0,321,7399,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,104:4:0 0,9,107:3:0 +X 1835 . T <*> 0 . DP=18;I16=9,9,0,0,641,23505,0,0,1037,61489,0,0,347,7965,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,123:4:0 0,9,115:3:0 +X 1836 . C <*> 0 . DP=18;I16=9,9,0,0,657,24427,0,0,1037,61489,0,0,350,8016,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,127:4:0 0,9,108:3:0 +X 1837 . C <*> 0 . DP=18;I16=9,9,0,0,586,20044,0,0,1037,61489,0,0,352,8030,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,33,233:11:0 0,12,114:4:0 0,9,108:3:0 +X 1838 . C <*> 0 . DP=18;I16=9,9,0,0,655,24607,0,0,1037,61489,0,0,354,8056,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,120:4:0 0,9,107:3:0 +X 1839 . T <*> 0 . DP=18;I16=9,7,0,0,557,20543,0,0,917,54289,0,0,321,7369,0,0;QS=3,0;MQSB=0.933674;MQ0F=0 PL:DP:DV 0,30,231:10:0 0,9,103:3:0 0,9,119:3:0 +X 1840 . C <*> 0 . DP=18;I16=9,9,0,0,637,23295,0,0,1037,61489,0,0,358,8144,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,116:4:0 0,9,109:3:0 +X 1841 . C <*> 0 . DP=18;I16=9,9,0,0,622,22458,0,0,1037,61489,0,0,360,8206,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,33,252:11:0 0,12,121:4:0 0,9,108:3:0 +X 1842 . C <*> 0 . DP=18;I16=9,9,0,0,672,26064,0,0,1037,61489,0,0,362,8280,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,124:4:0 0,9,108:3:0 +X 1843 . T <*> 0 . DP=18;I16=9,9,0,0,630,22746,0,0,1037,61489,0,0,364,8366,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,33,243:11:0 0,12,131:4:0 0,9,107:3:0 +X 1844 . T <*> 0 . DP=18;I16=9,9,0,0,618,21618,0,0,1037,61489,0,0,366,8464,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,33,240:11:0 0,12,137:4:0 0,9,98:3:0 +X 1845 . G <*> 0 . DP=18;I16=9,9,0,0,644,23976,0,0,1037,61489,0,0,368,8574,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,138:4:0 0,9,82:3:0 +X 1846 . C <*> 0 . DP=18;I16=9,9,0,0,687,26809,0,0,1037,61489,0,0,370,8696,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,129:4:0 0,9,100:3:0 +X 1847 . T <*> 0 . DP=18;I16=9,9,0,0,675,25529,0,0,1037,61489,0,0,373,8829,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,132:4:0 0,6,76:2:0 +X 1848 . G <*> 0 . DP=18;I16=9,9,0,0,597,20845,0,0,1037,61489,0,0,377,8973,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,118:4:0 0,6,64:2:0 +X 1849 . T <*> 0 . DP=20;I16=9,10,0,0,614,20770,0,0,1097,65089,0,0,380,9078,0,0;QS=3,0;MQSB=0.920044;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,119:4:0 0,6,71:2:0 +X 1850 . C <*> 0 . DP=19;I16=8,11,0,0,684,25154,0,0,1097,65089,0,0,409,9769,0,0;QS=3,0;MQSB=0.902014;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,120:4:0 0,3,37:1:0 +X 1851 . A <*> 0 . DP=20;I16=9,11,0,0,738,27838,0,0,1157,68689,0,0,413,9847,0,0;QS=3,0;MQSB=0.916401;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,143:4:0 0,3,41:1:0 +X 1852 . G <*> 0 . DP=19;I16=8,11,0,0,639,22239,0,0,1097,65089,0,0,392,9264,0,0;QS=3,0;MQSB=0.902014;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,117:4:0 0,3,36:1:0 +X 1853 . G <*> 0 . DP=20;I16=9,11,0,0,627,20873,0,0,1157,68689,0,0,396,9322,0,0;QS=3,0;MQSB=0.916401;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,127:5:0 0,3,38:1:0 +X 1854 . A <*> 0 . DP=22;I16=10,11,0,0,674,22428,0,0,1217,72289,0,0,401,9397,0,0;QS=3,0;MQSB=0.927743;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,145:5:0 0,3,38:1:0 +X 1855 . C <*> 0 . DP=22;I16=10,12,0,0,771,27949,0,0,1277,75889,0,0,407,9441,0,0;QS=3,0;MQSB=0.924723;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,132:5:0 0,3,37:1:0 +X 1856 . A <*> 0 . DP=22;I16=10,12,0,0,806,30230,0,0,1277,75889,0,0,412,9456,0,0;QS=3,0;MQSB=0.924723;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,146:5:0 0,3,41:1:0 +X 1857 . G <*> 0 . DP=22;I16=10,12,0,0,699,23919,0,0,1277,75889,0,0,416,9442,0,0;QS=3,0;MQSB=0.924723;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,134:5:0 0,3,35:1:0 +X 1858 . T <*> 0 . DP=23;I16=10,13,0,0,773,26797,0,0,1337,79489,0,0,419,9399,0,0;QS=3,0;MQSB=0.921963;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,148:5:0 0,3,37:1:0 +X 1859 . G <*> 0 . DP=23;I16=10,13,0,0,798,28594,0,0,1337,79489,0,0,423,9379,0,0;QS=3,0;MQSB=0.921963;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,146:5:0 0,3,36:1:0 +X 1860 . G <*> 0 . DP=23;I16=10,13,0,0,726,23842,0,0,1337,79489,0,0,425,9283,0,0;QS=3,0;MQSB=0.921963;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,126:5:0 0,3,33:1:0 +X 1861 . T <*> 0 . DP=23;I16=10,13,0,0,741,24793,0,0,1337,79489,0,0,425,9113,0,0;QS=3,0;MQSB=0.921963;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,143:5:0 0,3,39:1:0 +X 1862 . C <*> 0 . DP=23;I16=10,12,0,0,738,25732,0,0,1277,75889,0,0,403,8487,0,0;QS=3,0;MQSB=0.924723;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,135:5:0 0,3,34:1:0 +X 1863 . C <*> 0 . DP=24;I16=10,13,0,0,804,29186,0,0,1337,79489,0,0,400,8232,0,0;QS=3,0;MQSB=0.921963;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,133:5:0 0,3,36:1:0 +X 1864 . T <*> 0 . DP=24;I16=11,11,0,0,766,27572,0,0,1277,75889,0,0,392,8174,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,125:4:0 0,3,37:1:0 +X 1865 . G <*> 0 . DP=24;I16=11,13,0,0,860,31394,0,0,1397,83089,0,0,425,8621,0,0;QS=3,0;MQSB=0.931547;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,154:5:0 0,3,38:1:0 +X 1866 . G <*> 0 . DP=24;I16=11,13,0,0,795,27503,0,0,1397,83089,0,0,425,8551,0,0;QS=3,0;MQSB=0.931547;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,152:5:0 0,3,36:1:0 +X 1867 . C <*> 0 . DP=24;I16=9,13,0,0,726,24886,0,0,1320,79200,0,0,375,7263,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,122:5:0 0,3,38:1:0 +X 1868 . C <*> 0 . DP=24;I16=11,12,0,0,857,32293,0,0,1337,79489,0,0,411,8311,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,12,118:4:0 0,3,41:1:0 +X 1869 . A T,<*> 0 . DP=24;I16=6,9,5,4,531,19001,268,8660,857,50689,540,32400,273,5667,152,2866;QS=1.4724,1.5276,0;VDB=0.928022;SGB=-11.9537;RPB=0.984127;MQB=0.96464;MQSB=0.931547;BQB=0.359155;MQ0F=0 PL:DP:DV 115,0,224,148,245,255:18:7 16,0,104,28,107,128:5:1 42,3,0,42,3,42:1:1 +X 1870 . C <*> 0 . DP=25;I16=11,13,0,0,804,27826,0,0,1397,83089,0,0,425,8591,0,0;QS=3,0;MQSB=0.931547;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,127:5:0 0,3,36:1:0 +X 1871 . C <*> 0 . DP=25;I16=11,14,0,0,761,24187,0,0,1457,86689,0,0,428,8690,0,0;QS=3,0;MQSB=0.929204;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,128:6:0 0,3,29:1:0 +X 1872 . G <*> 0 . DP=25;I16=10,14,0,0,763,25437,0,0,1397,83089,0,0,425,8803,0,0;QS=3,0;MQSB=0.919431;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,132:6:0 0,3,43:1:0 +X 1873 . G <*> 0 . DP=26;I16=11,15,0,0,790,25548,0,0,1517,90289,0,0,429,8931,0,0;QS=3,0;MQSB=0.927041;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,151:7:0 0,3,43:1:0 +X 1874 . G <*> 0 . DP=27;I16=11,16,0,0,861,29013,0,0,1577,93889,0,0,430,9076,0,0;QS=3,0;MQSB=0.925036;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,24,172:8:0 0,3,43:1:0 +X 1875 . G <*> 0 . DP=26;I16=11,15,0,0,800,26216,0,0,1517,90289,0,0,431,9155,0,0;QS=3,0;MQSB=0.927041;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,168:7:0 0,3,42:1:0 +X 1876 . C <*> 0 . DP=26;I16=10,15,0,0,894,32714,0,0,1457,86689,0,0,432,9268,0,0;QS=3,0;MQSB=0.9171;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,171:7:0 0,3,41:1:0 +X 1877 . T <*> 0 . DP=25;I16=9,15,0,0,848,30804,0,0,1397,83089,0,0,409,8787,0,0;QS=3,0;MQSB=0.904837;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,163:6:0 0,3,42:1:0 +X 1878 . C <*> 0 . DP=25;I16=10,15,0,0,906,33478,0,0,1457,86689,0,0,434,9488,0,0;QS=3,0;MQSB=0.9171;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,166:7:0 0,3,40:1:0 +X 1879 . A <*> 0 . DP=26;I16=10,16,0,0,911,32761,0,0,1517,90289,0,0,433,9543,0,0;QS=3,0;MQSB=0.914947;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,191:8:0 0,3,40:1:0 +X 1880 . C <*> 0 . DP=26;I16=10,16,0,0,790,24876,0,0,1517,90289,0,0,431,9527,0,0;QS=3,0;MQSB=0.914947;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,152:8:0 0,3,31:1:0 +X 1881 . G <*> 0 . DP=27;I16=10,15,0,0,782,25352,0,0,1500,90000,0,0,380,8288,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,144:7:0 0,3,42:1:0 +X 1882 . G <*> 0 . DP=28;I16=12,15,0,0,937,33215,0,0,1577,93889,0,0,406,8952,0,0;QS=3,0;MQSB=0.935229;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,164:7:0 0,3,42:1:0 +X 1883 . A <*> 0 . DP=29;I16=14,15,0,0,998,35394,0,0,1697,101089,0,0,434,9646,0,0;QS=3,0;MQSB=0.947838;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,24,180:8:0 0,3,43:1:0 +X 1884 . G <*> 0 . DP=29;I16=14,15,0,0,1036,37926,0,0,1697,101089,0,0,437,9647,0,0;QS=3,0;MQSB=0.947838;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,24,202:8:0 0,3,42:1:0 +X 1885 . C <*> 0 . DP=28;I16=14,13,0,0,925,32305,0,0,1577,93889,0,0,430,9560,0,0;QS=3,0;MQSB=0.951472;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,182:7:0 0,3,42:1:0 +X 1886 . C <*> 0 . DP=26;I16=13,13,0,0,826,27194,0,0,1517,90289,0,0,447,9745,0,0;QS=3,0;MQSB=0.945959;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,166:8:0 0,3,32:1:0 +X 1887 . G <*> 0 . DP=26;I16=12,13,0,0,798,26554,0,0,1500,90000,0,0,428,9212,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,185:8:0 0,3,40:1:0 +X 1888 . C <*> 0 . DP=26;I16=13,13,0,0,901,32343,0,0,1517,90289,0,0,459,9957,0,0;QS=3,0;MQSB=0.945959;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,178:8:0 0,3,39:1:0 +X 1889 . C <*> 0 . DP=25;I16=13,11,0,0,825,29127,0,0,1397,83089,0,0,444,9612,0,0;QS=3,0;MQSB=0.950498;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,187:7:0 0,3,37:1:0 +X 1890 . C <*> 0 . DP=25;I16=13,12,0,0,913,34029,0,0,1457,86689,0,0,471,10173,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,198:8:0 0,3,40:1:0 +X 1891 . T <*> 0 . DP=25;I16=13,12,0,0,912,34028,0,0,1457,86689,0,0,477,10317,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,212:8:0 0,3,39:1:0 +X 1892 . G <*> 0 . DP=25;I16=12,12,0,0,885,33149,0,0,1397,83089,0,0,458,9860,0,0;QS=3,0;MQSB=0.941765;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,166:7:0 0,3,37:1:0 +X 1893 . T <*> 0 . DP=26;I16=14,12,0,0,920,33494,0,0,1517,90289,0,0,489,10677,0,0;QS=3,0;MQSB=0.953497;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,205:8:0 0,6,72:2:0 +X 1894 . G <*> 0 . DP=26;I16=14,12,0,0,934,35048,0,0,1517,90289,0,0,495,10843,0,0;QS=3,0;MQSB=0.953497;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,188:8:0 0,6,75:2:0 +X 1895 . C <*> 0 . DP=26;I16=13,12,0,0,882,31980,0,0,1500,90000,0,0,476,10408,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,24,180:8:0 0,6,73:2:0 +X 1896 . C <*> 0 . DP=26;I16=14,11,0,0,827,28179,0,0,1457,86689,0,0,482,10622,0,0;QS=3,0;MQSB=0.955682;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,154:7:0 0,6,72:2:0 +X 1897 . G <*> 0 . DP=26;I16=13,11,0,0,763,25169,0,0,1397,83089,0,0,486,10856,0,0;QS=3,0;MQSB=0.950498;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,164:7:0 0,3,27:1:0 +X 1898 . T <*> 0 . DP=27;I16=14,11,0,0,846,29526,0,0,1500,90000,0,0,492,11072,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,24,187:8:0 0,6,62:2:0 +X 1899 . G <*> 0 . DP=27;I16=14,11,0,0,875,32007,0,0,1500,90000,0,0,497,11213,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,24,188:8:0 0,6,61:2:0 +X 1900 . T <*> 0 . DP=26;I16=14,11,0,0,850,29882,0,0,1500,90000,0,0,501,11329,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,24,185:8:0 0,6,69:2:0 +X 1901 . A <*> 0 . DP=27;I16=15,10,0,0,842,29298,0,0,1457,86689,0,0,505,11469,0,0;QS=3,0;MQSB=0.962269;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,190:7:0 0,6,68:2:0 +X 1902 . C <*> 0 . DP=27;I16=15,12,0,0,912,31970,0,0,1577,93889,0,0,537,12267,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,184:8:0 0,6,60:2:0 +X 1903 . C <*> 0 . DP=27;I16=15,12,0,0,959,34645,0,0,1577,93889,0,0,542,12462,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,201:8:0 0,6,63:2:0 +X 1904 . T <*> 0 . DP=27;I16=16,11,0,0,1017,38757,0,0,1577,93889,0,0,548,12682,0,0;QS=3,0;MQSB=0.96384;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,221:8:0 0,6,77:2:0 +X 1905 . C <*> 0 . DP=27;I16=16,11,0,0,985,36561,0,0,1577,93889,0,0,553,12827,0,0;QS=3,0;MQSB=0.96384;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,211:8:0 0,6,69:2:0 +X 1906 . T <*> 0 . DP=27;I16=16,11,0,0,1018,39242,0,0,1577,93889,0,0,558,12998,0,0;QS=3,0;MQSB=0.96384;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,207:8:0 0,6,75:2:0 +X 1907 . G <*> 0 . DP=27;I16=15,11,0,0,935,34679,0,0,1517,90289,0,0,535,12419,0,0;QS=3,0;MQSB=0.960078;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,187:7:0 0,6,68:2:0 +X 1908 . A <*> 0 . DP=28;I16=16,12,0,0,1023,38221,0,0,1637,97489,0,0,561,13063,0,0;QS=3,0;MQSB=0.96195;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,24,215:8:0 0,6,67:2:0 +X 1909 . G <*> 0 . DP=27;I16=15,12,0,0,1002,38398,0,0,1577,93889,0,0,561,12953,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,206:8:0 0,6,73:2:0 +X 1910 . C <*> 0 . DP=27;I16=14,10,0,0,855,31251,0,0,1440,86400,0,0,502,11588,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,179:7:0 0,6,71:2:0 +X 1911 . C <*> 0 . DP=27;I16=15,12,0,0,967,35429,0,0,1577,93889,0,0,561,12793,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,206:8:0 0,6,71:2:0 +X 1912 . C <*> 0 . DP=27;I16=15,12,0,0,1024,39272,0,0,1577,93889,0,0,561,12743,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,217:8:0 0,6,73:2:0 +X 1913 . T <*> 0 . DP=27;I16=15,12,0,0,1028,39768,0,0,1577,93889,0,0,561,12713,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,228:8:0 0,6,77:2:0 +X 1914 . C <*> 0 . DP=27;I16=15,12,0,0,1010,38762,0,0,1577,93889,0,0,561,12703,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,221:8:0 0,6,75:2:0 +X 1915 . T C,<*> 0 . DP=27;I16=14,12,1,0,974,37184,16,256,1560,93600,17,289,543,12389,18,324;QS=2.97351,0.0264901,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.958048;BQB=1;MQ0F=0 PL:DP:DV 0,34,255,48,255,255:17:1 0,24,231,24,231,231:8:0 0,6,60,6,60,60:2:0 +X 1916 . G T,<*> 0 . DP=27;I16=14,12,1,0,991,38291,15,225,1560,93600,17,289,544,12454,17,289;QS=2.97581,0.0241935,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.958048;BQB=1;MQ0F=0 PL:DP:DV 0,35,255,48,255,255:17:1 0,24,226,24,226,226:8:0 0,6,69,6,69,69:2:0 +X 1917 . C <*> 0 . DP=27;I16=15,12,0,0,1030,39740,0,0,1577,93889,0,0,561,12793,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,214:8:0 0,6,73:2:0 +X 1918 . A <*> 0 . DP=27;I16=15,11,0,0,963,36201,0,0,1517,90289,0,0,542,12502,0,0;QS=3,0;MQSB=0.960078;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,217:8:0 0,6,72:2:0 +X 1919 . C <*> 0 . DP=27;I16=15,12,0,0,987,36651,0,0,1577,93889,0,0,560,12902,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,214:8:0 0,6,72:2:0 +X 1920 . A T,<*> 0 . DP=29;I16=15,12,0,1,1007,38337,14,196,1546,91130,60,3600,538,12518,21,441;QS=2.97647,0.0235294,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.999735;BQB=1;MQ0F=0 PL:DP:DV 0,36,255,48,255,255:17:1 0,24,225,24,225,225:8:0 0,9,101,9,101,101:3:0 +X 1921 . G <*> 0 . DP=30;I16=15,14,0,0,1059,39815,0,0,1666,98330,0,0,542,12474,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,182:7:0 0,12,132:4:0 +X 1922 . T <*> 0 . DP=29;I16=14,14,0,0,1013,37513,0,0,1649,98041,0,0,532,12418,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,197:7:0 0,12,134:4:0 +X 1923 . G <*> 0 . DP=28;I16=14,14,0,0,1034,38974,0,0,1606,94730,0,0,545,12629,0,0;QS=3,0;MQSB=0.999736;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,188:7:0 0,12,126:4:0 +X 1924 . C <*> 0 . DP=27;I16=13,13,0,0,965,36587,0,0,1486,87530,0,0,521,12017,0,0;QS=3,0;MQSB=0.999671;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,183:7:0 0,12,116:4:0 +X 1925 . C <*> 0 . DP=27;I16=14,13,0,0,987,37021,0,0,1546,91130,0,0,546,12626,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,187:7:0 0,12,124:4:0 +X 1926 . T <*> 0 . DP=27;I16=14,13,0,0,1031,40057,0,0,1546,91130,0,0,545,12581,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,197:7:0 0,12,141:4:0 +X 1927 . T <*> 0 . DP=27;I16=13,13,0,0,959,35773,0,0,1529,90841,0,0,538,12522,0,0;QS=3,0;MQSB=0.945959;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,191:7:0 0,12,133:4:0 +X 1928 . C <*> 0 . DP=27;I16=13,13,0,0,986,38264,0,0,1529,90841,0,0,538,12532,0,0;QS=3,0;MQSB=0.945959;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,189:7:0 0,12,125:4:0 +X 1929 . T <*> 0 . DP=27;I16=13,13,0,0,990,38630,0,0,1529,90841,0,0,538,12562,0,0;QS=3,0;MQSB=0.945959;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,189:7:0 0,12,139:4:0 +X 1930 . G <*> 0 . DP=26;I16=13,11,0,0,905,34865,0,0,1409,83641,0,0,521,12271,0,0;QS=3,0;MQSB=0.931547;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,179:6:0 0,9,99:3:0 +X 1931 . C <*> 0 . DP=27;I16=15,12,0,0,967,36293,0,0,1546,91130,0,0,540,12578,0,0;QS=3,0;MQSB=0.99881;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,165:6:0 0,12,121:4:0 +X 1932 . T <*> 0 . DP=27;I16=14,13,0,0,998,38154,0,0,1546,91130,0,0,541,12605,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,143:5:0 0,15,146:5:0 +X 1933 . T <*> 0 . DP=27;I16=14,13,0,0,962,35344,0,0,1546,91130,0,0,542,12602,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,142:5:0 0,15,158:5:0 +X 1934 . G <*> 0 . DP=27;I16=13,13,0,0,987,38219,0,0,1529,90841,0,0,543,12569,0,0;QS=3,0;MQSB=0.945959;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,134:5:0 0,15,143:5:0 +X 1935 . C <*> 0 . DP=27;I16=14,12,0,0,963,36627,0,0,1529,90841,0,0,520,11930,0,0;QS=3,0;MQSB=0.937241;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,162:6:0 0,15,154:5:0 +X 1936 . C <*> 0 . DP=27;I16=14,13,0,0,1018,39406,0,0,1589,94441,0,0,547,12561,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,177:6:0 0,15,159:5:0 +X 1937 . T <*> 0 . DP=27;I16=14,13,0,0,1036,40636,0,0,1589,94441,0,0,547,12489,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,182:6:0 0,15,170:5:0 +X 1938 . G <*> 0 . DP=27;I16=14,13,0,0,1001,38377,0,0,1589,94441,0,0,546,12392,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,166:6:0 0,15,155:5:0 +X 1939 . T <*> 0 . DP=27;I16=14,12,0,0,964,36430,0,0,1560,93600,0,0,525,11909,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,167:6:0 0,12,144:4:0 +X 1940 . G <*> 0 . DP=27;I16=14,13,0,0,1003,37937,0,0,1589,94441,0,0,542,12172,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,159:6:0 0,15,155:5:0 +X 1941 . G <*> 0 . DP=27;I16=14,13,0,0,1004,38072,0,0,1589,94441,0,0,540,12098,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,176:6:0 0,15,156:5:0 +X 1942 . C <*> 0 . DP=27;I16=14,12,0,0,996,38790,0,0,1560,93600,0,0,516,11564,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,174:6:0 0,12,140:4:0 +X 1943 . T <*> 0 . DP=27;I16=14,13,0,0,1044,40952,0,0,1589,94441,0,0,536,12022,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,184:6:0 0,15,167:5:0 +X 1944 . T <*> 0 . DP=27;I16=14,13,0,0,987,37237,0,0,1589,94441,0,0,533,11971,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,175:6:0 0,15,170:5:0 +X 1945 . T <*> 0 . DP=27;I16=14,13,0,0,993,37067,0,0,1589,94441,0,0,530,11946,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,174:6:0 0,15,171:5:0 +X 1946 . G <*> 0 . DP=27;I16=14,13,0,0,1013,38617,0,0,1589,94441,0,0,526,11896,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,162:6:0 0,15,162:5:0 +X 1947 . A <*> 0 . DP=26;I16=13,13,0,0,950,35522,0,0,1529,90841,0,0,522,11818,0,0;QS=3,0;MQSB=0.945959;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,167:6:0 0,15,160:5:0 +X 1948 . G C,<*> 0 . DP=27;I16=14,12,0,1,966,36912,16,256,1560,93600,29,841,493,11135,25,625;QS=2.90361,0.0963855,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.94394;BQB=1;MQ0F=0 PL:DP:DV 0,45,255,45,255,255:15:0 0,21,190,21,190,190:7:0 1,0,123,13,126,132:5:1 +X 1949 . A <*> 0 . DP=26;I16=14,11,0,0,871,31325,0,0,1469,87241,0,0,490,11048,0,0;QS=3,0;MQSB=0.929204;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,174:7:0 0,15,155:5:0 +X 1950 . A <*> 0 . DP=27;I16=14,13,0,0,1007,38049,0,0,1589,94441,0,0,511,11559,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,21,205:7:0 0,18,176:6:0 +X 1951 . G <*> 0 . DP=27;I16=14,13,0,0,960,35536,0,0,1589,94441,0,0,509,11469,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,21,180:7:0 0,18,181:6:0 +X 1952 . A <*> 0 . DP=27;I16=14,12,0,0,924,33366,0,0,1529,90841,0,0,483,10779,0,0;QS=3,0;MQSB=0.937241;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,184:7:0 0,18,182:6:0 +X 1953 . A <*> 0 . DP=28;I16=15,12,0,0,925,32719,0,0,1589,94441,0,0,482,10740,0,0;QS=3,0;MQSB=0.935229;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,21,189:7:0 0,18,168:6:0 +X 1954 . A C,<*> 0 . DP=29;I16=14,13,0,1,929,33219,18,324,1620,97200,29,841,475,10679,25,625;QS=2.90217,0.0978261,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.949591;BQB=1;MQ0F=0 PL:DP:DV 0,45,255,45,255,255:15:0 0,21,198,21,198,198:7:0 0,0,130,15,133,141:6:1 +X 1955 . C <*> 0 . DP=29;I16=14,12,0,0,961,36067,0,0,1560,93600,0,0,451,10035,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,21,206:7:0 0,15,165:5:0 +X 1956 . C <*> 0 . DP=29;I16=14,13,0,0,964,35402,0,0,1620,97200,0,0,475,10573,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,196:7:0 0,15,164:5:0 +X 1957 . C <*> 0 . DP=29;I16=14,13,0,0,980,36212,0,0,1620,97200,0,0,472,10420,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,183:7:0 0,15,167:5:0 +X 1958 . C <*> 0 . DP=29;I16=15,13,0,0,1003,37293,0,0,1649,98041,0,0,493,10825,0,0;QS=3,0;MQSB=0.942064;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,191:7:0 0,18,190:6:0 +X 1959 . T <*> 0 . DP=29;I16=16,13,0,0,1112,43258,0,0,1709,101641,0,0,491,10593,0,0;QS=3,0;MQSB=0.940317;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,213:7:0 0,18,193:6:0 +X 1960 . T <*> 0 . DP=30;I16=17,13,0,0,1053,37939,0,0,1769,105241,0,0,485,10339,0,0;QS=3,0;MQSB=0.938685;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,196:7:0 0,18,186:6:0 +X 1961 . C <*> 0 . DP=30;I16=17,13,0,0,1101,41737,0,0,1769,105241,0,0,480,10122,0,0;QS=3,0;MQSB=0.938685;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,195:7:0 0,18,183:6:0 +X 1962 . T <*> 0 . DP=29;I16=17,12,0,0,1134,44582,0,0,1709,101641,0,0,477,9941,0,0;QS=3,0;MQSB=0.931617;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,208:7:0 0,18,198:6:0 +X 1963 . G <*> 0 . DP=28;I16=16,12,0,0,1066,41050,0,0,1649,98041,0,0,476,9794,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,192:7:0 0,18,188:6:0 +X 1964 . G <*> 0 . DP=28;I16=16,12,0,0,970,34764,0,0,1649,98041,0,0,475,9681,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,178:7:0 0,18,169:6:0 +X 1965 . T <*> 0 . DP=29;I16=16,12,0,0,964,34772,0,0,1649,98041,0,0,449,8977,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,196:7:0 0,18,171:6:0 +X 1966 . T <*> 0 . DP=29;I16=16,13,0,0,1029,37027,0,0,1709,101641,0,0,474,9558,0,0;QS=3,0;MQSB=0.940317;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,191:7:0 0,18,181:6:0 +X 1967 . A <*> 0 . DP=29;I16=16,13,0,0,1030,37234,0,0,1709,101641,0,0,474,9550,0,0;QS=3,0;MQSB=0.940317;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,187:7:0 0,18,182:6:0 +X 1968 . T <*> 0 . DP=29;I16=16,13,0,0,1075,40173,0,0,1709,101641,0,0,474,9578,0,0;QS=3,0;MQSB=0.940317;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,195:7:0 0,18,190:6:0 +X 1969 . A <*> 0 . DP=28;I16=16,12,0,0,992,35828,0,0,1649,98041,0,0,474,9592,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,175:6:0 0,18,186:6:0 +X 1970 . C <*> 0 . DP=28;I16=16,12,0,0,1015,37503,0,0,1649,98041,0,0,474,9642,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,170:6:0 0,18,180:6:0 +X 1971 . A <*> 0 . DP=29;I16=16,13,0,0,1073,40273,0,0,1709,101641,0,0,474,9728,0,0;QS=3,0;MQSB=0.940317;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,178:6:0 0,21,206:7:0 +X 1972 . T <*> 0 . DP=30;I16=16,14,0,0,1068,38978,0,0,1769,105241,0,0,475,9851,0,0;QS=3,0;MQSB=0.946202;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,176:6:0 0,21,203:7:0 +X 1973 . A <*> 0 . DP=30;I16=16,13,0,0,1046,38070,0,0,1740,104400,0,0,452,9388,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,172:6:0 0,18,196:6:0 +X 1974 . A <*> 0 . DP=29;I16=16,13,0,0,1086,41474,0,0,1709,101641,0,0,477,10065,0,0;QS=3,0;MQSB=0.940317;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,157:5:0 0,21,214:7:0 +X 1975 . G <*> 0 . DP=28;I16=16,12,0,0,1067,41171,0,0,1649,98041,0,0,478,10156,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,133:4:0 0,21,195:7:0 +X 1976 . A <*> 0 . DP=28;I16=16,12,0,0,981,34839,0,0,1649,98041,0,0,478,10234,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,125:4:0 0,21,199:7:0 +X 1977 . C <*> 0 . DP=28;I16=16,12,0,0,1009,37471,0,0,1649,98041,0,0,477,10297,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,132:4:0 0,21,194:7:0 +X 1978 . A <*> 0 . DP=28;I16=16,12,0,0,1082,42132,0,0,1649,98041,0,0,476,10394,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,144:4:0 0,21,220:7:0 +X 1979 . G <*> 0 . DP=28;I16=16,11,0,0,1019,38927,0,0,1589,94441,0,0,454,10064,0,0;QS=3,0;MQSB=0.925036;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,122:4:0 0,21,208:7:0 +X 1980 . C <*> 0 . DP=27;I16=16,10,0,0,932,34456,0,0,1529,90841,0,0,452,10114,0,0;QS=3,0;MQSB=0.914947;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,107:3:0 0,21,197:7:0 +X 1981 . C <*> 0 . DP=28;I16=16,12,0,0,998,36510,0,0,1649,98041,0,0,469,10479,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,9,101:3:0 0,24,219:8:0 +X 1982 . A <*> 0 . DP=29;I16=16,12,0,0,1035,38815,0,0,1649,98041,0,0,472,10548,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,110:3:0 0,27,254:9:0 +X 1983 . G <*> 0 . DP=28;I16=16,12,0,0,1048,40322,0,0,1649,98041,0,0,477,10599,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,96:3:0 0,27,249:9:0 +X 1984 . A <*> 0 . DP=27;I16=16,11,0,0,1024,39232,0,0,1589,94441,0,0,482,10632,0,0;QS=3,0;MQSB=0.925036;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,70:2:0 0,27,255:9:0 +X 1985 . G <*> 0 . DP=27;I16=16,11,0,0,1009,38449,0,0,1589,94441,0,0,487,10695,0,0;QS=3,0;MQSB=0.925036;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,66:2:0 0,27,231:9:0 +X 1986 . A <*> 0 . DP=27;I16=16,10,0,0,926,33696,0,0,1560,93600,0,0,466,10112,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,76:2:0 0,24,223:8:0 +X 1987 . A <*> 0 . DP=28;I16=17,11,0,0,1034,39088,0,0,1649,98041,0,0,495,10807,0,0;QS=3,0;MQSB=0.923174;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,78:2:0 0,27,247:9:0 +X 1988 . G <*> 0 . DP=28;I16=17,11,0,0,1050,39980,0,0,1649,98041,0,0,499,10855,0,0;QS=3,0;MQSB=0.923174;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,63:2:0 0,27,239:9:0 +X 1989 . G <*> 0 . DP=28;I16=17,10,0,0,994,37610,0,0,1589,94441,0,0,493,10801,0,0;QS=3,0;MQSB=0.912952;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,73:2:0 0,27,237:9:0 +X 1990 . G T,<*> 0 . DP=28;I16=17,9,0,1,965,36359,33,1089,1560,93600,29,841,472,10250,25,625;QS=2.90675,0.0932476,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.912952;BQB=1;MQ0F=0 PL:DP:DV 0,48,255,48,255,255:16:0 0,6,71,6,71,71:2:0 2,0,195,26,198,215:9:1 +X 1991 . A <*> 0 . DP=28;I16=17,11,0,0,1017,38203,0,0,1649,98041,0,0,507,10975,0,0;QS=3,0;MQSB=0.923174;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,60:2:0 0,27,250:9:0 +X 1992 . G <*> 0 . DP=28;I16=17,11,0,0,1028,38852,0,0,1649,98041,0,0,509,11039,0,0;QS=3,0;MQSB=0.923174;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,62:2:0 0,27,231:9:0 +X 1993 . T <*> 0 . DP=28;I16=17,11,0,0,1015,37325,0,0,1649,98041,0,0,511,11131,0,0;QS=3,0;MQSB=0.923174;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,59:2:0 0,27,243:9:0 +X 1994 . T <*> 0 . DP=27;I16=16,11,0,0,942,33698,0,0,1589,94441,0,0,514,11250,0,0;QS=3,0;MQSB=0.925036;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,54:2:0 0,24,216:8:0 +X 1995 . G <*> 0 . DP=28;I16=16,11,0,0,960,35432,0,0,1620,97200,0,0,492,10770,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,66:2:0 0,21,188:7:0 +X 1996 . C <*> 0 . DP=29;I16=17,12,0,0,1022,37426,0,0,1709,101641,0,0,519,11469,0,0;QS=3,0;MQSB=0.931617;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,64:2:0 0,24,192:8:0 +X 1997 . C <*> 0 . DP=29;I16=17,11,0,0,934,32858,0,0,1649,98041,0,0,520,11524,0,0;QS=3,0;MQSB=0.923174;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,70:2:0 0,24,193:8:0 +X 1998 . C <*> 0 . DP=29;I16=17,12,0,0,1027,37843,0,0,1709,101641,0,0,522,11562,0,0;QS=3,0;MQSB=0.931617;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,69:2:0 0,24,222:8:0 +X 1999 . A <*> 0 . DP=28;I16=17,11,0,0,1073,41493,0,0,1649,98041,0,0,525,11627,0,0;QS=3,0;MQSB=0.923174;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,72:2:0 0,21,206:7:0 +X 2000 . G <*> 0 . DP=28;I16=16,11,0,0,1036,40576,0,0,1589,94441,0,0,511,11395,0,0;QS=3,0;MQSB=0.925036;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,72:2:0 0,18,168:6:0 +X 2001 . G <*> 0 . DP=28;I16=15,11,0,0,955,35661,0,0,1529,90841,0,0,489,10853,0,0;QS=3,0;MQSB=0.927041;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,62:2:0 0,18,172:6:0 +X 2002 . G <*> 0 . DP=28;I16=17,10,0,0,907,32227,0,0,1620,97200,0,0,519,11663,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,53:2:0 0,18,163:6:0 +X 2003 . T <*> 0 . DP=28;I16=17,11,0,0,920,31866,0,0,1649,98041,0,0,541,12163,0,0;QS=3,0;MQSB=0.923174;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,49:2:0 0,21,190:7:0 +X 2004 . G <*> 0 . DP=27;I16=16,10,0,0,970,36928,0,0,1560,93600,0,0,530,12110,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,57:2:0 0,18,178:6:0 +X 2005 . G <*> 0 . DP=27;I16=16,10,0,0,868,30936,0,0,1560,93600,0,0,536,12370,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,59:2:0 0,18,153:6:0 +X 2006 . C <*> 0 . DP=27;I16=16,10,0,0,968,37046,0,0,1560,93600,0,0,541,12605,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,73:2:0 0,18,166:6:0 +X 2007 . A <*> 0 . DP=27;I16=16,11,0,0,1000,37396,0,0,1589,94441,0,0,556,12882,0,0;QS=3,0;MQSB=0.925036;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,76:2:0 0,21,193:7:0 +X 2008 . C <*> 0 . DP=26;I16=16,10,0,0,964,36892,0,0,1529,90841,0,0,555,12833,0,0;QS=3,0;MQSB=0.914947;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,73:2:0 0,21,183:7:0 +X 2009 . A <*> 0 . DP=26;I16=16,10,0,0,997,38955,0,0,1529,90841,0,0,554,12802,0,0;QS=3,0;MQSB=0.914947;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,74:2:0 0,21,210:7:0 +X 2010 . G <*> 0 . DP=26;I16=16,9,0,0,936,36208,0,0,1500,90000,0,0,542,12640,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,73:2:0 0,18,169:6:0 +X 2011 . C <*> 0 . DP=26;I16=16,9,0,0,966,37960,0,0,1500,90000,0,0,541,12617,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,74:2:0 0,18,175:6:0 +X 2012 . A <*> 0 . DP=27;I16=16,11,0,0,956,35018,0,0,1589,94441,0,0,548,12676,0,0;QS=3,0;MQSB=0.925036;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,74:2:0 0,21,189:7:0 +X 2013 . C <*> 0 . DP=27;I16=15,10,0,0,876,31370,0,0,1500,90000,0,0,514,11950,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,69:2:0 0,18,160:6:0 +X 2014 . G <*> 0 . DP=27;I16=17,10,0,0,903,31239,0,0,1589,94441,0,0,545,12591,0,0;QS=3,0;MQSB=0.912952;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,9,80:3:0 0,18,160:6:0 +X 2015 . T <*> 0 . DP=27;I16=17,10,0,0,999,37507,0,0,1589,94441,0,0,545,12577,0,0;QS=3,0;MQSB=0.912952;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,9,95:3:0 0,18,178:6:0 +X 2016 . T <*> 0 . DP=27;I16=17,10,0,0,971,35649,0,0,1589,94441,0,0,545,12583,0,0;QS=3,0;MQSB=0.912952;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,9,93:3:0 0,18,178:6:0 +X 2017 . G <*> 0 . DP=28;I16=17,11,0,0,1013,37849,0,0,1649,98041,0,0,545,12609,0,0;QS=3,0;MQSB=0.923174;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,9,91:3:0 0,18,172:6:0 +X 2018 . C <*> 0 . DP=28;I16=17,11,0,0,1060,41414,0,0,1649,98041,0,0,546,12656,0,0;QS=3,0;MQSB=0.923174;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,9,97:3:0 0,18,169:6:0 +X 2019 . T <*> 0 . DP=28;I16=17,11,0,0,1083,42253,0,0,1649,98041,0,0,547,12725,0,0;QS=3,0;MQSB=0.923174;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,9,106:3:0 0,18,187:6:0 +X 2020 . G <*> 0 . DP=29;I16=18,11,0,0,1095,42063,0,0,1678,98882,0,0,548,12816,0,0;QS=3,0;MQSB=0.987702;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,9,85:3:0 0,18,175:6:0 +X 2021 . C <*> 0 . DP=29;I16=18,11,0,0,1081,41535,0,0,1709,101641,0,0,551,12877,0,0;QS=3,0;MQSB=0.969907;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,9,97:3:0 0,15,167:5:0 +X 2022 . C <*> 0 . DP=30;I16=19,11,0,0,1115,42003,0,0,1769,105241,0,0,555,12907,0,0;QS=3,0;MQSB=0.972375;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,9,92:3:0 0,18,177:6:0 +X 2023 . A <*> 0 . DP=30;I16=19,10,0,0,1063,39991,0,0,1709,101641,0,0,549,12837,0,0;QS=3,0;MQSB=0.974027;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,9,96:3:0 0,18,186:6:0 +X 2024 . G <*> 0 . DP=32;I16=20,12,0,0,1168,43872,0,0,1889,112441,0,0,564,12982,0,0;QS=3,0;MQSB=0.973096;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,9,92:3:0 0,24,203:8:0 +X 2025 . T <*> 0 . DP=32;I16=20,12,0,0,1150,42122,0,0,1889,112441,0,0,569,12981,0,0;QS=3,0;MQSB=0.973096;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,9,87:3:0 0,24,226:8:0 +X 2026 . T <*> 0 . DP=32;I16=20,12,0,0,1130,40724,0,0,1889,112441,0,0,572,12908,0,0;QS=3,0;MQSB=0.973096;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,9,94:3:0 0,24,208:8:0 +X 2027 . A <*> 0 . DP=32;I16=19,12,0,0,1121,40871,0,0,1829,108841,0,0,550,12240,0,0;QS=3,0;MQSB=0.970829;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,9,84:3:0 0,21,207:7:0 +X 2028 . C <*> 0 . DP=32;I16=20,12,0,0,1242,48548,0,0,1889,112441,0,0,577,12803,0,0;QS=3,0;MQSB=0.973096;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,9,94:3:0 0,24,228:8:0 +X 2029 . T <*> 0 . DP=32;I16=20,12,0,0,1229,47605,0,0,1889,112441,0,0,578,12724,0,0;QS=3,0;MQSB=0.973096;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,9,102:3:0 0,24,236:8:0 +X 2030 . G <*> 0 . DP=32;I16=20,12,0,0,1222,47140,0,0,1889,112441,0,0,579,12679,0,0;QS=3,0;MQSB=0.973096;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,9,93:3:0 0,24,216:8:0 +X 2031 . C <*> 0 . DP=31;I16=19,12,0,0,1150,43656,0,0,1829,108841,0,0,581,12667,0,0;QS=3,0;MQSB=0.970829;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,9,96:3:0 0,24,204:8:0 +X 2032 . C <*> 0 . DP=31;I16=19,12,0,0,1157,44035,0,0,1829,108841,0,0,583,12687,0,0;QS=3,0;MQSB=0.970829;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,9,90:3:0 0,24,210:8:0 +X 2033 . A <*> 0 . DP=30;I16=19,11,0,0,1091,40223,0,0,1769,105241,0,0,585,12689,0,0;QS=3,0;MQSB=0.972375;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,9,93:3:0 0,21,203:7:0 +X 2034 . T <*> 0 . DP=30;I16=19,11,0,0,1104,41498,0,0,1769,105241,0,0,587,12723,0,0;QS=3,0;MQSB=0.972375;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,9,91:3:0 0,21,208:7:0 +X 2035 . T <*> 0 . DP=29;I16=18,11,0,0,1084,41024,0,0,1709,101641,0,0,589,12739,0,0;QS=3,0;MQSB=0.969907;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,6,69:2:0 0,21,211:7:0 +X 2036 . T <*> 0 . DP=29;I16=18,11,0,0,1080,40612,0,0,1709,101641,0,0,591,12787,0,0;QS=3,0;MQSB=0.969907;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,6,67:2:0 0,21,216:7:0 +X 2037 . T <*> 0 . DP=29;I16=18,11,0,0,1082,40956,0,0,1709,101641,0,0,592,12818,0,0;QS=3,0;MQSB=0.969907;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,6,69:2:0 0,21,217:7:0 +X 2038 . C <*> 0 . DP=29;I16=18,11,0,0,1117,43573,0,0,1709,101641,0,0,592,12832,0,0;QS=3,0;MQSB=0.969907;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,6,69:2:0 0,21,211:7:0 +X 2039 . A <*> 0 . DP=29;I16=18,11,0,0,1067,39581,0,0,1709,101641,0,0,592,12878,0,0;QS=3,0;MQSB=0.969907;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,6,72:2:0 0,21,212:7:0 +X 2040 . C <*> 0 . DP=29;I16=18,11,0,0,1077,40469,0,0,1709,101641,0,0,590,12856,0,0;QS=3,0;MQSB=0.969907;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,6,69:2:0 0,21,196:7:0 +X 2041 . G A,<*> 0 . DP=31;I16=6,5,12,7,389,14023,721,28149,660,39600,1109,65641,235,5607,353,7259;QS=0.917304,2.0827,0;VDB=0.816435;SGB=-4.18892;RPB=0.88473;MQB=0.972375;MQSB=0.968257;BQB=0.311275;MQ0F=0 PL:DP:DV 229,0,212,255,245,255:21:11 32,0,24,35,27,59:2:1 223,21,0,223,21,223:7:7 +X 2042 . G <*> 0 . DP=32;I16=18,14,0,0,1189,45617,0,0,1889,112441,0,0,588,12910,0,0;QS=3,0;MQSB=0.965264;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,9,86:3:0 0,21,206:7:0 +X 2043 . G <*> 0 . DP=32;I16=17,14,0,0,1115,41585,0,0,1829,108841,0,0,581,12891,0,0;QS=3,0;MQSB=0.962133;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,9,90:3:0 0,21,197:7:0 +X 2044 . C <*> 0 . DP=32;I16=18,14,0,0,1213,47029,0,0,1889,112441,0,0,588,13006,0,0;QS=3,0;MQSB=0.965264;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,9,85:3:0 0,21,207:7:0 +X 2045 . A <*> 0 . DP=32;I16=18,14,0,0,1181,44527,0,0,1889,112441,0,0,588,13108,0,0;QS=3,0;MQSB=0.965264;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,9,83:3:0 0,21,213:7:0 +X 2046 . T <*> 0 . DP=32;I16=18,14,0,0,1197,45135,0,0,1889,112441,0,0,587,13195,0,0;QS=3,0;MQSB=0.965264;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,9,103:3:0 0,21,216:7:0 +X 2047 . G <*> 0 . DP=34;I16=17,16,0,0,1248,47798,0,0,1949,116041,0,0,557,12491,0,0;QS=3,0;MQSB=0.959328;MQ0F=0 PL:DP:DV 0,72,255:24:0 0,9,88:3:0 0,18,195:6:0 +X 2048 . A <*> 0 . DP=34;I16=18,16,0,0,1230,45184,0,0,2009,119641,0,0,578,13022,0,0;QS=3,0;MQSB=0.962621;MQ0F=0 PL:DP:DV 0,72,255:24:0 0,9,87:3:0 0,21,206:7:0 +X 2049 . A <*> 0 . DP=33;I16=17,16,0,0,1207,44567,0,0,1949,116041,0,0,575,12963,0,0;QS=3,0;MQSB=0.959328;MQ0F=0 PL:DP:DV 0,72,255:24:0 0,6,74:2:0 0,21,208:7:0 +X 2050 . A <*> 0 . DP=33;I16=16,16,0,0,1169,43313,0,0,1889,112441,0,0,545,12211,0,0;QS=3,0;MQSB=0.955563;MQ0F=0 PL:DP:DV 0,72,255:24:0 0,6,77:2:0 0,18,188:6:0 +X 2051 . T <*> 0 . DP=31;I16=16,15,0,0,1134,42164,0,0,1829,108841,0,0,567,12737,0,0;QS=3,0;MQSB=0.957006;MQ0F=0 PL:DP:DV 0,69,255:23:0 0,6,69:2:0 0,18,170:6:0 +X 2052 . G <*> 0 . DP=31;I16=16,15,0,0,1180,45546,0,0,1829,108841,0,0,564,12664,0,0;QS=3,0;MQSB=0.957006;MQ0F=0 PL:DP:DV 0,69,255:23:0 0,6,74:2:0 0,18,175:6:0 +X 2053 . G T,<*> 0 . DP=31;I16=15,15,0,1,1126,42672,23,529,1769,105241,60,3600,537,11991,25,625;QS=2.97307,0.0269321,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.951229;BQB=1;MQ0F=0 PL:DP:DV 0,46,255,66,255,255:23:1 0,6,71,6,71,71:2:0 0,18,180,18,180,180:6:0 +X 2054 . A <*> 0 . DP=30;I16=15,15,0,0,1123,43027,0,0,1769,105241,0,0,562,12592,0,0;QS=3,0;MQSB=0.952765;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,6,78:2:0 0,18,171:6:0 +X 2055 . G <*> 0 . DP=30;I16=15,15,0,0,1156,45206,0,0,1769,105241,0,0,562,12592,0,0;QS=3,0;MQSB=0.952765;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,6,66:2:0 0,18,168:6:0 +X 2056 . A <*> 0 . DP=30;I16=15,15,0,0,1124,42416,0,0,1769,105241,0,0,560,12518,0,0;QS=3,0;MQSB=0.952765;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,6,71:2:0 0,18,179:6:0 +X 2057 . T <*> 0 . DP=30;I16=15,15,0,0,1094,40082,0,0,1769,105241,0,0,556,12374,0,0;QS=3,0;MQSB=0.952765;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,6,72:2:0 0,18,178:6:0 +X 2058 . A <*> 0 . DP=29;I16=14,15,0,0,1035,37517,0,0,1709,101641,0,0,552,12212,0,0;QS=3,0;MQSB=0.947838;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,6,57:2:0 0,18,179:6:0 +X 2059 . A <*> 0 . DP=29;I16=14,15,0,0,1063,39615,0,0,1709,101641,0,0,548,12082,0,0;QS=3,0;MQSB=0.947838;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,6,66:2:0 0,18,188:6:0 +X 2060 . C <*> 0 . DP=28;I16=12,15,0,0,1015,39057,0,0,1589,94441,0,0,523,11499,0,0;QS=3,0;MQSB=0.935229;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,6,62:2:0 0,15,143:5:0 +X 2061 . A <*> 0 . DP=27;I16=12,14,0,0,950,35084,0,0,1529,90841,0,0,501,11073,0,0;QS=3,0;MQSB=0.937241;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,3,41:1:0 0,15,163:5:0 +X 2062 . A <*> 0 . DP=26;I16=11,15,0,0,973,37349,0,0,1529,90841,0,0,519,11425,0,0;QS=3,0;MQSB=0.927041;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,57:2:0 0,15,164:5:0 +X 2063 . C <*> 0 . DP=26;I16=11,15,0,0,1017,40149,0,0,1529,90841,0,0,517,11405,0,0;QS=3,0;MQSB=0.927041;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,74:2:0 0,15,158:5:0 +X 2064 . A <*> 0 . DP=26;I16=11,15,0,0,1002,38980,0,0,1529,90841,0,0,515,11413,0,0;QS=3,0;MQSB=0.927041;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,75:2:0 0,15,164:5:0 +X 2065 . G <*> 0 . DP=26;I16=12,14,0,0,1030,41232,0,0,1529,90841,0,0,514,11448,0,0;QS=3,0;MQSB=0.937241;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,78:2:0 0,18,167:6:0 +X 2066 . G <*> 0 . DP=26;I16=12,14,0,0,973,37055,0,0,1529,90841,0,0,514,11510,0,0;QS=3,0;MQSB=0.937241;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,75:2:0 0,18,152:6:0 +X 2067 . A <*> 0 . DP=26;I16=12,14,0,0,1005,39095,0,0,1529,90841,0,0,512,11498,0,0;QS=3,0;MQSB=0.937241;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,69:2:0 0,18,187:6:0 +X 2068 . G <*> 0 . DP=26;I16=12,14,0,0,993,39005,0,0,1529,90841,0,0,509,11459,0,0;QS=3,0;MQSB=0.937241;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,53:2:0 0,18,167:6:0 +X 2069 . C <*> 0 . DP=26;I16=12,14,0,0,873,29879,0,0,1529,90841,0,0,506,11442,0,0;QS=3,0;MQSB=0.937241;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,59:2:0 0,18,156:6:0 +X 2070 . G <*> 0 . DP=27;I16=13,14,0,0,932,33090,0,0,1589,94441,0,0,502,11398,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,62:2:0 0,18,145:6:0 +X 2071 . A <*> 0 . DP=27;I16=13,14,0,0,946,33884,0,0,1589,94441,0,0,498,11330,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,53:2:0 0,18,177:6:0 +X 2072 . C <*> 0 . DP=25;I16=13,12,0,0,897,32897,0,0,1469,87241,0,0,496,11288,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,59:2:0 0,15,128:5:0 +X 2073 . C <*> 0 . DP=26;I16=14,12,0,0,874,30184,0,0,1529,90841,0,0,492,11168,0,0;QS=3,0;MQSB=0.953497;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,53:2:0 0,15,133:5:0 +X 2074 . G <*> 0 . DP=26;I16=13,12,0,0,835,29219,0,0,1469,87241,0,0,463,10395,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,67:2:0 0,12,83:4:0 +X 2075 . C <*> 0 . DP=27;I16=15,12,0,0,989,37027,0,0,1589,94441,0,0,484,10896,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,6,69:2:0 0,15,115:5:0 +X 2076 . A <*> 0 . DP=27;I16=14,12,0,0,929,33551,0,0,1529,90841,0,0,470,10676,0,0;QS=3,0;MQSB=0.953497;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,6,76:2:0 0,12,114:4:0 +X 2077 . C <*> 0 . DP=27;I16=15,12,0,0,990,37252,0,0,1589,94441,0,0,478,10724,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,6,65:2:0 0,15,125:5:0 +X 2078 . A <*> 0 . DP=27;I16=15,12,0,0,1023,39089,0,0,1589,94441,0,0,475,10677,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,6,72:2:0 0,15,148:5:0 +X 2079 . G <*> 0 . DP=28;I16=15,13,0,0,1042,39694,0,0,1649,98041,0,0,471,10605,0,0;QS=3,0;MQSB=0.956162;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,6,72:2:0 0,15,133:5:0 +X 2080 . G <*> 0 . DP=28;I16=14,13,0,0,968,35328,0,0,1589,94441,0,0,453,10333,0,0;QS=3,0;MQSB=0.951472;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,6,67:2:0 0,12,108:4:0 +X 2081 . C <*> 0 . DP=26;I16=14,12,0,0,937,35303,0,0,1529,90841,0,0,467,10535,0,0;QS=3,0;MQSB=0.953497;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,63:2:0 0,15,110:5:0 +X 2082 . T <*> 0 . DP=24;I16=12,12,0,0,901,34287,0,0,1409,83641,0,0,468,10532,0,0;QS=3,0;MQSB=0.941765;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,71:2:0 0,12,112:4:0 +X 2083 . G <*> 0 . DP=24;I16=12,12,0,0,887,33597,0,0,1409,83641,0,0,469,10547,0,0;QS=3,0;MQSB=0.941765;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,68:2:0 0,12,113:4:0 +X 2084 . C <*> 0 . DP=25;I16=13,12,0,0,938,35868,0,0,1469,87241,0,0,470,10580,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,61:2:0 0,12,115:4:0 +X 2085 . T <*> 0 . DP=25;I16=13,12,0,0,932,35282,0,0,1469,87241,0,0,472,10632,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,64:2:0 0,12,130:4:0 +X 2086 . G <*> 0 . DP=25;I16=13,12,0,0,932,35400,0,0,1469,87241,0,0,474,10704,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,61:2:0 0,12,129:4:0 +X 2087 . A <*> 0 . DP=24;I16=12,12,0,0,903,34391,0,0,1409,83641,0,0,476,10746,0,0;QS=3,0;MQSB=0.941765;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,66:2:0 0,12,126:4:0 +X 2088 . G <*> 0 . DP=24;I16=12,12,0,0,880,33116,0,0,1409,83641,0,0,478,10808,0,0;QS=3,0;MQSB=0.941765;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,70:2:0 0,12,121:4:0 +X 2089 . C <*> 0 . DP=25;I16=13,12,0,0,817,27419,0,0,1469,87241,0,0,480,10890,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,64:2:0 0,15,138:5:0 +X 2090 . G <*> 0 . DP=25;I16=12,12,0,0,802,27940,0,0,1409,83641,0,0,457,10319,0,0;QS=3,0;MQSB=0.941765;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,63:2:0 0,12,99:4:0 +X 2091 . C <*> 0 . DP=25;I16=12,12,0,0,800,27346,0,0,1440,86400,0,0,458,10346,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,61:2:0 0,15,125:5:0 +X 2092 . G <*> 0 . DP=26;I16=13,12,0,0,838,29188,0,0,1469,87241,0,0,461,10487,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,64:2:0 0,18,133:6:0 +X 2093 . T G,<*> 0 . DP=26;I16=13,12,1,0,905,33415,17,289,1500,90000,29,841,459,10371,25,625;QS=2.97424,0.0257576,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.953497;BQB=1;MQ0F=0 PL:DP:DV 0,36,255,51,255,255:18:1 0,6,67,6,67,67:2:0 0,18,153,18,153,153:6:0 +X 2094 . C <*> 0 . DP=26;I16=14,12,0,0,949,35501,0,0,1529,90841,0,0,485,11047,0,0;QS=3,0;MQSB=0.953497;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,69:2:0 0,18,142:6:0 +X 2095 . A <*> 0 . DP=25;I16=14,11,0,0,879,31219,0,0,1469,87241,0,0,487,11123,0,0;QS=3,0;MQSB=0.955682;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,72:2:0 0,18,154:6:0 +X 2096 . C <*> 0 . DP=24;I16=13,11,0,0,878,32734,0,0,1409,83641,0,0,487,11073,0,0;QS=3,0;MQSB=0.950498;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,65:2:0 0,18,161:6:0 +X 2097 . A <*> 0 . DP=24;I16=13,11,0,0,849,30671,0,0,1409,83641,0,0,487,11047,0,0;QS=3,0;MQSB=0.950498;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,56:2:0 0,18,172:6:0 +X 2098 . C <*> 0 . DP=24;I16=13,11,0,0,781,26113,0,0,1409,83641,0,0,486,10996,0,0;QS=3,0;MQSB=0.950498;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,58:2:0 0,18,139:6:0 +X 2099 . G <*> 0 . DP=23;I16=12,10,0,0,719,25109,0,0,1289,76441,0,0,460,10294,0,0;QS=3,0;MQSB=0.947103;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,3,24:1:0 0,18,129:6:0 +X 2100 . C <*> 0 . DP=25;I16=13,11,0,0,873,32759,0,0,1409,83641,0,0,457,10141,0,0;QS=3,0;MQSB=0.950498;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,87:3:0 0,18,160:6:0 +X 2101 . A <*> 0 . DP=25;I16=12,12,0,0,907,34671,0,0,1440,86400,0,0,455,9965,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,135:4:0 0,18,161:6:0 +X 2102 . G <*> 0 . DP=25;I16=13,12,0,0,930,35596,0,0,1469,87241,0,0,478,10442,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,118:4:0 0,18,151:6:0 +X 2103 . C <*> 0 . DP=25;I16=11,12,0,0,842,31630,0,0,1380,82800,0,0,432,9336,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,106:4:0 0,15,146:5:0 +X 2104 . C <*> 0 . DP=24;I16=12,12,0,0,869,32463,0,0,1409,83641,0,0,454,9810,0,0;QS=3,0;MQSB=0.941765;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,126:4:0 0,15,147:5:0 +X 2105 . A <*> 0 . DP=25;I16=11,12,0,0,836,30696,0,0,1380,82800,0,0,429,9201,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,138:4:0 0,15,130:5:0 +X 2106 . T <*> 0 . DP=25;I16=12,13,0,0,897,33087,0,0,1469,87241,0,0,473,10211,0,0;QS=3,0;MQSB=0.939413;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,129:4:0 0,15,146:5:0 +X 2107 . C <*> 0 . DP=25;I16=11,12,0,0,783,27185,0,0,1380,82800,0,0,425,9113,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,100:3:0 0,15,133:5:0 +X 2108 . G <*> 0 . DP=25;I16=11,13,0,0,829,29703,0,0,1440,86400,0,0,448,9730,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,122:4:0 0,15,111:5:0 +X 2109 . C <*> 0 . DP=25;I16=11,13,0,0,781,26717,0,0,1440,86400,0,0,446,9746,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,109:4:0 0,15,125:5:0 +X 2110 . G <*> 0 . DP=25;I16=12,12,0,0,804,28134,0,0,1440,86400,0,0,418,9110,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,92:3:0 0,15,117:5:0 +X 2111 . C <*> 0 . DP=25;I16=12,13,0,0,925,35081,0,0,1500,90000,0,0,441,9747,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,134:4:0 0,15,140:5:0 +X 2112 . A <*> 0 . DP=24;I16=12,12,0,0,885,33445,0,0,1440,86400,0,0,440,9782,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,129:4:0 0,15,140:5:0 +X 2113 . G <*> 0 . DP=24;I16=12,12,0,0,871,32641,0,0,1440,86400,0,0,439,9839,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,128:4:0 0,15,134:5:0 +X 2114 . C <*> 0 . DP=24;I16=12,11,0,0,844,32052,0,0,1380,82800,0,0,413,9293,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,103:3:0 0,15,126:5:0 +X 2115 . T <*> 0 . DP=23;I16=11,11,0,0,821,30869,0,0,1320,79200,0,0,412,9342,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,78:2:0 0,15,143:5:0 +X 2116 . C <*> 0 . DP=23;I16=11,12,0,0,890,34892,0,0,1380,82800,0,0,435,9985,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,102:3:0 0,15,152:5:0 +X 2117 . A <*> 0 . DP=23;I16=11,11,0,0,833,32121,0,0,1320,79200,0,0,432,9924,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,118:3:0 0,15,156:5:0 +X 2118 . G <*> 0 . DP=23;I16=12,11,0,0,842,31502,0,0,1380,82800,0,0,429,9835,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,125:4:0 0,15,147:5:0 +X 2119 . G <*> 0 . DP=23;I16=12,11,0,0,823,30553,0,0,1380,82800,0,0,426,9768,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,135:4:0 0,15,137:5:0 +X 2120 . G <*> 0 . DP=24;I16=13,11,0,0,864,32028,0,0,1440,86400,0,0,423,9723,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,137:4:0 0,15,140:5:0 +X 2121 . A <*> 0 . DP=22;I16=11,10,0,0,734,26712,0,0,1260,75600,0,0,398,9074,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,135:4:0 0,12,122:4:0 +X 2122 . T <*> 0 . DP=22;I16=11,10,0,0,752,27278,0,0,1260,75600,0,0,396,8972,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,136:4:0 0,12,123:4:0 +X 2123 . A <*> 0 . DP=22;I16=12,10,0,0,758,27024,0,0,1320,79200,0,0,419,9519,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,120:4:0 0,15,137:5:0 +X 2124 . T <*> 0 . DP=22;I16=12,10,0,0,789,28741,0,0,1320,79200,0,0,417,9465,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,128:4:0 0,15,136:5:0 +X 2125 . T <*> 0 . DP=20;I16=11,8,0,0,696,25704,0,0,1140,68400,0,0,401,9177,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,106:3:0 0,9,93:3:0 +X 2126 . A <*> 0 . DP=20;I16=11,9,0,0,717,25979,0,0,1200,72000,0,0,415,9319,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,133:4:0 0,9,95:3:0 +X 2127 . C <*> 0 . DP=21;I16=11,10,0,0,706,24426,0,0,1260,75600,0,0,413,9221,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,107:4:0 0,9,95:3:0 +X 2128 . G <*> 0 . DP=21;I16=11,10,0,0,677,22633,0,0,1260,75600,0,0,411,9091,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,116:4:0 0,9,72:3:0 +X 2129 . T <*> 0 . DP=21;I16=11,10,0,0,782,29386,0,0,1260,75600,0,0,409,8981,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,140:4:0 0,9,83:3:0 +X 2130 . G <*> 0 . DP=21;I16=11,10,0,0,766,28562,0,0,1260,75600,0,0,407,8891,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,135:4:0 0,9,87:3:0 +X 2131 . T <*> 0 . DP=21;I16=11,10,0,0,732,26216,0,0,1260,75600,0,0,405,8821,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,136:4:0 0,9,79:3:0 +X 2132 . A <*> 0 . DP=21;I16=11,10,0,0,743,26733,0,0,1260,75600,0,0,403,8771,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,135:4:0 0,9,88:3:0 +X 2133 . A <*> 0 . DP=21;I16=11,10,0,0,787,29651,0,0,1260,75600,0,0,401,8741,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,141:4:0 0,9,96:3:0 +X 2134 . C <*> 0 . DP=21;I16=11,10,0,0,804,31100,0,0,1260,75600,0,0,399,8731,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,138:4:0 0,9,86:3:0 +X 2135 . T <*> 0 . DP=22;I16=11,11,0,0,831,32197,0,0,1320,79200,0,0,397,8741,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,153:4:0 0,12,119:4:0 +X 2136 . C <*> 0 . DP=22;I16=11,11,0,0,760,26892,0,0,1320,79200,0,0,395,8721,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,124:4:0 0,12,127:4:0 +X 2137 . G <*> 0 . DP=22;I16=11,11,0,0,745,26047,0,0,1320,79200,0,0,393,8721,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,121:4:0 0,12,102:4:0 +X 2138 . A <*> 0 . DP=22;I16=11,11,0,0,816,30934,0,0,1320,79200,0,0,391,8741,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,128:4:0 0,12,139:4:0 +X 2139 . C <*> 0 . DP=22;I16=11,11,0,0,839,32237,0,0,1320,79200,0,0,389,8781,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,138:4:0 0,12,125:4:0 +X 2140 . A <*> 0 . DP=22;I16=11,11,0,0,826,31300,0,0,1320,79200,0,0,387,8841,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,140:4:0 0,12,138:4:0 +X 2141 . T <*> 0 . DP=21;I16=11,10,0,0,792,30156,0,0,1260,75600,0,0,385,8871,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,137:4:0 0,12,137:4:0 +X 2142 . G <*> 0 . DP=19;I16=11,8,0,0,724,27784,0,0,1140,68400,0,0,385,8919,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,113:3:0 0,12,129:4:0 +X 2143 . T <*> 0 . DP=19;I16=11,8,0,0,650,23454,0,0,1140,68400,0,0,384,8932,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,113:3:0 0,12,120:4:0 +X 2144 . C <*> 0 . DP=19;I16=11,8,0,0,739,29003,0,0,1140,68400,0,0,383,8959,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,108:3:0 0,12,125:4:0 +X 2145 . A <*> 0 . DP=20;I16=12,8,0,0,760,29304,0,0,1200,72000,0,0,381,8951,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,133:4:0 0,12,139:4:0 +X 2146 . G <*> 0 . DP=20;I16=12,8,0,0,745,28105,0,0,1200,72000,0,0,379,8909,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,139:4:0 0,12,127:4:0 +X 2147 . C <*> 0 . DP=20;I16=13,6,0,0,674,24296,0,0,1140,68400,0,0,379,8881,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,127:4:0 0,12,130:4:0 +X 2148 . G <*> 0 . DP=20;I16=12,7,0,0,630,21274,0,0,1140,68400,0,0,365,8537,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,250:11:0 0,12,112:4:0 0,12,120:4:0 +X 2149 . A <*> 0 . DP=20;I16=12,7,0,0,702,26212,0,0,1140,68400,0,0,367,8529,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,138:4:0 0,12,127:4:0 +X 2150 . T <*> 0 . DP=20;I16=13,7,0,0,675,23943,0,0,1200,72000,0,0,383,8713,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,247:11:0 0,12,138:4:0 0,15,139:5:0 +X 2151 . T <*> 0 . DP=20;I16=13,7,0,0,690,24274,0,0,1200,72000,0,0,383,8661,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,251:11:0 0,12,133:4:0 0,15,142:5:0 +X 2152 . G <*> 0 . DP=20;I16=13,7,0,0,693,24713,0,0,1200,72000,0,0,383,8629,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,131:4:0 0,15,146:5:0 +X 2153 . T <*> 0 . DP=19;I16=13,6,0,0,671,24571,0,0,1140,68400,0,0,383,8565,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,230:10:0 0,12,134:4:0 0,15,162:5:0 +X 2154 . C <*> 0 . DP=19;I16=13,6,0,0,703,26955,0,0,1140,68400,0,0,382,8468,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,251:10:0 0,12,131:4:0 0,15,159:5:0 +X 2155 . A <*> 0 . DP=19;I16=13,6,0,0,693,25727,0,0,1140,68400,0,0,381,8389,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,245:10:0 0,12,135:4:0 0,15,156:5:0 +X 2156 . C <*> 0 . DP=19;I16=13,6,0,0,702,26214,0,0,1140,68400,0,0,380,8328,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,125:4:0 0,15,154:5:0 +X 2157 . A <*> 0 . DP=19;I16=13,6,0,0,722,28058,0,0,1140,68400,0,0,379,8285,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,250:10:0 0,12,141:4:0 0,15,173:5:0 +X 2158 . G <*> 0 . DP=19;I16=13,6,0,0,713,27567,0,0,1140,68400,0,0,378,8260,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,136:4:0 0,15,144:5:0 +X 2159 . G <*> 0 . DP=19;I16=12,6,0,0,662,24744,0,0,1080,64800,0,0,366,8104,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,247:9:0 0,12,126:4:0 0,15,153:5:0 +X 2160 . C <*> 0 . DP=19;I16=12,6,0,0,651,24005,0,0,1080,64800,0,0,364,8038,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,244:9:0 0,12,119:4:0 0,15,154:5:0 +X 2161 . A <*> 0 . DP=19;I16=13,6,0,0,695,25883,0,0,1140,68400,0,0,369,8005,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,248:10:0 0,12,121:4:0 0,15,164:5:0 +X 2162 . C <*> 0 . DP=20;I16=13,7,0,0,742,27834,0,0,1200,72000,0,0,365,7911,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,127:4:0 0,15,155:5:0 +X 2163 . T <*> 0 . DP=20;I16=13,7,0,0,763,29517,0,0,1200,72000,0,0,362,7838,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,131:4:0 0,15,175:5:0 +X 2164 . G <*> 0 . DP=20;I16=13,7,0,0,715,26301,0,0,1200,72000,0,0,359,7787,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,116:4:0 0,15,156:5:0 +X 2165 . C <*> 0 . DP=20;I16=13,7,0,0,753,28781,0,0,1200,72000,0,0,355,7709,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,136:4:0 0,15,151:5:0 +X 2166 . T <*> 0 . DP=19;I16=12,7,0,0,711,27211,0,0,1140,68400,0,0,352,7654,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,142:4:0 0,12,140:4:0 +X 2167 . A <*> 0 . DP=19;I16=12,6,0,0,650,23760,0,0,1080,64800,0,0,327,7137,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,254:11:0 0,12,133:4:0 0,9,111:3:0 +X 2168 . C <*> 0 . DP=19;I16=12,7,0,0,685,25039,0,0,1140,68400,0,0,345,7561,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,130:4:0 0,12,124:4:0 +X 2169 . T <*> 0 . DP=19;I16=12,7,0,0,702,26940,0,0,1140,68400,0,0,341,7525,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,140:4:0 0,12,142:4:0 +X 2170 . C <*> 0 . DP=18;I16=11,7,0,0,665,24861,0,0,1080,64800,0,0,338,7512,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,132:4:0 0,12,135:4:0 +X 2171 . C <*> 0 . DP=20;I16=11,9,0,0,750,28368,0,0,1200,72000,0,0,333,7419,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,136:4:0 0,12,138:4:0 +X 2172 . T <*> 0 . DP=20;I16=11,9,0,0,732,27540,0,0,1200,72000,0,0,330,7346,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,149:4:0 0,12,147:4:0 +X 2173 . G <*> 0 . DP=19;I16=10,9,0,0,704,26534,0,0,1140,68400,0,0,327,7243,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,142:4:0 0,12,133:4:0 +X 2174 . G <*> 0 . DP=19;I16=10,9,0,0,674,24372,0,0,1140,68400,0,0,324,7158,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,126:4:0 0,12,129:4:0 +X 2175 . G <*> 0 . DP=18;I16=9,9,0,0,639,23059,0,0,1080,64800,0,0,322,7090,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,123:4:0 0,12,126:4:0 +X 2176 . G <*> 0 . DP=18;I16=9,9,0,0,621,21815,0,0,1080,64800,0,0,318,6940,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,247:10:0 0,12,121:4:0 0,12,123:4:0 +X 2177 . T <*> 0 . DP=18;I16=9,9,0,0,547,18051,0,0,1080,64800,0,0,314,6810,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,239:10:0 0,12,83:4:0 0,12,108:4:0 +X 2178 . T <*> 0 . DP=18;I16=9,9,0,0,579,19659,0,0,1080,64800,0,0,310,6700,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,234:10:0 0,12,110:4:0 0,12,118:4:0 +X 2179 . T <*> 0 . DP=18;I16=9,9,0,0,591,20403,0,0,1080,64800,0,0,307,6609,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,239:10:0 0,12,97:4:0 0,12,135:4:0 +X 2180 . T <*> 0 . DP=18;I16=9,9,0,0,616,21524,0,0,1080,64800,0,0,305,6537,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,236:10:0 0,12,122:4:0 0,12,133:4:0 +X 2181 . C <*> 0 . DP=18;I16=9,8,0,0,611,22485,0,0,1020,61200,0,0,293,6385,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,224:9:0 0,12,129:4:0 0,12,150:4:0 +X 2182 . C <*> 0 . DP=18;I16=9,9,0,0,665,24877,0,0,1080,64800,0,0,301,6453,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,125:4:0 0,12,145:4:0 +X 2183 . A <*> 0 . DP=18;I16=9,9,0,0,646,23624,0,0,1080,64800,0,0,299,6441,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,247:10:0 0,12,123:4:0 0,12,144:4:0 +X 2184 . T <*> 0 . DP=17;I16=8,9,0,0,610,22250,0,0,1020,61200,0,0,298,6448,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,224:9:0 0,12,134:4:0 0,12,136:4:0 +X 2185 . C <*> 0 . DP=16;I16=8,8,0,0,569,20761,0,0,960,57600,0,0,297,6423,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,211:8:0 0,12,128:4:0 0,12,137:4:0 +X 2186 . A <*> 0 . DP=16;I16=8,8,0,0,576,21314,0,0,960,57600,0,0,296,6416,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,204:8:0 0,12,134:4:0 0,12,145:4:0 +X 2187 . A <*> 0 . DP=16;I16=8,8,0,0,562,20396,0,0,960,57600,0,0,295,6427,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,201:8:0 0,12,136:4:0 0,12,135:4:0 +X 2188 . A <*> 0 . DP=17;I16=9,8,0,0,569,19925,0,0,1020,61200,0,0,293,6405,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,214:9:0 0,12,133:4:0 0,12,123:4:0 +X 2189 . C <*> 0 . DP=19;I16=9,10,0,0,645,22647,0,0,1097,65089,0,0,292,6400,0,0;QS=3,0;MQSB=0.934728;MQ0F=0 PL:DP:DV 0,30,230:10:0 0,12,133:4:0 0,15,142:5:0 +X 2190 . C <*> 0 . DP=19;I16=9,10,0,0,604,20072,0,0,1097,65089,0,0,294,6414,0,0;QS=3,0;MQSB=0.934728;MQ0F=0 PL:DP:DV 0,33,238:11:0 0,12,119:4:0 0,12,107:4:0 +X 2191 . C <*> 0 . DP=19;I16=9,10,0,0,647,23007,0,0,1097,65089,0,0,297,6449,0,0;QS=3,0;MQSB=0.934728;MQ0F=0 PL:DP:DV 0,33,251:11:0 0,12,129:4:0 0,12,119:4:0 +X 2192 . T <*> 0 . DP=19;I16=9,10,0,0,659,23723,0,0,1097,65089,0,0,300,6506,0,0;QS=3,0;MQSB=0.934728;MQ0F=0 PL:DP:DV 0,33,253:11:0 0,12,136:4:0 0,12,120:4:0 +X 2193 . C <*> 0 . DP=18;I16=8,10,0,0,642,23934,0,0,1037,61489,0,0,303,6535,0,0;QS=3,0;MQSB=0.938795;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,128:4:0 0,9,87:3:0 +X 2194 . A <*> 0 . DP=18;I16=8,9,0,0,617,22683,0,0,1020,61200,0,0,301,6561,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,247:10:0 0,12,134:4:0 0,9,98:3:0 +X 2195 . A <*> 0 . DP=18;I16=8,10,0,0,635,23271,0,0,1037,61489,0,0,309,6659,0,0;QS=3,0;MQSB=0.938795;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,128:4:0 0,9,101:3:0 +X 2196 . G <*> 0 . DP=19;I16=8,11,0,0,703,26383,0,0,1097,65089,0,0,312,6754,0,0;QS=3,0;MQSB=0.946915;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,117:4:0 0,12,120:4:0 +X 2197 . A <*> 0 . DP=19;I16=8,11,0,0,735,28599,0,0,1097,65089,0,0,314,6770,0,0;QS=3,0;MQSB=0.946915;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,141:4:0 0,12,125:4:0 +X 2198 . G <*> 0 . DP=19;I16=8,10,0,0,650,24206,0,0,1080,64800,0,0,307,6725,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,129:4:0 0,12,107:4:0 +X 2199 . C <*> 0 . DP=19;I16=8,11,0,0,701,26735,0,0,1097,65089,0,0,318,6862,0,0;QS=3,0;MQSB=0.946915;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,128:4:0 0,12,116:4:0 +X 2200 . T <*> 0 . DP=19;I16=8,11,0,0,710,26768,0,0,1097,65089,0,0,320,6938,0,0;QS=3,0;MQSB=0.946915;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,129:4:0 0,12,114:4:0 +X 2201 . G <*> 0 . DP=17;I16=7,10,0,0,628,23764,0,0,977,57889,0,0,324,7032,0,0;QS=3,0;MQSB=0.943335;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,66:2:0 0,12,119:4:0 +X 2202 . G <*> 0 . DP=17;I16=7,10,0,0,557,19249,0,0,977,57889,0,0,327,7093,0,0;QS=3,0;MQSB=0.943335;MQ0F=0 PL:DP:DV 0,33,245:11:0 0,6,57:2:0 0,12,115:4:0 +X 2203 . G <*> 0 . DP=17;I16=7,10,0,0,588,21184,0,0,977,57889,0,0,329,7123,0,0;QS=3,0;MQSB=0.943335;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,47:2:0 0,12,116:4:0 +X 2204 . C <*> 0 . DP=17;I16=7,10,0,0,538,18568,0,0,977,57889,0,0,331,7173,0,0;QS=3,0;MQSB=0.943335;MQ0F=0 PL:DP:DV 0,33,246:11:0 0,6,61:2:0 0,12,99:4:0 +X 2205 . C <*> 0 . DP=18;I16=7,11,0,0,628,22918,0,0,1037,61489,0,0,332,7192,0,0;QS=3,0;MQSB=0.951002;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,68:2:0 0,12,109:4:0 +X 2206 . T <*> 0 . DP=19;I16=7,12,0,0,677,25237,0,0,1097,65089,0,0,334,7230,0,0;QS=3,0;MQSB=0.957193;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,77:2:0 0,12,115:4:0 +X 2207 . G <*> 0 . DP=19;I16=7,11,0,0,663,24717,0,0,1080,64800,0,0,319,6965,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,67:2:0 0,12,110:4:0 +X 2208 . G <*> 0 . DP=21;I16=7,14,0,0,726,26038,0,0,1217,72289,0,0,340,7370,0,0;QS=3,0;MQSB=0.966484;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,110:4:0 0,12,122:4:0 +X 2209 . G <*> 0 . DP=22;I16=8,13,0,0,715,25133,0,0,1237,73369,0,0,325,7075,0,0;QS=3,0;MQSB=0.895122;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,128:5:0 0,12,117:4:0 +X 2210 . G C,<*> 0 . DP=21;I16=7,13,0,1,648,22186,25,625,1177,69769,17,289,331,7165,21,441;QS=2.95442,0.0455764,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.975265;BQB=1;MQ0F=0 PL:DP:DV 0,19,234,33,237,241:12:1 0,15,127,15,127,127:5:0 0,12,113,12,113,113:4:0 +X 2211 . T <*> 0 . DP=21;I16=7,13,0,0,724,27000,0,0,1177,69769,0,0,336,7230,0,0;QS=3,0;MQSB=0.875769;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,141:5:0 0,12,124:4:0 +X 2212 . C <*> 0 . DP=22;I16=8,14,0,0,791,29201,0,0,1254,73658,0,0,364,7850,0,0;QS=3,0;MQSB=0.985548;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,148:5:0 0,12,111:4:0 +X 2213 . A <*> 0 . DP=22;I16=8,14,0,0,767,27327,0,0,1254,73658,0,0,371,8015,0,0;QS=3,0;MQSB=0.985548;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,153:5:0 0,12,112:4:0 +X 2214 . A <*> 0 . DP=22;I16=8,14,0,0,756,26836,0,0,1254,73658,0,0,377,8159,0,0;QS=3,0;MQSB=0.985548;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,153:5:0 0,12,117:4:0 +X 2215 . C <*> 0 . DP=22;I16=8,14,0,0,815,31121,0,0,1254,73658,0,0,381,8229,0,0;QS=3,0;MQSB=0.985548;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,162:5:0 0,12,124:4:0 +X 2216 . T <*> 0 . DP=22;I16=8,14,0,0,815,31233,0,0,1254,73658,0,0,384,8272,0,0;QS=3,0;MQSB=0.985548;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,166:5:0 0,12,124:4:0 +X 2217 . T <*> 0 . DP=22;I16=8,13,0,0,741,26855,0,0,1237,73369,0,0,362,7712,0,0;QS=3,0;MQSB=0.895122;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,155:5:0 0,12,118:4:0 +X 2218 . C <*> 0 . DP=21;I16=7,14,0,0,753,27973,0,0,1194,70058,0,0,391,8423,0,0;QS=3,0;MQSB=0.975265;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,138:4:0 0,12,119:4:0 +X 2219 . C <*> 0 . DP=21;I16=7,13,0,0,757,29125,0,0,1177,69769,0,0,370,7904,0,0;QS=3,0;MQSB=0.875769;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,141:4:0 0,12,122:4:0 +X 2220 . G A,<*> 0 . DP=21;I16=6,2,1,11,256,8364,474,19128,457,26569,720,43200,141,2959,233,5071;QS=0.886504,2.1135,0;VDB=0.532753;SGB=-3.51597;RPB=0.964198;MQB=0.898397;MQSB=0.875769;BQB=0.0354359;MQ0F=0 PL:DP:DV 139,0,130,157,148,255:12:6 69,0,46,75,52,119:4:2 131,12,0,131,12,131:4:4 +X 2221 . G <*> 0 . DP=21;I16=7,13,0,0,738,27922,0,0,1177,69769,0,0,376,8078,0,0;QS=3,0;MQSB=0.875769;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,132:4:0 0,12,120:4:0 +X 2222 . C <*> 0 . DP=21;I16=7,14,0,0,746,28098,0,0,1194,70058,0,0,401,8675,0,0;QS=3,0;MQSB=0.975265;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,135:4:0 0,12,107:4:0 +X 2223 . C <*> 0 . DP=21;I16=7,14,0,0,796,30632,0,0,1194,70058,0,0,401,8671,0,0;QS=3,0;MQSB=0.975265;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,135:4:0 0,12,122:4:0 +X 2224 . T <*> 0 . DP=21;I16=7,14,0,0,811,31599,0,0,1194,70058,0,0,401,8691,0,0;QS=3,0;MQSB=0.975265;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,144:4:0 0,12,123:4:0 +X 2225 . G <*> 0 . DP=21;I16=7,14,0,0,778,29396,0,0,1194,70058,0,0,401,8735,0,0;QS=3,0;MQSB=0.975265;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,133:4:0 0,12,121:4:0 +X 2226 . G <*> 0 . DP=21;I16=7,14,0,0,727,26485,0,0,1194,70058,0,0,401,8803,0,0;QS=3,0;MQSB=0.975265;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,128:4:0 0,12,113:4:0 +X 2227 . G <*> 0 . DP=20;I16=7,12,0,0,663,23985,0,0,1117,66169,0,0,377,8269,0,0;QS=3,0;MQSB=0.879351;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,123:4:0 0,12,114:4:0 +X 2228 . G C,<*> 0 . DP=19;I16=5,12,0,1,643,24791,16,256,1020,61200,17,289,360,8020,25,625;QS=2.9603,0.0397022,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.970092;BQB=1;MQ0F=0 PL:DP:DV 0,17,255,30,255,255:11:1 0,9,95,9,95,95:3:0 0,12,121,12,121,121:4:0 +X 2229 . A <*> 0 . DP=20;I16=6,14,0,0,757,28857,0,0,1134,66458,0,0,406,9138,0,0;QS=3,0;MQSB=0.959189;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,138:4:0 0,12,122:4:0 +X 2230 . A <*> 0 . DP=20;I16=6,14,0,0,729,26985,0,0,1134,66458,0,0,409,9291,0,0;QS=3,0;MQSB=0.959189;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,141:4:0 0,12,119:4:0 +X 2231 . A <*> 0 . DP=20;I16=6,13,0,0,712,26990,0,0,1117,66169,0,0,386,8790,0,0;QS=3,0;MQSB=0.850016;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,144:4:0 0,12,124:4:0 +X 2232 . C <*> 0 . DP=20;I16=6,14,0,0,751,28657,0,0,1134,66458,0,0,412,9508,0,0;QS=3,0;MQSB=0.959189;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,130:4:0 0,12,107:4:0 +X 2233 . T <*> 0 . DP=20;I16=6,14,0,0,774,30432,0,0,1134,66458,0,0,413,9619,0,0;QS=3,0;MQSB=0.959189;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,150:4:0 0,12,117:4:0 +X 2234 . G <*> 0 . DP=20;I16=6,14,0,0,719,26621,0,0,1134,66458,0,0,412,9646,0,0;QS=3,0;MQSB=0.959189;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,145:4:0 0,12,107:4:0 +X 2235 . G <*> 0 . DP=20;I16=6,14,0,0,728,27036,0,0,1134,66458,0,0,410,9636,0,0;QS=3,0;MQSB=0.959189;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,139:4:0 0,12,104:4:0 +X 2236 . G <*> 0 . DP=19;I16=6,13,0,0,705,26985,0,0,1074,62858,0,0,409,9637,0,0;QS=3,0;MQSB=0.965977;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,142:4:0 0,9,84:3:0 +X 2237 . G <*> 0 . DP=19;I16=6,12,0,0,684,26576,0,0,1057,62569,0,0,383,9023,0,0;QS=3,0;MQSB=0.85394;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,141:4:0 0,9,86:3:0 +X 2238 . C <*> 0 . DP=19;I16=5,13,0,0,648,24496,0,0,1037,61489,0,0,381,8993,0,0;QS=3,0;MQSB=0.970092;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,108:3:0 0,9,78:3:0 +X 2239 . A <*> 0 . DP=19;I16=6,11,0,0,634,24178,0,0,997,58969,0,0,373,8935,0,0;QS=3,0;MQSB=0.85832;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,133:4:0 0,6,77:2:0 +X 2240 . A <*> 0 . DP=19;I16=6,13,0,0,731,28595,0,0,1074,62858,0,0,402,9582,0,0;QS=3,0;MQSB=0.965977;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,135:4:0 0,9,101:3:0 +X 2241 . G <*> 0 . DP=19;I16=6,12,0,0,683,26433,0,0,1057,62569,0,0,375,8951,0,0;QS=3,0;MQSB=0.85394;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,126:4:0 0,9,88:3:0 +X 2242 . T <*> 0 . DP=20;I16=5,13,0,0,635,22949,0,0,1057,62569,0,0,370,8944,0,0;QS=3,0;MQSB=0.814433;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,91:3:0 0,9,95:3:0 +X 2243 . A <*> 0 . DP=19;I16=5,14,0,0,704,26274,0,0,1074,62858,0,0,395,9585,0,0;QS=3,0;MQSB=0.933727;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,107:3:0 0,9,99:3:0 +X 2244 . T <*> 0 . DP=19;I16=5,14,0,0,681,25263,0,0,1074,62858,0,0,395,9609,0,0;QS=3,0;MQSB=0.933727;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,89:3:0 0,9,98:3:0 +X 2245 . C <*> 0 . DP=19;I16=5,14,0,0,722,27846,0,0,1074,62858,0,0,394,9592,0,0;QS=3,0;MQSB=0.933727;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,98:3:0 0,9,88:3:0 +X 2246 . A <*> 0 . DP=18;I16=5,12,0,0,597,21693,0,0,997,58969,0,0,367,8861,0,0;QS=3,0;MQSB=0.818731;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,95:3:0 0,6,72:2:0 +X 2247 . C <*> 0 . DP=17;I16=4,13,0,0,639,24373,0,0,954,55658,0,0,391,9391,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,105:3:0 0,6,71:2:0 +X 2248 . C <*> 0 . DP=17;I16=4,13,0,0,669,26863,0,0,954,55658,0,0,390,9306,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,90:3:0 0,6,75:2:0 +X 2249 . A <*> 0 . DP=17;I16=4,13,0,0,677,27371,0,0,954,55658,0,0,389,9231,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,116:3:0 0,6,80:2:0 +X 2250 . G <*> 0 . DP=17;I16=4,13,0,0,654,25800,0,0,954,55658,0,0,388,9166,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,100:3:0 0,6,78:2:0 +X 2251 . A <*> 0 . DP=17;I16=4,13,0,0,673,27327,0,0,954,55658,0,0,387,9111,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,112:3:0 0,6,80:2:0 +X 2252 . G <*> 0 . DP=17;I16=4,12,0,0,647,26249,0,0,937,55369,0,0,361,8441,0,0;QS=3,0;MQSB=0.767432;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,113:3:0 0,6,73:2:0 +X 2253 . A <*> 0 . DP=17;I16=4,13,0,0,641,24643,0,0,954,55658,0,0,385,9031,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,111:3:0 0,6,73:2:0 +X 2254 . T <*> 0 . DP=17;I16=4,12,0,0,615,23821,0,0,937,55369,0,0,358,8332,0,0;QS=3,0;MQSB=0.767432;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,112:3:0 0,6,73:2:0 +X 2255 . G <*> 0 . DP=17;I16=4,13,0,0,677,27243,0,0,954,55658,0,0,380,8844,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,115:3:0 0,6,71:2:0 +X 2256 . A <*> 0 . DP=17;I16=4,13,0,0,656,26088,0,0,954,55658,0,0,377,8741,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,110:3:0 0,6,78:2:0 +X 2257 . G <*> 0 . DP=17;I16=4,12,0,0,627,24863,0,0,937,55369,0,0,349,8023,0,0;QS=3,0;MQSB=0.767432;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,115:3:0 0,6,74:2:0 +X 2258 . C <*> 0 . DP=17;I16=4,13,0,0,667,26403,0,0,954,55658,0,0,371,8565,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,109:3:0 0,6,70:2:0 +X 2259 . T <*> 0 . DP=17;I16=4,13,0,0,646,25334,0,0,954,55658,0,0,368,8492,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,116:3:0 0,6,79:2:0 +X 2260 . T <*> 0 . DP=17;I16=4,13,0,0,638,24178,0,0,954,55658,0,0,365,8429,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,115:3:0 0,6,72:2:0 +X 2261 . T <*> 0 . DP=17;I16=4,13,0,0,633,23799,0,0,954,55658,0,0,362,8376,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,105:3:0 0,6,73:2:0 +X 2262 . A <*> 0 . DP=17;I16=4,13,0,0,628,23438,0,0,954,55658,0,0,359,8333,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,36,253:12:0 0,9,112:3:0 0,6,74:2:0 +X 2263 . T <*> 0 . DP=17;I16=4,13,0,0,631,23673,0,0,954,55658,0,0,355,8251,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,112:3:0 0,6,74:2:0 +X 2264 . A <*> 0 . DP=17;I16=4,12,0,0,623,24371,0,0,937,55369,0,0,326,7556,0,0;QS=3,0;MQSB=0.767432;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,114:3:0 0,6,75:2:0 +X 2265 . A <*> 0 . DP=18;I16=4,13,0,0,642,24718,0,0,997,58969,0,0,320,7400,0,0;QS=3,0;MQSB=0.762744;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,113:3:0 0,6,75:2:0 +X 2266 . A <*> 0 . DP=19;I16=5,14,0,0,656,23962,0,0,1074,62858,0,0,337,7745,0,0;QS=3,0;MQSB=0.933727;MQ0F=0 PL:DP:DV 0,39,252:13:0 0,12,128:4:0 0,6,75:2:0 +X 2267 . A <*> 0 . DP=20;I16=6,14,0,0,712,26052,0,0,1134,66458,0,0,332,7582,0,0;QS=3,0;MQSB=0.959189;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,134:4:0 0,9,102:3:0 +X 2268 . A <*> 0 . DP=20;I16=6,14,0,0,741,27841,0,0,1134,66458,0,0,327,7391,0,0;QS=3,0;MQSB=0.959189;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,135:4:0 0,9,100:3:0 +X 2269 . T <*> 0 . DP=20;I16=6,13,0,0,681,24751,0,0,1074,62858,0,0,318,7206,0,0;QS=3,0;MQSB=0.965977;MQ0F=0 PL:DP:DV 0,36,246:12:0 0,12,137:4:0 0,9,111:3:0 +X 2270 . A <*> 0 . DP=19;I16=6,12,0,0,652,24154,0,0,1057,62569,0,0,300,6750,0,0;QS=3,0;MQSB=0.85394;MQ0F=0 PL:DP:DV 0,33,244:11:0 0,12,134:4:0 0,9,112:3:0 +X 2271 . A <*> 0 . DP=17;I16=6,11,0,0,654,25406,0,0,954,55658,0,0,316,6944,0,0;QS=3,0;MQSB=0.980001;MQ0F=0 PL:DP:DV 0,30,243:10:0 0,12,142:4:0 0,9,111:3:0 +X 2272 . T <*> 0 . DP=17;I16=6,10,0,0,604,22908,0,0,937,55369,0,0,297,6525,0,0;QS=3,0;MQSB=0.863243;MQ0F=0 PL:DP:DV 0,27,238:9:0 0,12,137:4:0 0,9,111:3:0 +X 2273 . G <*> 0 . DP=17;I16=6,10,0,0,581,22129,0,0,937,55369,0,0,295,6411,0,0;QS=3,0;MQSB=0.863243;MQ0F=0 PL:DP:DV 0,27,240:9:0 0,12,123:4:0 0,9,115:3:0 +X 2274 . G <*> 0 . DP=18;I16=6,11,0,0,621,23109,0,0,997,58969,0,0,293,6313,0,0;QS=3,0;MQSB=0.85832;MQ0F=0 PL:DP:DV 0,30,248:10:0 0,12,132:4:0 0,9,110:3:0 +X 2275 . T <*> 0 . DP=18;I16=6,11,0,0,624,23152,0,0,997,58969,0,0,292,6232,0,0;QS=3,0;MQSB=0.85832;MQ0F=0 PL:DP:DV 0,30,249:10:0 0,12,126:4:0 0,9,113:3:0 +X 2276 . G <*> 0 . DP=20;I16=7,12,0,0,710,26848,0,0,1074,62858,0,0,303,6313,0,0;QS=3,0;MQSB=0.985816;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,129:4:0 0,9,110:3:0 +X 2277 . C <*> 0 . DP=21;I16=8,13,0,0,797,30699,0,0,1194,70058,0,0,303,6247,0,0;QS=3,0;MQSB=0.989565;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,151:5:0 0,12,143:4:0 +X 2278 . T <*> 0 . DP=21;I16=7,13,0,0,736,27790,0,0,1157,68689,0,0,279,5581,0,0;QS=3,0;MQSB=0.962269;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,133:4:0 0,12,148:4:0 +X 2279 . A <*> 0 . DP=20;I16=8,12,0,0,723,27047,0,0,1134,66458,0,0,306,6190,0,0;QS=3,0;MQSB=0.993326;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,155:5:0 0,12,144:4:0 +X 2280 . G <*> 0 . DP=21;I16=8,12,0,0,766,29776,0,0,1177,69769,0,0,299,6085,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,166:5:0 0,12,144:4:0 +X 2281 . C <*> 0 . DP=22;I16=8,13,0,0,784,29748,0,0,1237,73369,0,0,301,6037,0,0;QS=3,0;MQSB=0.895122;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,165:5:0 0,12,140:4:0 +X 2282 . T <*> 0 . DP=22;I16=8,14,0,0,789,29699,0,0,1254,73658,0,0,310,6054,0,0;QS=3,0;MQSB=0.985548;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,162:5:0 0,12,150:4:0 +X 2283 . G <*> 0 . DP=22;I16=8,14,0,0,798,29774,0,0,1254,73658,0,0,312,6054,0,0;QS=3,0;MQSB=0.985548;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,158:5:0 0,12,142:4:0 +X 2284 . G <*> 0 . DP=22;I16=7,14,0,0,760,28408,0,0,1194,70058,0,0,294,5664,0,0;QS=3,0;MQSB=0.975265;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,130:4:0 0,12,141:4:0 +X 2285 . G <*> 0 . DP=23;I16=9,14,0,0,844,31592,0,0,1314,77258,0,0,311,5909,0,0;QS=3,0;MQSB=0.992095;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,152:5:0 0,12,144:4:0 +X 2286 . C <*> 0 . DP=23;I16=9,14,0,0,854,32244,0,0,1314,77258,0,0,311,5869,0,0;QS=3,0;MQSB=0.992095;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,155:5:0 0,12,130:4:0 +X 2287 . A <*> 0 . DP=23;I16=9,14,0,0,818,30288,0,0,1314,77258,0,0,311,5869,0,0;QS=3,0;MQSB=0.992095;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,166:5:0 0,12,143:4:0 +X 2288 . T <*> 0 . DP=22;I16=8,14,0,0,794,29190,0,0,1254,73658,0,0,312,5908,0,0;QS=3,0;MQSB=0.985548;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,158:5:0 0,12,142:4:0 +X 2289 . G <*> 0 . DP=21;I16=8,13,0,0,723,25835,0,0,1237,73369,0,0,314,5984,0,0;QS=3,0;MQSB=0.895122;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,154:5:0 0,12,126:4:0 +X 2290 . G <*> 0 . DP=20;I16=7,13,0,0,748,28318,0,0,1177,69769,0,0,318,6094,0,0;QS=3,0;MQSB=0.875769;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,149:5:0 0,9,114:3:0 +X 2291 . T <*> 0 . DP=20;I16=7,13,0,0,731,27165,0,0,1177,69769,0,0,322,6186,0,0;QS=3,0;MQSB=0.875769;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,151:5:0 0,9,112:3:0 +X 2292 . G <*> 0 . DP=20;I16=7,13,0,0,749,28747,0,0,1177,69769,0,0,325,6259,0,0;QS=3,0;MQSB=0.875769;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,156:5:0 0,9,109:3:0 +X 2293 . G <*> 0 . DP=20;I16=7,13,0,0,739,27903,0,0,1177,69769,0,0,327,6311,0,0;QS=3,0;MQSB=0.875769;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,156:5:0 0,9,112:3:0 +X 2294 . C <*> 0 . DP=21;I16=7,14,0,0,775,29453,0,0,1237,73369,0,0,329,6391,0,0;QS=3,0;MQSB=0.872525;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,169:5:0 0,9,114:3:0 +X 2295 . T <*> 0 . DP=21;I16=7,14,0,0,773,29209,0,0,1237,73369,0,0,331,6451,0,0;QS=3,0;MQSB=0.872525;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,164:5:0 0,9,115:3:0 +X 2296 . T <*> 0 . DP=21;I16=7,14,0,0,756,27780,0,0,1237,73369,0,0,333,6543,0,0;QS=3,0;MQSB=0.872525;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,160:5:0 0,9,106:3:0 +X 2297 . G <*> 0 . DP=20;I16=7,13,0,0,736,27692,0,0,1177,69769,0,0,336,6666,0,0;QS=3,0;MQSB=0.875769;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,165:5:0 0,6,74:2:0 +X 2298 . C <*> 0 . DP=21;I16=7,14,0,0,778,29300,0,0,1237,73369,0,0,339,6819,0,0;QS=3,0;MQSB=0.872525;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,139:5:0 0,9,106:3:0 +X 2299 . A <*> 0 . DP=21;I16=7,14,0,0,714,25282,0,0,1237,73369,0,0,343,7003,0,0;QS=3,0;MQSB=0.872525;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,128:5:0 0,9,110:3:0 +X 2300 . C <*> 0 . DP=21;I16=7,13,0,0,687,24749,0,0,1177,69769,0,0,326,6768,0,0;QS=3,0;MQSB=0.875769;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,148:5:0 0,9,109:3:0 +X 2301 . C <*> 0 . DP=23;I16=7,15,0,0,802,30292,0,0,1266,74210,0,0,349,7363,0,0;QS=3,0;MQSB=0.970024;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,147:5:0 0,9,116:3:0 +X 2302 . T <*> 0 . DP=23;I16=7,16,0,0,860,32956,0,0,1326,77810,0,0,354,7496,0,0;QS=3,0;MQSB=0.964916;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,166:5:0 0,12,150:4:0 +X 2303 . G <*> 0 . DP=23;I16=7,16,0,0,817,29823,0,0,1326,77810,0,0,356,7604,0,0;QS=3,0;MQSB=0.964916;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,151:5:0 0,12,139:4:0 +X 2304 . T <*> 0 . DP=23;I16=7,16,0,0,802,28628,0,0,1326,77810,0,0,357,7691,0,0;QS=3,0;MQSB=0.964916;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,148:5:0 0,12,140:4:0 +X 2305 . A <*> 0 . DP=22;I16=7,14,0,0,725,25585,0,0,1237,73369,0,0,355,7791,0,0;QS=3,0;MQSB=0.872525;MQ0F=0 PL:DP:DV 0,36,248:12:0 0,15,155:5:0 0,12,129:4:0 +X 2306 . A <*> 0 . DP=21;I16=7,14,0,0,727,26841,0,0,1206,70610,0,0,361,7899,0,0;QS=3,0;MQSB=0.975265;MQ0F=0 PL:DP:DV 0,36,246:12:0 0,15,168:5:0 0,12,130:4:0 +X 2307 . T <*> 0 . DP=21;I16=7,14,0,0,751,27427,0,0,1206,70610,0,0,362,7964,0,0;QS=3,0;MQSB=0.975265;MQ0F=0 PL:DP:DV 0,36,251:12:0 0,15,165:5:0 0,12,141:4:0 +X 2308 . C <*> 0 . DP=21;I16=7,14,0,0,735,26675,0,0,1206,70610,0,0,363,8051,0,0;QS=3,0;MQSB=0.975265;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,144:5:0 0,12,146:4:0 +X 2309 . C A,<*> 0 . DP=19;I16=7,11,0,1,604,21364,16,256,1057,62569,29,841,358,8094,8,64;QS=2.95676,0.0432432,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.985816;BQB=1;MQ0F=0 PL:DP:DV 0,20,224,33,227,230:12:1 0,9,94,9,94,94:3:0 0,12,138,12,138,138:4:0 +X 2310 . C <*> 0 . DP=18;I16=6,12,0,0,668,25392,0,0,1049,62041,0,0,370,8282,0,0;QS=3,0;MQSB=0.961295;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,80:2:0 0,12,139:4:0 +X 2311 . A <*> 0 . DP=19;I16=7,12,0,0,707,26855,0,0,1109,65641,0,0,373,8371,0,0;QS=3,0;MQSB=0.957193;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,78:2:0 0,12,137:4:0 +X 2312 . G <*> 0 . DP=20;I16=7,12,0,0,736,29118,0,0,1109,65641,0,0,364,8306,0,0;QS=3,0;MQSB=0.957193;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,82:2:0 0,9,122:3:0 +X 2313 . C <*> 0 . DP=20;I16=7,13,0,0,723,27231,0,0,1169,69241,0,0,382,8596,0,0;QS=3,0;MQSB=0.962269;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,76:2:0 0,12,130:4:0 +X 2314 . A <*> 0 . DP=21;I16=7,12,0,0,630,22184,0,0,1109,65641,0,0,372,8510,0,0;QS=3,0;MQSB=0.957193;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,78:2:0 0,9,115:3:0 +X 2315 . C <*> 0 . DP=23;I16=7,14,0,0,739,26861,0,0,1229,72841,0,0,392,8892,0,0;QS=3,0;MQSB=0.966484;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,71:2:0 0,12,135:4:0 +X 2316 . T <*> 0 . DP=23;I16=8,15,0,0,826,30690,0,0,1349,80041,0,0,408,9102,0,0;QS=3,0;MQSB=0.967216;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,105:3:0 0,15,170:5:0 +X 2317 . T <*> 0 . DP=24;I16=7,16,0,0,766,27014,0,0,1349,80041,0,0,411,9211,0,0;QS=3,0;MQSB=0.973027;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,78:2:0 0,15,170:5:0 +X 2318 . T <*> 0 . DP=24;I16=8,14,0,0,757,27433,0,0,1320,79200,0,0,379,8449,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,91:3:0 0,15,165:5:0 +X 2319 . G <*> 0 . DP=24;I16=6,16,0,0,827,31577,0,0,1289,76441,0,0,398,8882,0,0;QS=3,0;MQSB=0.97584;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,3,43:1:0 0,15,167:5:0 +X 2320 . G <*> 0 . DP=23;I16=7,16,0,0,803,29077,0,0,1349,80041,0,0,435,9675,0,0;QS=3,0;MQSB=0.973027;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,87:3:0 0,15,157:5:0 +X 2321 . G <*> 0 . DP=23;I16=7,16,0,0,804,29368,0,0,1349,80041,0,0,442,9840,0,0;QS=3,0;MQSB=0.973027;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,79:3:0 0,15,169:5:0 +X 2322 . A <*> 0 . DP=24;I16=7,17,0,0,860,32116,0,0,1409,83641,0,0,449,10027,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,95:3:0 0,15,178:5:0 +X 2323 . G <*> 0 . DP=24;I16=7,17,0,0,863,31887,0,0,1409,83641,0,0,457,10237,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,88:3:0 0,15,153:5:0 +X 2324 . G <*> 0 . DP=24;I16=7,16,0,0,786,27932,0,0,1349,80041,0,0,462,10416,0,0;QS=3,0;MQSB=0.973027;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,88:3:0 0,15,161:5:0 +X 2325 . C <*> 0 . DP=24;I16=7,15,0,0,730,25576,0,0,1289,76441,0,0,427,9625,0,0;QS=3,0;MQSB=0.970024;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,102:3:0 0,12,130:4:0 +X 2326 . C <*> 0 . DP=24;I16=7,15,0,0,709,23523,0,0,1320,79200,0,0,426,9498,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,241:15:0 0,9,95:3:0 0,12,133:4:0 +X 2327 . G <*> 0 . DP=24;I16=7,17,0,0,817,29275,0,0,1409,83641,0,0,481,10891,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,81:3:0 0,15,158:5:0 +X 2328 . A <*> 0 . DP=24;I16=6,17,0,0,814,29804,0,0,1349,80041,0,0,461,10427,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,82:3:0 0,15,172:5:0 +X 2329 . G <*> 0 . DP=23;I16=6,16,0,0,755,27641,0,0,1289,76441,0,0,477,11005,0,0;QS=3,0;MQSB=0.97584;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,63:2:0 0,15,160:5:0 +X 2330 . C <*> 0 . DP=24;I16=7,17,0,0,875,33131,0,0,1409,83641,0,0,498,11424,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,87:3:0 0,18,181:6:0 +X 2331 . T <*> 0 . DP=24;I16=7,17,0,0,862,31882,0,0,1409,83641,0,0,505,11635,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,106:3:0 0,18,200:6:0 +X 2332 . A <*> 0 . DP=25;I16=8,17,0,0,926,35412,0,0,1469,87241,0,0,512,11864,0,0;QS=3,0;MQSB=0.973216;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,97:3:0 0,18,204:6:0 +X 2333 . G <*> 0 . DP=26;I16=8,17,0,0,923,35129,0,0,1469,87241,0,0,494,11436,0,0;QS=3,0;MQSB=0.973216;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,97:3:0 0,18,189:6:0 +X 2334 . G <*> 0 . DP=26;I16=8,18,0,0,928,34574,0,0,1529,90841,0,0,527,12277,0,0;QS=3,0;MQSB=0.975611;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,93:3:0 0,21,202:7:0 +X 2335 . A <*> 0 . DP=26;I16=8,18,0,0,967,36793,0,0,1529,90841,0,0,535,12513,0,0;QS=3,0;MQSB=0.975611;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,105:3:0 0,21,214:7:0 +X 2336 . G <*> 0 . DP=26;I16=8,18,0,0,962,36346,0,0,1529,90841,0,0,543,12769,0,0;QS=3,0;MQSB=0.975611;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,92:3:0 0,21,204:7:0 +X 2337 . G <*> 0 . DP=26;I16=7,18,0,0,895,32981,0,0,1469,87241,0,0,527,12465,0,0;QS=3,0;MQSB=0.977814;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,74:2:0 0,21,204:7:0 +X 2338 . A <*> 0 . DP=26;I16=8,18,0,0,892,31758,0,0,1529,90841,0,0,556,13186,0,0;QS=3,0;MQSB=0.975611;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,87:3:0 0,21,194:7:0 +X 2339 . T <*> 0 . DP=26;I16=7,18,0,0,827,28921,0,0,1469,87241,0,0,537,12769,0,0;QS=3,0;MQSB=0.977814;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,55:2:0 0,21,200:7:0 +X 2340 . C <*> 0 . DP=25;I16=7,18,0,0,792,25816,0,0,1469,87241,0,0,541,12893,0,0;QS=3,0;MQSB=0.977814;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,57:2:0 0,21,173:7:0 +X 2341 . G <*> 0 . DP=25;I16=6,17,0,0,771,26477,0,0,1349,80041,0,0,494,11732,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,3,41:1:0 0,21,186:7:0 +X 2342 . T <*> 0 . DP=24;I16=6,17,0,0,863,32711,0,0,1349,80041,0,0,523,12459,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,3,43:1:0 0,21,214:7:0 +X 2343 . T <*> 0 . DP=24;I16=6,16,0,0,770,28230,0,0,1289,76441,0,0,504,12032,0,0;QS=3,0;MQSB=0.97584;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,3,44:1:0 0,21,213:7:0 +X 2344 . T <*> 0 . DP=24;I16=7,17,0,0,843,30483,0,0,1409,83641,0,0,552,13124,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,56:2:0 0,21,202:7:0 +X 2345 . G <*> 0 . DP=24;I16=7,17,0,0,897,34121,0,0,1409,83641,0,0,554,13162,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,77:2:0 0,21,206:7:0 +X 2346 . A <*> 0 . DP=24;I16=7,17,0,0,908,34818,0,0,1409,83641,0,0,556,13212,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,68:2:0 0,21,220:7:0 +X 2347 . G <*> 0 . DP=24;I16=6,17,0,0,824,30406,0,0,1349,80041,0,0,533,12649,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,3,39:1:0 0,21,190:7:0 +X 2348 . T <*> 0 . DP=24;I16=7,16,0,0,745,25653,0,0,1349,80041,0,0,544,13072,0,0;QS=3,0;MQSB=0.973027;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,64:2:0 0,18,183:6:0 +X 2349 . C <*> 0 . DP=24;I16=6,17,0,0,804,29224,0,0,1349,80041,0,0,534,12656,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,3,36:1:0 0,21,200:7:0 +X 2350 . C <*> 0 . DP=25;I16=7,17,0,0,869,31905,0,0,1409,83641,0,0,534,12652,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,63:2:0 0,21,198:7:0 +X 2351 . A <*> 0 . DP=25;I16=8,17,0,0,945,36169,0,0,1469,87241,0,0,559,13237,0,0;QS=3,0;MQSB=0.973216;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,74:2:0 0,21,222:7:0 +X 2352 . G <*> 0 . DP=25;I16=7,17,0,0,893,34005,0,0,1409,83641,0,0,533,12539,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,3,41:1:0 0,21,207:7:0 +X 2353 . C <*> 0 . DP=24;I16=7,17,0,0,866,31864,0,0,1409,83641,0,0,531,12435,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,3,41:1:0 0,21,205:7:0 +X 2354 . A <*> 0 . DP=24;I16=7,17,0,0,880,33206,0,0,1409,83641,0,0,529,12351,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,3,43:1:0 0,21,214:7:0 +X 2355 . G <*> 0 . DP=24;I16=7,17,0,0,871,32261,0,0,1409,83641,0,0,526,12238,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,3,39:1:0 0,21,195:7:0 +X 2356 . T <*> 0 . DP=24;I16=7,17,0,0,887,33305,0,0,1409,83641,0,0,521,12047,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,3,43:1:0 0,21,219:7:0 +X 2357 . T <*> 0 . DP=24;I16=7,17,0,0,899,34225,0,0,1409,83641,0,0,516,11878,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,3,43:1:0 0,21,220:7:0 +X 2358 . T <*> 0 . DP=24;I16=7,17,0,0,913,34891,0,0,1409,83641,0,0,510,11680,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,3,40:1:0 0,21,218:7:0 +X 2359 . G <*> 0 . DP=25;I16=7,17,0,0,898,34048,0,0,1409,83641,0,0,503,11451,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,3,39:1:0 0,21,209:7:0 +X 2360 . A <*> 0 . DP=25;I16=7,18,0,0,959,37113,0,0,1469,87241,0,0,514,11552,0,0;QS=3,0;MQSB=0.977814;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,72:2:0 0,21,222:7:0 +X 2361 . G <*> 0 . DP=25;I16=7,17,0,0,850,30946,0,0,1409,83641,0,0,482,10726,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,67:2:0 0,18,168:6:0 +X 2362 . A <*> 0 . DP=25;I16=7,17,0,0,762,25482,0,0,1409,83641,0,0,475,10547,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,51:2:0 0,18,159:6:0 +X 2363 . C <*> 0 . DP=25;I16=7,18,0,0,875,31837,0,0,1469,87241,0,0,493,11015,0,0;QS=3,0;MQSB=0.977814;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,65:2:0 0,21,187:7:0 +X 2364 . C <*> 0 . DP=25;I16=7,18,0,0,927,34965,0,0,1469,87241,0,0,486,10880,0,0;QS=3,0;MQSB=0.977814;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,64:2:0 0,21,201:7:0 +X 2365 . A <*> 0 . DP=24;I16=7,17,0,0,908,34754,0,0,1409,83641,0,0,479,10717,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,65:2:0 0,21,221:7:0 +X 2366 . G <*> 0 . DP=25;I16=7,17,0,0,912,35074,0,0,1440,86400,0,0,447,9951,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,58:2:0 0,21,206:7:0 +X 2367 . C <*> 0 . DP=25;I16=7,17,0,0,872,32088,0,0,1409,83641,0,0,440,9782,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,3,36:1:0 0,21,197:7:0 +X 2368 . C <*> 0 . DP=24;I16=6,17,0,0,871,33801,0,0,1349,80041,0,0,434,9634,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,3,39:1:0 0,18,180:6:0 +X 2369 . T <*> 0 . DP=24;I16=6,18,0,0,877,33009,0,0,1409,83641,0,0,452,10082,0,0;QS=3,0;MQSB=0.980199;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,49:2:0 0,18,179:6:0 +X 2370 . G <*> 0 . DP=24;I16=6,18,0,0,899,34289,0,0,1409,83641,0,0,445,9927,0,0;QS=3,0;MQSB=0.980199;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,56:2:0 0,18,179:6:0 +X 2371 . G <*> 0 . DP=24;I16=6,18,0,0,880,33088,0,0,1409,83641,0,0,438,9794,0,0;QS=3,0;MQSB=0.980199;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,51:2:0 0,18,177:6:0 +X 2372 . C <*> 0 . DP=24;I16=6,18,0,0,827,29615,0,0,1409,83641,0,0,431,9683,0,0;QS=3,0;MQSB=0.980199;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,47:2:0 0,18,163:6:0 +X 2373 . C <*> 0 . DP=24;I16=6,18,0,0,886,33212,0,0,1409,83641,0,0,424,9594,0,0;QS=3,0;MQSB=0.980199;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,58:2:0 0,18,166:6:0 +X 2374 . A <*> 0 . DP=23;I16=6,17,0,0,844,31230,0,0,1349,80041,0,0,417,9477,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,66:2:0 0,18,177:6:0 +X 2375 . A <*> 0 . DP=23;I16=5,17,0,0,788,28340,0,0,1289,76441,0,0,409,9333,0,0;QS=3,0;MQSB=0.981001;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,64:2:0 0,18,171:6:0 +X 2376 . T <*> 0 . DP=22;I16=5,17,0,0,778,27804,0,0,1289,76441,0,0,401,9161,0,0;QS=3,0;MQSB=0.981001;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,62:2:0 0,18,162:6:0 +X 2377 . A <*> 0 . DP=21;I16=4,17,0,0,704,24488,0,0,1229,72841,0,0,394,9008,0,0;QS=3,0;MQSB=0.984085;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,49:2:0 0,15,135:5:0 +X 2378 . C <*> 0 . DP=20;I16=4,16,0,0,626,20138,0,0,1169,69241,0,0,388,8872,0,0;QS=3,0;MQSB=0.982301;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,3,15:1:0 0,15,108:5:0 +X 2379 . G <*> 0 . DP=20;I16=4,16,0,0,714,25924,0,0,1169,69241,0,0,382,8752,0,0;QS=3,0;MQSB=0.982301;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,3,34:1:0 0,15,140:5:0 +X 2380 . G <*> 0 . DP=19;I16=4,14,0,0,672,25672,0,0,1049,62041,0,0,352,8022,0,0;QS=3,0;MQSB=0.977696;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,18:1:0 0,15,134:5:0 +X 2381 . C <*> 0 . DP=18;I16=4,14,0,0,676,25626,0,0,1049,62041,0,0,373,8555,0,0;QS=3,0;MQSB=0.977696;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,28:1:0 0,15,133:5:0 +X 2382 . A <*> 0 . DP=19;I16=5,14,0,0,669,23995,0,0,1109,65641,0,0,369,8475,0,0;QS=3,0;MQSB=0.97357;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,3,28:1:0 0,15,131:5:0 +X 2383 . A <*> 0 . DP=19;I16=5,14,0,0,686,25162,0,0,1109,65641,0,0,365,8359,0,0;QS=3,0;MQSB=0.97357;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,3,26:1:0 0,15,140:5:0 +X 2384 . A <*> 0 . DP=19;I16=5,14,0,0,649,22943,0,0,1109,65641,0,0,360,8210,0,0;QS=3,0;MQSB=0.97357;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,3,13:1:0 0,15,132:5:0 +X 2385 . A <*> 0 . DP=18;I16=4,14,0,0,643,23235,0,0,1049,62041,0,0,356,8078,0,0;QS=3,0;MQSB=0.977696;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,38:1:0 0,15,134:5:0 +X 2386 . C <*> 0 . DP=18;I16=4,14,0,0,652,24008,0,0,1049,62041,0,0,351,7913,0,0;QS=3,0;MQSB=0.977696;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,25:1:0 0,15,130:5:0 +X 2387 . C <*> 0 . DP=18;I16=4,14,0,0,667,25007,0,0,1049,62041,0,0,345,7717,0,0;QS=3,0;MQSB=0.977696;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,25:1:0 0,15,128:5:0 +X 2388 . C <*> 0 . DP=18;I16=4,14,0,0,691,26659,0,0,1049,62041,0,0,339,7541,0,0;QS=3,0;MQSB=0.977696;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,39:1:0 0,15,134:5:0 +X 2389 . A <*> 0 . DP=19;I16=5,14,0,0,682,24912,0,0,1109,65641,0,0,333,7385,0,0;QS=3,0;MQSB=0.97357;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,3,35:1:0 0,15,140:5:0 +X 2390 . G <*> 0 . DP=18;I16=5,13,0,0,642,23418,0,0,1049,62041,0,0,328,7200,0,0;QS=3,0;MQSB=0.970092;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,27:1:0 0,15,126:5:0 +X 2391 . T <*> 0 . DP=18;I16=5,12,0,0,624,23122,0,0,989,58441,0,0,298,6412,0,0;QS=2,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,0,0:0:0 0,15,140:5:0 +X 2392 . C <*> 0 . DP=18;I16=5,12,0,0,660,25910,0,0,989,58441,0,0,291,6171,0,0;QS=2,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,0,0:0:0 0,15,131:5:0 +X 2393 . T <*> 0 . DP=18;I16=5,13,0,0,669,25099,0,0,1049,62041,0,0,309,6577,0,0;QS=3,0;MQSB=0.970092;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,38:1:0 0,15,134:5:0 +X 2394 . C <*> 0 . DP=17;I16=5,12,0,0,653,25323,0,0,989,58441,0,0,303,6379,0,0;QS=3,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,3,29:1:0 0,15,133:5:0 +X 2395 . T <*> 0 . DP=17;I16=5,12,0,0,613,22621,0,0,989,58441,0,0,297,6201,0,0;QS=3,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,3,19:1:0 0,15,128:5:0 +X 2396 . A <*> 0 . DP=17;I16=5,11,0,0,584,21426,0,0,929,54841,0,0,266,5418,0,0;QS=2,0;MQSB=0.960687;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,0,0:0:0 0,15,130:5:0 +X 2397 . C <*> 0 . DP=18;I16=5,13,0,0,650,24046,0,0,1049,62041,0,0,284,5856,0,0;QS=3,0;MQSB=0.970092;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,18:1:0 0,15,129:5:0 +X 2398 . A <*> 0 . DP=18;I16=5,13,0,0,617,21907,0,0,1049,62041,0,0,278,5692,0,0;QS=3,0;MQSB=0.970092;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,19:1:0 0,15,128:5:0 +X 2399 . A <*> 0 . DP=17;I16=5,11,0,0,592,22176,0,0,929,54841,0,0,248,4926,0,0;QS=2,0;MQSB=0.960687;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,0,0:0:0 0,12,115:4:0 +X 2400 . A <*> 0 . DP=16;I16=5,11,0,0,576,21010,0,0,929,54841,0,0,269,5431,0,0;QS=3,0;MQSB=0.960687;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,26:1:0 0,9,99:3:0 +X 2401 . A <*> 0 . DP=17;I16=6,11,0,0,594,21126,0,0,989,58441,0,0,265,5331,0,0;QS=3,0;MQSB=0.955563;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,3,23:1:0 0,9,98:3:0 +X 2402 . A <*> 0 . DP=17;I16=6,11,0,0,606,21986,0,0,989,58441,0,0,262,5252,0,0;QS=3,0;MQSB=0.955563;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,3,27:1:0 0,9,99:3:0 +X 2403 . A <*> 0 . DP=17;I16=6,11,0,0,608,22130,0,0,989,58441,0,0,259,5195,0,0;QS=3,0;MQSB=0.955563;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,3,21:1:0 0,9,97:3:0 +X 2404 . T <*> 0 . DP=17;I16=6,11,0,0,567,19449,0,0,989,58441,0,0,256,5160,0,0;QS=3,0;MQSB=0.955563;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,3,14:1:0 0,9,87:3:0 +X 2405 . A <*> 0 . DP=18;I16=7,11,0,0,618,21666,0,0,1049,62041,0,0,253,5147,0,0;QS=3,0;MQSB=0.951002;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,3,17:1:0 0,9,88:3:0 +X 2406 . C <*> 0 . DP=18;I16=7,11,0,0,676,25664,0,0,1049,62041,0,0,250,5108,0,0;QS=3,0;MQSB=0.951002;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,3,27:1:0 0,9,90:3:0 +X 2407 . A <*> 0 . DP=19;I16=8,11,0,0,673,24197,0,0,1109,65641,0,0,246,5046,0,0;QS=3,0;MQSB=0.946915;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,3,34:1:0 0,9,89:3:0 +X 2408 . A <*> 0 . DP=18;I16=8,10,0,0,619,21951,0,0,1049,62041,0,0,243,4961,0,0;QS=3,0;MQSB=0.938795;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,3,22:1:0 0,6,73:2:0 +X 2409 . A <*> 0 . DP=17;I16=8,9,0,0,615,22687,0,0,1020,61200,0,0,240,4852,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,3,39:1:0 0,6,74:2:0 +X 2410 . A <*> 0 . DP=17;I16=8,9,0,0,604,21938,0,0,1020,61200,0,0,237,4769,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,3,39:1:0 0,6,73:2:0 +X 2411 . A <*> 0 . DP=16;I16=7,9,0,0,567,20551,0,0,960,57600,0,0,235,4711,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,3,25:1:0 0,6,70:2:0 +X 2412 . A <*> 0 . DP=15;I16=7,8,0,0,527,18903,0,0,900,54000,0,0,234,4676,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,21:1:0 0,6,70:2:0 +X 2413 . C <*> 0 . DP=15;I16=7,8,0,0,559,21161,0,0,900,54000,0,0,233,4663,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,22:1:0 0,6,72:2:0 +X 2414 . A <*> 0 . DP=16;I16=8,8,0,0,570,20822,0,0,929,54841,0,0,232,4672,0,0;QS=3,0;MQSB=0.915545;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,3,25:1:0 0,6,73:2:0 +X 2415 . A <*> 0 . DP=16;I16=9,7,0,0,574,20768,0,0,929,54841,0,0,232,4652,0,0;QS=3,0;MQSB=0.933674;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,3,30:1:0 0,6,64:2:0 +X 2416 . C <*> 0 . DP=17;I16=8,8,0,0,576,21424,0,0,960,57600,0,0,231,4649,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,42:2:0 0,6,68:2:0 +X 2417 . T <*> 0 . DP=17;I16=10,7,0,0,612,22740,0,0,958,55682,0,0,235,4627,0,0;QS=3,0;MQSB=0.79189;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,57:2:0 0,9,92:3:0 +X 2418 . A <*> 0 . DP=17;I16=10,7,0,0,624,23210,0,0,958,55682,0,0,238,4626,0,0;QS=3,0;MQSB=0.79189;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,62:2:0 0,9,105:3:0 +X 2419 . G <*> 0 . DP=19;I16=11,7,0,0,651,24113,0,0,1018,59282,0,0,241,4651,0,0;QS=3,0;MQSB=0.817948;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,51:2:0 0,12,126:4:0 +X 2420 . C <*> 0 . DP=19;I16=11,8,0,0,663,23999,0,0,1078,62882,0,0,246,4704,0,0;QS=3,0;MQSB=0.803979;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,44:2:0 0,12,127:4:0 +X 2421 . C <*> 0 . DP=19;I16=10,8,0,0,657,24779,0,0,1049,62041,0,0,244,4738,0,0;QS=3,0;MQSB=0.938795;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,45:2:0 0,12,126:4:0 +X 2422 . A <*> 0 . DP=18;I16=11,6,0,0,647,24747,0,0,958,55682,0,0,238,4538,0,0;QS=3,0;MQSB=0.833753;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,33:1:0 0,12,137:4:0 +X 2423 . G <*> 0 . DP=18;I16=11,6,0,0,634,24250,0,0,958,55682,0,0,258,4972,0,0;QS=3,0;MQSB=0.833753;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,54:2:0 0,12,126:4:0 +X 2424 . G <*> 0 . DP=18;I16=10,6,0,0,595,22361,0,0,929,54841,0,0,240,4714,0,0;QS=3,0;MQSB=0.948436;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,3,36:1:0 0,12,126:4:0 +X 2425 . C <*> 0 . DP=18;I16=10,7,0,0,596,21716,0,0,989,58441,0,0,260,5074,0,0;QS=3,0;MQSB=0.943335;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,45:2:0 0,12,114:4:0 +X 2426 . G <*> 0 . DP=18;I16=10,7,0,0,550,18088,0,0,989,58441,0,0,263,5171,0,0;QS=3,0;MQSB=0.943335;MQ0F=0 PL:DP:DV 0,33,232:11:0 0,6,59:2:0 0,12,113:4:0 +X 2427 . T <*> 0 . DP=18;I16=11,6,0,0,618,22654,0,0,958,55682,0,0,275,5403,0,0;QS=3,0;MQSB=0.833753;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,62:2:0 0,9,99:3:0 +X 2428 . G <*> 0 . DP=18;I16=11,7,0,0,649,24633,0,0,1018,59282,0,0,281,5535,0,0;QS=3,0;MQSB=0.817948;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,48:2:0 0,12,128:4:0 +X 2429 . G <*> 0 . DP=18;I16=10,7,0,0,553,19057,0,0,989,58441,0,0,269,5459,0,0;QS=3,0;MQSB=0.943335;MQ0F=0 PL:DP:DV 0,33,241:11:0 0,6,55:2:0 0,12,117:4:0 +X 2430 . T A,<*> 0 . DP=18;I16=10,7,1,0,552,18556,21,441,989,58441,29,841,271,5603,16,256;QS=2.94278,0.0572207,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.817948;BQB=1;MQ0F=0 PL:DP:DV 0,15,212,33,215,222:12:1 0,6,60,6,60,60:2:0 0,12,125,12,125,125:4:0 +X 2431 . G <*> 0 . DP=18;I16=11,5,0,0,580,21766,0,0,898,52082,0,0,268,5764,0,0;QS=3,0;MQSB=0.851779;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,37:1:0 0,9,98:3:0 +X 2432 . G <*> 0 . DP=17;I16=10,7,0,0,593,21479,0,0,958,55682,0,0,295,6179,0,0;QS=3,0;MQSB=0.79189;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,53:2:0 0,9,97:3:0 +X 2433 . T <*> 0 . DP=17;I16=10,7,0,0,577,20425,0,0,958,55682,0,0,299,6321,0,0;QS=3,0;MQSB=0.79189;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,57:2:0 0,9,94:3:0 +X 2434 . G <*> 0 . DP=17;I16=10,6,0,0,546,19340,0,0,929,54841,0,0,284,6082,0,0;QS=3,0;MQSB=0.948436;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,46:2:0 0,6,62:2:0 +X 2435 . C <*> 0 . DP=18;I16=12,5,0,0,597,21843,0,0,958,55682,0,0,304,6626,0,0;QS=3,0;MQSB=0.870325;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,58:2:0 0,6,60:2:0 +X 2436 . A <*> 0 . DP=18;I16=11,6,0,0,545,18599,0,0,989,58441,0,0,295,6379,0,0;QS=3,0;MQSB=0.955563;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,64:3:0 0,6,61:2:0 +X 2437 . C <*> 0 . DP=18;I16=11,5,0,0,573,21195,0,0,929,54841,0,0,297,6541,0,0;QS=3,0;MQSB=0.960687;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,63:2:0 0,6,63:2:0 +X 2438 . A <*> 0 . DP=19;I16=12,6,0,0,583,20111,0,0,1018,59282,0,0,328,7322,0,0;QS=3,0;MQSB=0.85394;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,65:2:0 0,6,65:2:0 +X 2439 . C <*> 0 . DP=19;I16=11,7,0,0,635,22997,0,0,1049,62041,0,0,314,6974,0,0;QS=3,0;MQSB=0.951002;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,91:3:0 0,6,57:2:0 +X 2440 . C <*> 0 . DP=21;I16=13,7,0,0,701,26195,0,0,1138,66482,0,0,346,7840,0,0;QS=3,0;MQSB=0.857404;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,114:4:0 0,6,66:2:0 +X 2441 . T <*> 0 . DP=21;I16=13,8,0,0,788,29910,0,0,1198,70082,0,0,360,8068,0,0;QS=3,0;MQSB=0.845496;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,164:5:0 0,6,67:2:0 +X 2442 . G <*> 0 . DP=20;I16=12,7,0,0,695,25957,0,0,1109,65641,0,0,342,7596,0,0;QS=3,0;MQSB=0.957193;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,128:4:0 0,6,66:2:0 +X 2443 . T <*> 0 . DP=20;I16=13,7,0,0,697,24685,0,0,1138,66482,0,0,373,8345,0,0;QS=3,0;MQSB=0.857404;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,130:4:0 0,6,64:2:0 +X 2444 . A <*> 0 . DP=21;I16=13,8,0,0,755,27981,0,0,1198,70082,0,0,379,8489,0,0;QS=3,0;MQSB=0.845496;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,140:4:0 0,6,64:2:0 +X 2445 . G <*> 0 . DP=21;I16=12,8,0,0,731,27427,0,0,1169,69241,0,0,359,7927,0,0;QS=3,0;MQSB=0.953497;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,130:4:0 0,6,65:2:0 +X 2446 . T <*> 0 . DP=21;I16=13,8,0,0,723,25707,0,0,1198,70082,0,0,389,8633,0,0;QS=3,0;MQSB=0.845496;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,128:4:0 0,6,65:2:0 +X 2447 . C <*> 0 . DP=22;I16=14,8,0,0,770,27950,0,0,1258,73682,0,0,394,8732,0,0;QS=3,0;MQSB=0.86151;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,127:4:0 0,6,64:2:0 +X 2448 . C <*> 0 . DP=23;I16=14,7,0,0,727,26165,0,0,1167,67323,0,0,388,8674,0,0;QS=3,0;MQSB=0.735784;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,129:5:0 0,6,66:2:0 +X 2449 . C <*> 0 . DP=23;I16=13,8,0,0,727,26415,0,0,1198,70082,0,0,363,7787,0,0;QS=3,0;MQSB=0.845496;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,128:5:0 0,6,62:2:0 +X 2450 . A <*> 0 . DP=22;I16=12,8,0,0,673,24267,0,0,1138,66482,0,0,371,7959,0,0;QS=3,0;MQSB=0.826565;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,143:5:0 0,6,65:2:0 +X 2451 . G <*> 0 . DP=22;I16=14,8,0,0,821,31595,0,0,1227,70923,0,0,429,9401,0,0;QS=3,0;MQSB=0.715049;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,151:5:0 0,6,67:2:0 +X 2452 . C <*> 0 . DP=22;I16=14,8,0,0,743,26557,0,0,1227,70923,0,0,437,9613,0,0;QS=3,0;MQSB=0.715049;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,137:5:0 0,6,66:2:0 +X 2453 . T <*> 0 . DP=22;I16=14,8,0,0,775,28215,0,0,1227,70923,0,0,445,9845,0,0;QS=3,0;MQSB=0.715049;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,143:5:0 0,6,68:2:0 +X 2454 . A <*> 0 . DP=22;I16=14,8,0,0,721,24545,0,0,1227,70923,0,0,453,10097,0,0;QS=3,0;MQSB=0.715049;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,145:5:0 0,6,64:2:0 +X 2455 . C <*> 0 . DP=22;I16=14,8,0,0,776,28212,0,0,1227,70923,0,0,461,10369,0,0;QS=3,0;MQSB=0.715049;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,138:5:0 0,6,65:2:0 +X 2456 . T <*> 0 . DP=24;I16=14,9,0,0,834,30902,0,0,1318,77282,0,0,444,10036,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,168:6:0 0,6,60:2:0 +X 2457 . C <*> 0 . DP=24;I16=15,9,0,0,816,29244,0,0,1347,78123,0,0,478,10924,0,0;QS=3,0;MQSB=0.72325;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,159:6:0 0,6,65:2:0 +X 2458 . A <*> 0 . DP=24;I16=15,9,0,0,869,32555,0,0,1347,78123,0,0,487,11209,0,0;QS=3,0;MQSB=0.72325;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,166:6:0 0,6,65:2:0 +X 2459 . G T,<*> 0 . DP=24;I16=13,9,1,0,822,31186,13,169,1289,76441,29,841,453,10551,17,289;QS=2.92973,0.0702703,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.851535;BQB=1;MQ0F=0 PL:DP:DV 0,45,255,45,255,255:15:0 0,5,138,15,141,144:6:1 0,6,64,6,64,64:2:0 +X 2460 . G <*> 0 . DP=24;I16=14,9,0,0,834,31432,0,0,1318,77282,0,0,477,11065,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,160:6:0 0,6,65:2:0 +X 2461 . A G,<*> 0 . DP=24;I16=14,9,1,0,839,31487,13,169,1318,77282,29,841,489,11521,19,361;QS=2.93401,0.0659898,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.72325;BQB=1;MQ0F=0 PL:DP:DV 0,48,255,48,255,255:16:0 0,5,148,15,151,154:6:1 0,6,67,6,67,67:2:0 +X 2462 . G <*> 0 . DP=25;I16=15,10,0,0,893,33155,0,0,1407,81723,0,0,514,12090,0,0;QS=3,0;MQSB=0.707404;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,165:6:0 0,6,66:2:0 +X 2463 . G T,<*> 0 . DP=25;I16=12,10,1,0,777,28525,14,196,1289,76441,29,841,452,10720,25,625;QS=2.975,0.025,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.825053;BQB=1;MQ0F=0 PL:DP:DV 0,36,255,48,255,255:17:1 0,12,133,12,133,133:4:0 0,6,68,6,68,68:2:0 +X 2464 . C <*> 0 . DP=25;I16=15,10,0,0,904,34194,0,0,1407,81723,0,0,526,12458,0,0;QS=3,0;MQSB=0.707404;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,149:6:0 0,6,67:2:0 +X 2465 . T <*> 0 . DP=25;I16=14,10,0,0,857,32235,0,0,1347,78123,0,0,506,11994,0,0;QS=3,0;MQSB=0.679965;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,163:6:0 0,6,69:2:0 +X 2466 . G <*> 0 . DP=24;I16=14,9,0,0,852,32336,0,0,1318,77282,0,0,509,12025,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,157:6:0 0,6,63:2:0 +X 2467 . A <*> 0 . DP=24;I16=14,9,0,0,829,30725,0,0,1318,77282,0,0,513,12121,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,168:6:0 0,6,67:2:0 +X 2468 . G <*> 0 . DP=24;I16=15,9,0,0,890,34034,0,0,1347,78123,0,0,541,12807,0,0;QS=3,0;MQSB=0.72325;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,169:6:0 0,6,64:2:0 +X 2469 . G <*> 0 . DP=24;I16=15,9,0,0,865,32303,0,0,1347,78123,0,0,544,12882,0,0;QS=3,0;MQSB=0.72325;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,174:6:0 0,6,58:2:0 +X 2470 . G <*> 0 . DP=24;I16=14,9,0,0,829,30785,0,0,1318,77282,0,0,521,12295,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,178:6:0 0,6,58:2:0 +X 2471 . G <*> 0 . DP=24;I16=14,9,0,0,833,31429,0,0,1318,77282,0,0,523,12345,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,170:5:0 0,6,64:2:0 +X 2472 . G <*> 0 . DP=24;I16=13,9,0,0,774,28428,0,0,1289,76441,0,0,499,11733,0,0;QS=3,0;MQSB=0.955854;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,154:5:0 0,6,56:2:0 +X 2473 . A <*> 0 . DP=24;I16=13,9,0,0,775,28137,0,0,1258,73682,0,0,508,12078,0,0;QS=3,0;MQSB=0.834768;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,160:5:0 0,6,63:2:0 +X 2474 . A <*> 0 . DP=25;I16=15,9,0,0,851,31665,0,0,1378,80882,0,0,524,12322,0,0;QS=3,0;MQSB=0.865888;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,160:5:0 0,9,80:3:0 +X 2475 . G <*> 0 . DP=25;I16=15,9,0,0,913,35239,0,0,1378,80882,0,0,525,12323,0,0;QS=3,0;MQSB=0.865888;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,167:5:0 0,9,84:3:0 +X 2476 . G <*> 0 . DP=25;I16=13,9,0,0,776,28584,0,0,1289,76441,0,0,488,11544,0,0;QS=3,0;MQSB=0.955854;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,138:5:0 0,9,82:3:0 +X 2477 . A <*> 0 . DP=25;I16=14,9,0,0,867,34329,0,0,1318,77282,0,0,515,12223,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,178:5:0 0,9,91:3:0 +X 2478 . C <*> 0 . DP=25;I16=14,9,0,0,897,36911,0,0,1318,77282,0,0,517,12289,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,175:5:0 0,9,87:3:0 +X 2479 . T <*> 0 . DP=25;I16=15,9,0,0,921,37957,0,0,1378,80882,0,0,529,12467,0,0;QS=3,0;MQSB=0.865888;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,176:5:0 0,9,97:3:0 +X 2480 . G <*> 0 . DP=25;I16=14,9,0,0,877,35485,0,0,1349,80041,0,0,504,11864,0,0;QS=3,0;MQSB=0.960618;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,176:5:0 0,9,88:3:0 +X 2481 . C <*> 0 . DP=25;I16=13,9,0,0,848,34542,0,0,1289,76441,0,0,496,11838,0,0;QS=3,0;MQSB=0.955854;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,183:5:0 0,9,88:3:0 +X 2482 . T <*> 0 . DP=25;I16=15,9,0,0,905,37331,0,0,1378,80882,0,0,526,12430,0,0;QS=3,0;MQSB=0.865888;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,178:5:0 0,9,96:3:0 +X 2483 . T <*> 0 . DP=25;I16=14,9,0,0,879,36187,0,0,1318,77282,0,0,517,12311,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,180:5:0 0,9,89:3:0 +X 2484 . G <*> 0 . DP=25;I16=14,9,0,0,884,35142,0,0,1349,80041,0,0,494,11604,0,0;QS=3,0;MQSB=0.960618;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,174:5:0 0,9,84:3:0 +X 2485 . A T,<*> 0 . DP=25;I16=14,9,1,0,891,36757,17,289,1349,80041,29,841,490,11502,25,625;QS=2.96926,0.0307414,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.865888;BQB=1;MQ0F=0 PL:DP:DV 0,31,255,45,255,255:16:1 0,15,193,15,193,193:5:0 0,9,93,9,93,93:3:0 +X 2486 . G <*> 0 . DP=25;I16=15,9,0,0,898,36230,0,0,1378,80882,0,0,511,12041,0,0;QS=3,0;MQSB=0.865888;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,153:5:0 0,9,90:3:0 +X 2487 . C <*> 0 . DP=25;I16=14,9,0,0,793,30695,0,0,1349,80041,0,0,482,11346,0,0;QS=3,0;MQSB=0.960618;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,175:5:0 0,9,91:3:0 +X 2488 . C <*> 0 . DP=25;I16=13,9,0,0,841,34597,0,0,1289,76441,0,0,457,10841,0,0;QS=3,0;MQSB=0.955854;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,174:5:0 0,9,93:3:0 +X 2489 . C <*> 0 . DP=23;I16=11,9,0,0,801,34227,0,0,1169,69241,0,0,454,10788,0,0;QS=3,0;MQSB=0.943233;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,187:5:0 0,9,93:3:0 +X 2490 . A <*> 0 . DP=23;I16=11,10,0,0,818,34642,0,0,1229,72841,0,0,451,10695,0,0;QS=3,0;MQSB=0.939898;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,175:5:0 0,12,128:4:0 +X 2491 . G <*> 0 . DP=23;I16=12,10,0,0,845,35143,0,0,1258,73682,0,0,471,11097,0,0;QS=3,0;MQSB=0.804615;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,178:5:0 0,12,121:4:0 +X 2492 . G A,<*> 0 . DP=23;I16=11,10,1,0,845,36207,16,256,1229,72841,29,841,446,10494,21,441;QS=2.96708,0.0329218,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.804615;BQB=1;MQ0F=0 PL:DP:DV 0,22,255,36,255,255:13:1 0,15,187,15,187,187:5:0 0,12,124,12,124,124:4:0 +X 2493 . A G,<*> 0 . DP=23;I16=11,10,1,0,855,37007,13,169,1229,72841,29,841,442,10340,20,400;QS=2.97269,0.0273109,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.804615;BQB=1;MQ0F=0 PL:DP:DV 0,25,255,36,255,255:13:1 0,15,191,15,191,191:5:0 0,12,127,12,127,127:4:0 +X 2494 . G <*> 0 . DP=23;I16=11,10,0,0,802,32720,0,0,1229,72841,0,0,437,10153,0,0;QS=3,0;MQSB=0.939898;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,179:5:0 0,12,118:4:0 +X 2495 . T <*> 0 . DP=23;I16=10,10,0,0,737,29861,0,0,1138,66482,0,0,413,9513,0,0;QS=3,0;MQSB=0.751477;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,172:5:0 0,12,113:4:0 +X 2496 . T <*> 0 . DP=23;I16=12,10,0,0,815,32793,0,0,1258,73682,0,0,442,10026,0,0;QS=3,0;MQSB=0.804615;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,183:5:0 0,12,123:4:0 +X 2497 . T <*> 0 . DP=22;I16=12,9,0,0,807,33723,0,0,1198,70082,0,0,436,9814,0,0;QS=3,0;MQSB=0.815018;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,177:5:0 0,12,131:4:0 +X 2498 . G <*> 0 . DP=22;I16=12,9,0,0,808,33264,0,0,1198,70082,0,0,430,9622,0,0;QS=3,0;MQSB=0.815018;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,173:5:0 0,12,127:4:0 +X 2499 . A <*> 0 . DP=22;I16=12,9,0,0,847,36803,0,0,1198,70082,0,0,424,9450,0,0;QS=3,0;MQSB=0.815018;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,185:5:0 0,12,133:4:0 +X 2500 . G <*> 0 . DP=22;I16=11,9,0,0,772,32546,0,0,1169,69241,0,0,404,9078,0,0;QS=3,0;MQSB=0.943233;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,168:5:0 0,12,129:4:0 +X 2501 . G <*> 0 . DP=22;I16=11,8,0,0,768,33120,0,0,1109,65641,0,0,373,8293,0,0;QS=3,0;MQSB=0.946915;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,146:4:0 0,12,118:4:0 +X 2502 . C <*> 0 . DP=22;I16=12,8,0,0,798,33902,0,0,1138,66482,0,0,378,8270,0,0;QS=3,0;MQSB=0.826565;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,155:4:0 0,12,125:4:0 +X 2503 . T <*> 0 . DP=22;I16=12,9,0,0,851,36841,0,0,1198,70082,0,0,396,8746,0,0;QS=3,0;MQSB=0.815018;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,180:5:0 0,12,139:4:0 +X 2504 . G <*> 0 . DP=22;I16=12,9,0,0,787,31955,0,0,1198,70082,0,0,389,8615,0,0;QS=3,0;MQSB=0.815018;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,171:5:0 0,12,129:4:0 +X 2505 . C <*> 0 . DP=21;I16=11,9,0,0,792,33440,0,0,1138,66482,0,0,383,8501,0,0;QS=3,0;MQSB=0.791547;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,169:5:0 0,12,132:4:0 +X 2506 . T <*> 0 . DP=22;I16=11,10,0,0,798,32868,0,0,1198,70082,0,0,376,8354,0,0;QS=3,0;MQSB=0.780412;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,175:5:0 0,15,169:5:0 +X 2507 . G <*> 0 . DP=21;I16=9,10,0,0,716,30074,0,0,1109,65641,0,0,365,8189,0,0;QS=3,0;MQSB=0.920044;MQ0F=0 PL:DP:DV 0,27,241:9:0 0,15,163:5:0 0,15,153:5:0 +X 2508 . T <*> 0 . DP=21;I16=9,10,0,0,724,30396,0,0,1109,65641,0,0,361,8089,0,0;QS=3,0;MQSB=0.920044;MQ0F=0 PL:DP:DV 0,27,241:9:0 0,15,158:5:0 0,15,162:5:0 +X 2509 . G T,<*> 0 . DP=21;I16=8,10,1,0,710,30408,35,1225,1049,62041,60,3600,330,7282,25,625;QS=2.80663,0.19337,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.920044;BQB=1;MQ0F=0 PL:DP:DV 0,27,253,27,253,253:9:0 20,0,122,32,125,150:5:1 0,15,163,15,163,163:5:0 +X 2510 . A <*> 0 . DP=21;I16=10,10,0,0,778,33128,0,0,1138,66482,0,0,352,7754,0,0;QS=3,0;MQSB=0.751477;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,174:5:0 0,15,161:5:0 +X 2511 . G <*> 0 . DP=21;I16=10,10,0,0,771,32165,0,0,1138,66482,0,0,344,7558,0,0;QS=3,0;MQSB=0.751477;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,161:5:0 0,15,159:5:0 +X 2512 . C <*> 0 . DP=21;I16=10,10,0,0,790,33406,0,0,1138,66482,0,0,336,7386,0,0;QS=3,0;MQSB=0.751477;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,175:5:0 0,15,160:5:0 +X 2513 . T <*> 0 . DP=21;I16=10,10,0,0,755,31503,0,0,1138,66482,0,0,327,7189,0,0;QS=3,0;MQSB=0.751477;MQ0F=0 PL:DP:DV 0,30,246:10:0 0,15,180:5:0 0,15,156:5:0 +X 2514 . G <*> 0 . DP=20;I16=9,10,0,0,702,28002,0,0,1109,65641,0,0,319,7017,0,0;QS=3,0;MQSB=0.920044;MQ0F=0 PL:DP:DV 0,27,228:9:0 0,15,171:5:0 0,15,155:5:0 +X 2515 . T <*> 0 . DP=19;I16=8,10,0,0,642,25888,0,0,1049,62041,0,0,312,6868,0,0;QS=3,0;MQSB=0.906029;MQ0F=0 PL:DP:DV 0,24,182:8:0 0,15,172:5:0 0,15,141:5:0 +X 2516 . G <*> 0 . DP=19;I16=8,10,0,0,685,28155,0,0,1049,62041,0,0,303,6641,0,0;QS=3,0;MQSB=0.906029;MQ0F=0 PL:DP:DV 0,24,211:8:0 0,15,175:5:0 0,15,147:5:0 +X 2517 . A <*> 0 . DP=18;I16=8,9,0,0,660,27600,0,0,989,58441,0,0,295,6435,0,0;QS=3,0;MQSB=0.91051;MQ0F=0 PL:DP:DV 0,24,215:8:0 0,12,139:4:0 0,15,161:5:0 +X 2518 . T <*> 0 . DP=17;I16=6,9,0,0,611,26911,0,0,900,54000,0,0,273,6023,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,188:7:0 0,12,144:4:0 0,12,146:4:0 +X 2519 . C <*> 0 . DP=16;I16=7,8,0,0,531,20111,0,0,900,54000,0,0,282,6078,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,175:7:0 0,12,141:4:0 0,12,125:4:0 +X 2520 . G <*> 0 . DP=15;I16=6,8,0,0,501,19731,0,0,840,50400,0,0,277,5923,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,187:7:0 0,12,129:4:0 0,9,101:3:0 +X 2521 . C <*> 0 . DP=15;I16=6,8,0,0,583,25777,0,0,840,50400,0,0,272,5782,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,214:7:0 0,12,149:4:0 0,9,111:3:0 +X 2522 . A <*> 0 . DP=16;I16=6,8,0,0,516,20930,0,0,840,50400,0,0,266,5606,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,173:7:0 0,12,139:4:0 0,9,114:3:0 +X 2523 . T <*> 0 . DP=16;I16=6,9,0,0,588,25538,0,0,900,54000,0,0,270,5546,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,207:7:0 0,15,157:5:0 0,9,117:3:0 +X 2524 . C <*> 0 . DP=16;I16=5,9,0,0,548,23502,0,0,840,50400,0,0,256,5342,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,182:6:0 0,15,156:5:0 0,9,112:3:0 +X 2525 . A C,<*> 0 . DP=17;I16=6,9,0,1,550,23138,28,784,900,54000,60,3600,248,5174,12,144;QS=2.86,0.14,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=1;BQB=1;MQ0F=0 PL:DP:DV 0,24,168,24,168,168:8:0 13,0,138,25,141,159:5:1 0,9,117,9,117,117:3:0 +X 2526 . C <*> 0 . DP=18;I16=6,11,0,0,677,28649,0,0,1020,61200,0,0,256,5232,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,229:9:0 0,15,183:5:0 0,9,113:3:0 +X 2527 . T <*> 0 . DP=18;I16=6,11,0,0,674,29286,0,0,1020,61200,0,0,252,5118,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,217:9:0 0,15,183:5:0 0,9,119:3:0 +X 2528 . G <*> 0 . DP=18;I16=6,11,0,0,701,30729,0,0,1020,61200,0,0,248,5028,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,234:9:0 0,15,184:5:0 0,9,119:3:0 +X 2529 . C <*> 0 . DP=18;I16=6,11,0,0,676,28974,0,0,1020,61200,0,0,244,4962,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,228:9:0 0,15,175:5:0 0,9,117:3:0 +X 2530 . A <*> 0 . DP=18;I16=6,10,0,0,624,26620,0,0,960,57600,0,0,223,4631,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,209:9:0 0,12,153:4:0 0,9,116:3:0 +X 2531 . T <*> 0 . DP=17;I16=6,10,0,0,641,27911,0,0,960,57600,0,0,236,4852,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,210:8:0 0,15,175:5:0 0,9,122:3:0 +X 2532 . T <*> 0 . DP=17;I16=6,10,0,0,634,27460,0,0,960,57600,0,0,230,4708,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,212:8:0 0,15,173:5:0 0,9,117:3:0 +X 2533 . C <*> 0 . DP=18;I16=6,11,0,0,614,24196,0,0,1020,61200,0,0,224,4588,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,212:9:0 0,15,159:5:0 0,9,104:3:0 +X 2534 . C <*> 0 . DP=16;I16=5,10,0,0,595,25141,0,0,900,54000,0,0,221,4491,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,202:8:0 0,12,144:4:0 0,9,110:3:0 +X 2535 . A <*> 0 . DP=16;I16=5,10,0,0,617,27711,0,0,900,54000,0,0,218,4416,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,204:8:0 0,12,136:4:0 0,9,123:3:0 +X 2536 . G <*> 0 . DP=15;I16=4,10,0,0,543,23023,0,0,840,50400,0,0,216,4362,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,195:8:0 0,9,102:3:0 0,9,117:3:0 +X 2537 . C <*> 0 . DP=15;I16=4,10,0,0,555,24075,0,0,840,50400,0,0,213,4279,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,195:8:0 0,9,113:3:0 0,9,115:3:0 +X 2538 . C <*> 0 . DP=15;I16=5,9,0,0,510,21070,0,0,840,50400,0,0,211,4217,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,157:7:0 0,9,129:3:0 0,12,126:4:0 +X 2539 . C <*> 0 . DP=15;I16=5,9,0,0,464,16896,0,0,840,50400,0,0,209,4125,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,146:7:0 0,9,122:3:0 0,12,111:4:0 +X 2540 . G <*> 0 . DP=16;I16=6,9,0,0,548,21860,0,0,900,54000,0,0,207,4053,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,189:7:0 0,12,139:4:0 0,12,110:4:0 +X 2541 . G <*> 0 . DP=15;I16=5,9,0,0,535,22527,0,0,840,50400,0,0,207,4001,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,170:7:0 0,9,117:3:0 0,12,140:4:0 +X 2542 . T <*> 0 . DP=15;I16=4,9,0,0,527,23207,0,0,780,46800,0,0,203,3953,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,183:7:0 0,9,125:3:0 0,9,109:3:0 +X 2543 . G <*> 0 . DP=15;I16=5,9,0,0,540,23004,0,0,840,50400,0,0,207,3957,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,196:7:0 0,9,117:3:0 0,12,117:4:0 +X 2544 . A <*> 0 . DP=16;I16=6,9,0,0,569,24139,0,0,900,54000,0,0,207,3965,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,202:8:0 0,9,119:3:0 0,12,132:4:0 +X 2545 . C <*> 0 . DP=16;I16=6,9,0,0,583,24657,0,0,900,54000,0,0,208,3994,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,217:8:0 0,9,118:3:0 0,12,130:4:0 +X 2546 . A <*> 0 . DP=16;I16=6,9,0,0,608,27290,0,0,900,54000,0,0,209,4045,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,206:8:0 0,9,133:3:0 0,12,144:4:0 +X 2547 . G <*> 0 . DP=16;I16=6,9,0,0,597,26215,0,0,900,54000,0,0,211,4117,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,191:7:0 0,9,131:3:0 0,15,150:5:0 +X 2548 . A <*> 0 . DP=16;I16=6,9,0,0,632,28806,0,0,900,54000,0,0,214,4210,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,196:7:0 0,9,131:3:0 0,15,171:5:0 +X 2549 . G <*> 0 . DP=16;I16=6,9,0,0,594,25254,0,0,900,54000,0,0,217,4325,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,180:7:0 0,9,132:3:0 0,15,160:5:0 +X 2550 . T <*> 0 . DP=16;I16=6,9,0,0,572,24134,0,0,900,54000,0,0,219,4413,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,182:7:0 0,9,122:3:0 0,15,148:5:0 +X 2551 . G <*> 0 . DP=16;I16=6,9,0,0,578,24606,0,0,900,54000,0,0,220,4474,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,181:7:0 0,9,131:3:0 0,15,151:5:0 +X 2552 . A <*> 0 . DP=15;I16=6,8,0,0,585,26419,0,0,840,50400,0,0,221,4505,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,178:6:0 0,9,129:3:0 0,15,168:5:0 +X 2553 . G <*> 0 . DP=15;I16=6,8,0,0,528,21944,0,0,840,50400,0,0,222,4554,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,170:6:0 0,9,117:3:0 0,15,142:5:0 +X 2554 . T <*> 0 . DP=15;I16=6,8,0,0,543,23015,0,0,840,50400,0,0,223,4621,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,156:6:0 0,9,129:3:0 0,15,160:5:0 +X 2555 . C <*> 0 . DP=15;I16=6,8,0,0,566,24416,0,0,840,50400,0,0,224,4706,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,173:6:0 0,9,131:3:0 0,15,159:5:0 +X 2556 . A <*> 0 . DP=14;I16=6,7,0,0,487,20095,0,0,780,46800,0,0,226,4808,0,0;QS=3,0;MQSB=0.961166;MQ0F=0 PL:DP:DV 0,15,141:5:0 0,9,125:3:0 0,15,146:5:0 +X 2557 . C <*> 0 . DP=13;I16=5,8,0,0,471,17481,0,0,780,46800,0,0,249,5325,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,15,161:5:0 0,9,96:3:0 0,15,151:5:0 +X 2558 . T <*> 0 . DP=14;I16=5,9,0,0,535,20597,0,0,840,50400,0,0,251,5417,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,173:6:0 0,9,99:3:0 0,15,174:5:0 +X 2559 . G <*> 0 . DP=14;I16=5,9,0,0,509,18693,0,0,840,50400,0,0,253,5475,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,172:6:0 0,9,98:3:0 0,15,156:5:0 +X 2560 . T <*> 0 . DP=14;I16=5,9,0,0,489,17587,0,0,840,50400,0,0,255,5549,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,160:6:0 0,9,106:3:0 0,15,144:5:0 +X 2561 . C <*> 0 . DP=14;I16=5,9,0,0,489,17477,0,0,840,50400,0,0,257,5639,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,164:6:0 0,9,96:3:0 0,15,153:5:0 +X 2562 . T <*> 0 . DP=13;I16=5,8,0,0,460,17016,0,0,780,46800,0,0,260,5744,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,15,139:5:0 0,9,99:3:0 0,15,167:5:0 +X 2563 . C <*> 0 . DP=14;I16=5,8,0,0,433,15133,0,0,780,46800,0,0,263,5863,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,15,149:5:0 0,9,83:3:0 0,15,142:5:0 +X 2564 . A G,<*> 0 . DP=15;I16=1,4,4,5,174,6124,316,11352,300,18000,540,32400,61,1311,184,4034;QS=0.988263,2.01174,0;VDB=0.690812;SGB=-3.20711;RPB=0.197899;MQB=1;MQSB=1;BQB=0.965069;MQ0F=0 PL:DP:DV 88,0,78,98,87,171:6:3 57,0,56,63,62,117:4:2 124,12,0,124,12,124:4:4 +X 2565 . A <*> 0 . DP=15;I16=6,9,0,0,562,21216,0,0,900,54000,0,0,274,6076,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,178:6:0 0,12,134:4:0 0,15,166:5:0 +X 2566 . A <*> 0 . DP=15;I16=6,9,0,0,545,20019,0,0,900,54000,0,0,276,6098,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,181:6:0 0,12,120:4:0 0,15,162:5:0 +X 2567 . A <*> 0 . DP=16;I16=7,9,0,0,580,21342,0,0,960,57600,0,0,278,6136,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,177:6:0 0,15,151:5:0 0,15,166:5:0 +X 2568 . A <*> 0 . DP=16;I16=7,8,0,0,555,20795,0,0,900,54000,0,0,256,5566,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,180:6:0 0,12,132:4:0 0,15,167:5:0 +X 2569 . A <*> 0 . DP=17;I16=7,10,0,0,661,25943,0,0,1020,61200,0,0,284,6264,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,213:7:0 0,15,163:5:0 0,15,172:5:0 +X 2570 . G <*> 0 . DP=18;I16=8,10,0,0,664,24968,0,0,1080,64800,0,0,287,6305,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,213:7:0 0,15,152:5:0 0,18,176:6:0 +X 2571 . A <*> 0 . DP=18;I16=8,10,0,0,618,21870,0,0,1080,64800,0,0,291,6365,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,195:7:0 0,15,155:5:0 0,18,155:6:0 +X 2572 . A <*> 0 . DP=18;I16=8,10,0,0,631,22829,0,0,1080,64800,0,0,295,6445,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,194:7:0 0,15,150:5:0 0,18,173:6:0 +X 2573 . A <*> 0 . DP=18;I16=8,10,0,0,690,26830,0,0,1080,64800,0,0,298,6494,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,210:7:0 0,15,170:5:0 0,18,183:6:0 +X 2574 . G <*> 0 . DP=18;I16=8,10,0,0,664,24884,0,0,1080,64800,0,0,301,6561,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,211:7:0 0,15,152:5:0 0,18,176:6:0 +X 2575 . G <*> 0 . DP=18;I16=8,10,0,0,642,23904,0,0,1080,64800,0,0,305,6645,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,242:8:0 0,15,145:5:0 0,15,140:5:0 +X 2576 . A <*> 0 . DP=18;I16=7,10,0,0,595,21311,0,0,1020,61200,0,0,285,6121,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,210:8:0 0,15,153:5:0 0,12,131:4:0 +X 2577 . A <*> 0 . DP=19;I16=8,10,0,0,682,26398,0,0,1080,64800,0,0,290,6240,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,244:8:0 0,15,161:5:0 0,15,155:5:0 +X 2578 . G <*> 0 . DP=18;I16=9,9,0,0,643,24115,0,0,1080,64800,0,0,322,7002,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,249:8:0 0,12,114:4:0 0,18,161:6:0 +X 2579 . A <*> 0 . DP=18;I16=9,8,0,0,634,23870,0,0,1020,61200,0,0,304,6532,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,229:8:0 0,9,110:3:0 0,18,176:6:0 +X 2580 . A <*> 0 . DP=18;I16=9,9,0,0,629,22593,0,0,1080,64800,0,0,336,7330,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,223:8:0 0,12,117:4:0 0,18,169:6:0 +X 2581 . A <*> 0 . DP=19;I16=10,9,0,0,691,25669,0,0,1140,68400,0,0,343,7521,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,12,133:4:0 0,18,166:6:0 +X 2582 . T <*> 0 . DP=19;I16=10,9,0,0,674,24218,0,0,1140,68400,0,0,350,7682,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,235:9:0 0,12,138:4:0 0,18,168:6:0 +X 2583 . A <*> 0 . DP=19;I16=10,9,0,0,693,25465,0,0,1140,68400,0,0,357,7865,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,247:9:0 0,12,126:4:0 0,18,178:6:0 +X 2584 . A <*> 0 . DP=19;I16=10,9,0,0,702,26340,0,0,1140,68400,0,0,363,8019,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,243:9:0 0,12,134:4:0 0,18,187:6:0 +X 2585 . A <*> 0 . DP=19;I16=9,9,0,0,690,26700,0,0,1080,64800,0,0,350,7818,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,250:9:0 0,9,114:3:0 0,18,190:6:0 +X 2586 . G <*> 0 . DP=19;I16=10,9,0,0,714,27314,0,0,1140,68400,0,0,373,8283,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,12,127:4:0 0,18,176:6:0 +X 2587 . A <*> 0 . DP=20;I16=9,9,0,0,665,24781,0,0,1049,62041,0,0,343,7717,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,137:4:0 0,12,136:4:0 +X 2588 . A <*> 0 . DP=21;I16=12,9,0,0,737,26531,0,0,1229,72841,0,0,384,8620,0,0;QS=3,0;MQSB=0.950149;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,138:4:0 0,18,162:6:0 +X 2589 . A <*> 0 . DP=22;I16=13,9,0,0,780,28412,0,0,1289,76441,0,0,390,8770,0,0;QS=3,0;MQSB=0.955854;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,142:4:0 0,18,170:6:0 +X 2590 . A <*> 0 . DP=22;I16=13,9,0,0,774,28352,0,0,1289,76441,0,0,396,8894,0,0;QS=3,0;MQSB=0.955854;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,135:4:0 0,18,160:6:0 +X 2591 . C <*> 0 . DP=21;I16=13,8,0,0,765,28617,0,0,1229,72841,0,0,403,9041,0,0;QS=3,0;MQSB=0.95891;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,136:4:0 0,15,136:5:0 +X 2592 . A <*> 0 . DP=21;I16=13,8,0,0,763,28325,0,0,1229,72841,0,0,410,9210,0,0;QS=3,0;MQSB=0.95891;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,140:4:0 0,15,139:5:0 +X 2593 . A <*> 0 . DP=21;I16=13,8,0,0,754,27888,0,0,1229,72841,0,0,416,9350,0,0;QS=3,0;MQSB=0.95891;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,141:4:0 0,15,147:5:0 +X 2594 . A <*> 0 . DP=21;I16=13,8,0,0,775,29179,0,0,1229,72841,0,0,422,9510,0,0;QS=3,0;MQSB=0.95891;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,130:4:0 0,15,153:5:0 +X 2595 . T <*> 0 . DP=22;I16=14,8,0,0,766,27472,0,0,1289,76441,0,0,427,9639,0,0;QS=3,0;MQSB=0.963419;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,119:4:0 0,15,143:5:0 +X 2596 . A <*> 0 . DP=22;I16=13,8,0,0,751,27409,0,0,1229,72841,0,0,407,9111,0,0;QS=3,0;MQSB=0.95891;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,123:4:0 0,12,129:4:0 +X 2597 . A <*> 0 . DP=22;I16=14,8,0,0,811,30147,0,0,1289,76441,0,0,437,9851,0,0;QS=3,0;MQSB=0.963419;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,145:4:0 0,15,145:5:0 +X 2598 . A <*> 0 . DP=22;I16=14,8,0,0,817,30915,0,0,1289,76441,0,0,442,9984,0,0;QS=3,0;MQSB=0.963419;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,136:4:0 0,15,159:5:0 +X 2599 . A <*> 0 . DP=22;I16=14,8,0,0,800,29912,0,0,1289,76441,0,0,447,10135,0,0;QS=3,0;MQSB=0.963419;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,126:4:0 0,15,150:5:0 +X 2600 . A <*> 0 . DP=22;I16=14,8,0,0,784,29138,0,0,1289,76441,0,0,451,10255,0,0;QS=3,0;MQSB=0.963419;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,113:4:0 0,15,150:5:0 +X 2601 . T <*> 0 . DP=22;I16=14,8,0,0,770,27820,0,0,1289,76441,0,0,454,10344,0,0;QS=3,0;MQSB=0.963419;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,118:4:0 0,15,142:5:0 +X 2602 . A <*> 0 . DP=23;I16=15,8,0,0,825,29971,0,0,1349,80041,0,0,457,10451,0,0;QS=3,0;MQSB=0.967216;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,143:4:0 0,18,154:6:0 +X 2603 . A <*> 0 . DP=23;I16=15,8,0,0,862,32840,0,0,1349,80041,0,0,460,10526,0,0;QS=3,0;MQSB=0.967216;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,138:4:0 0,18,172:6:0 +X 2604 . T <*> 0 . DP=23;I16=15,8,0,0,822,29902,0,0,1349,80041,0,0,463,10619,0,0;QS=3,0;MQSB=0.967216;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,129:4:0 0,18,154:6:0 +X 2605 . A <*> 0 . DP=23;I16=14,8,0,0,845,32617,0,0,1289,76441,0,0,441,10105,0,0;QS=3,0;MQSB=0.963419;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,143:4:0 0,15,157:5:0 +X 2606 . G <*> 0 . DP=23;I16=14,8,0,0,812,30796,0,0,1289,76441,0,0,444,10234,0,0;QS=3,0;MQSB=0.963419;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,129:4:0 0,15,142:5:0 +X 2607 . T <*> 0 . DP=22;I16=15,7,0,0,782,28440,0,0,1289,76441,0,0,472,10954,0,0;QS=3,0;MQSB=0.970024;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,119:4:0 0,15,132:5:0 +X 2608 . G <*> 0 . DP=22;I16=15,7,0,0,851,33169,0,0,1289,76441,0,0,474,11014,0,0;QS=3,0;MQSB=0.970024;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,132:4:0 0,15,127:5:0 +X 2609 . C <*> 0 . DP=22;I16=15,7,0,0,796,29454,0,0,1289,76441,0,0,475,11041,0,0;QS=3,0;MQSB=0.970024;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,137:4:0 0,15,124:5:0 +X 2610 . A <*> 0 . DP=22;I16=15,7,0,0,830,31684,0,0,1289,76441,0,0,476,11086,0,0;QS=3,0;MQSB=0.970024;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,146:4:0 0,15,121:5:0 +X 2611 . G <*> 0 . DP=22;I16=15,7,0,0,824,32048,0,0,1289,76441,0,0,477,11149,0,0;QS=3,0;MQSB=0.970024;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,129:4:0 0,15,122:5:0 +X 2612 . A <*> 0 . DP=22;I16=14,7,0,0,771,29035,0,0,1229,72841,0,0,453,10605,0,0;QS=3,0;MQSB=0.966484;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,130:4:0 0,12,117:4:0 +X 2613 . C <*> 0 . DP=22;I16=15,7,0,0,832,31926,0,0,1289,76441,0,0,478,11278,0,0;QS=3,0;MQSB=0.970024;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,138:4:0 0,15,120:5:0 +X 2614 . A <*> 0 . DP=21;I16=15,6,0,0,791,30065,0,0,1229,72841,0,0,477,11241,0,0;QS=3,0;MQSB=0.973096;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,110:3:0 0,15,140:5:0 +X 2615 . A <*> 0 . DP=21;I16=15,6,0,0,777,29101,0,0,1229,72841,0,0,475,11167,0,0;QS=3,0;MQSB=0.973096;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,99:3:0 0,15,142:5:0 +X 2616 . A <*> 0 . DP=21;I16=15,6,0,0,734,26922,0,0,1229,72841,0,0,472,11056,0,0;QS=3,0;MQSB=0.973096;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,90:3:0 0,15,144:5:0 +X 2617 . A <*> 0 . DP=21;I16=15,6,0,0,810,31654,0,0,1229,72841,0,0,469,10959,0,0;QS=3,0;MQSB=0.973096;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,95:3:0 0,15,140:5:0 +X 2618 . G <*> 0 . DP=23;I16=16,6,0,0,863,34219,0,0,1289,76441,0,0,441,10251,0,0;QS=3,0;MQSB=0.97584;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,74:2:0 0,15,132:5:0 +X 2619 . G <*> 0 . DP=23;I16=16,6,0,0,807,30109,0,0,1289,76441,0,0,439,10135,0,0;QS=3,0;MQSB=0.97584;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,66:2:0 0,15,127:5:0 +X 2620 . C <*> 0 . DP=23;I16=16,7,0,0,780,28242,0,0,1349,80041,0,0,462,10664,0,0;QS=3,0;MQSB=0.973027;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,87:3:0 0,15,115:5:0 +X 2621 . C <*> 0 . DP=23;I16=16,7,0,0,860,32944,0,0,1349,80041,0,0,459,10537,0,0;QS=3,0;MQSB=0.973027;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,112:3:0 0,15,124:5:0 +X 2622 . T <*> 0 . DP=24;I16=17,7,0,0,908,35474,0,0,1409,83641,0,0,456,10428,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,115:3:0 0,15,134:5:0 +X 2623 . T <*> 0 . DP=24;I16=17,7,0,0,850,30978,0,0,1409,83641,0,0,453,10289,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,114:3:0 0,15,129:5:0 +X 2624 . G <*> 0 . DP=24;I16=17,7,0,0,882,33332,0,0,1409,83641,0,0,450,10172,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,101:3:0 0,15,133:5:0 +X 2625 . A <*> 0 . DP=23;I16=17,6,0,0,855,32593,0,0,1349,80041,0,0,448,10076,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,114:3:0 0,15,135:5:0 +X 2626 . C <*> 0 . DP=23;I16=17,6,0,0,847,31625,0,0,1349,80041,0,0,446,10000,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,100:3:0 0,15,122:5:0 +X 2627 . C <*> 0 . DP=23;I16=17,6,0,0,863,32865,0,0,1349,80041,0,0,444,9944,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,104:3:0 0,15,129:5:0 +X 2628 . C <*> 0 . DP=24;I16=17,6,0,0,793,28559,0,0,1349,80041,0,0,431,9757,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,95:3:0 0,15,127:5:0 +X 2629 . A <*> 0 . DP=24;I16=18,6,0,0,893,33537,0,0,1409,83641,0,0,439,9789,0,0;QS=3,0;MQSB=0.980199;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,101:3:0 0,18,148:6:0 +X 2630 . T <*> 0 . DP=24;I16=17,6,0,0,836,31094,0,0,1380,82800,0,0,412,9116,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,112:3:0 0,18,140:6:0 +X 2631 . C <*> 0 . DP=24;I16=18,6,0,0,900,34378,0,0,1409,83641,0,0,435,9713,0,0;QS=3,0;MQSB=0.980199;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,104:3:0 0,18,142:6:0 +X 2632 . T <*> 0 . DP=24;I16=18,6,0,0,937,37097,0,0,1409,83641,0,0,433,9705,0,0;QS=3,0;MQSB=0.980199;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,113:3:0 0,18,164:6:0 +X 2633 . A <*> 0 . DP=23;I16=18,5,0,0,801,28913,0,0,1349,80041,0,0,431,9667,0,0;QS=3,0;MQSB=0.982789;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,95:3:0 0,18,148:6:0 +X 2634 . G <*> 0 . DP=23;I16=19,3,0,0,861,34125,0,0,1289,76441,0,0,405,9023,0,0;QS=3,0;MQSB=0.989755;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,74:2:0 0,18,149:6:0 +X 2635 . C <*> 0 . DP=23;I16=19,4,0,0,848,32154,0,0,1349,80041,0,0,429,9599,0,0;QS=3,0;MQSB=0.986928;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,107:3:0 0,18,148:6:0 +X 2636 . T <*> 0 . DP=24;I16=19,4,0,0,871,33973,0,0,1349,80041,0,0,428,9572,0,0;QS=3,0;MQSB=0.986928;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,98:3:0 0,18,160:6:0 +X 2637 . T <*> 0 . DP=24;I16=19,5,0,0,871,32073,0,0,1409,83641,0,0,428,9568,0,0;QS=3,0;MQSB=0.984335;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,111:3:0 0,18,144:6:0 +X 2638 . T <*> 0 . DP=24;I16=19,5,0,0,821,28851,0,0,1409,83641,0,0,428,9588,0,0;QS=3,0;MQSB=0.984335;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,103:3:0 0,18,135:6:0 +X 2639 . G <*> 0 . DP=24;I16=18,6,0,0,842,30840,0,0,1409,83641,0,0,428,9582,0,0;QS=3,0;MQSB=0.980199;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,106:3:0 0,15,125:5:0 +X 2640 . G <*> 0 . DP=24;I16=17,6,0,0,749,25957,0,0,1380,82800,0,0,404,8976,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,84:3:0 0,15,117:5:0 +X 2641 . C <*> 0 . DP=23;I16=17,6,0,0,834,31792,0,0,1349,80041,0,0,431,9645,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,61:2:0 0,15,129:5:0 +X 2642 . C <*> 0 . DP=23;I16=17,6,0,0,809,30033,0,0,1349,80041,0,0,433,9713,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,58:2:0 0,15,131:5:0 +X 2643 . C <*> 0 . DP=23;I16=17,6,0,0,856,33004,0,0,1349,80041,0,0,434,9756,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,57:2:0 0,15,133:5:0 +X 2644 . T <*> 0 . DP=22;I16=16,5,0,0,805,31419,0,0,1229,72841,0,0,428,9648,0,0;QS=3,0;MQSB=0.978919;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,73:2:0 0,15,143:5:0 +X 2645 . C <*> 0 . DP=22;I16=15,6,0,0,823,32499,0,0,1229,72841,0,0,415,9323,0,0;QS=3,0;MQSB=0.973096;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,78:2:0 0,12,122:4:0 +X 2646 . A <*> 0 . DP=22;I16=16,6,0,0,826,31566,0,0,1289,76441,0,0,430,9524,0,0;QS=3,0;MQSB=0.97584;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,79:2:0 0,15,129:5:0 +X 2647 . G <*> 0 . DP=22;I16=16,6,0,0,803,30643,0,0,1289,76441,0,0,428,9460,0,0;QS=3,0;MQSB=0.97584;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,77:2:0 0,15,129:5:0 +X 2648 . C <*> 0 . DP=21;I16=15,6,0,0,811,31709,0,0,1229,72841,0,0,426,9368,0,0;QS=3,0;MQSB=0.973096;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,80:2:0 0,12,118:4:0 +X 2649 . A <*> 0 . DP=23;I16=16,6,0,0,789,29215,0,0,1258,73682,0,0,414,9196,0,0;QS=3,0;MQSB=0.934321;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,93:3:0 0,12,105:4:0 +X 2650 . T <*> 0 . DP=23;I16=16,7,0,0,856,32340,0,0,1318,77282,0,0,423,9197,0,0;QS=3,0;MQSB=0.955805;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,103:3:0 0,12,118:4:0 +X 2651 . C <*> 0 . DP=23;I16=16,7,0,0,871,33599,0,0,1318,77282,0,0,422,9124,0,0;QS=3,0;MQSB=0.955805;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,95:3:0 0,12,121:4:0 +X 2652 . A <*> 0 . DP=23;I16=16,7,0,0,820,30324,0,0,1318,77282,0,0,421,9077,0,0;QS=3,0;MQSB=0.955805;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,87:3:0 0,12,126:4:0 +X 2653 . A <*> 0 . DP=23;I16=15,6,0,0,759,28489,0,0,1198,70082,0,0,389,8395,0,0;QS=3,0;MQSB=0.940481;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,73:2:0 0,9,109:3:0 +X 2654 . C <*> 0 . DP=23;I16=16,7,0,0,836,31006,0,0,1318,77282,0,0,393,8385,0,0;QS=3,0;MQSB=0.955805;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,9,88:3:0 0,9,99:3:0 +X 2655 . C <*> 0 . DP=23;I16=16,7,0,0,774,27190,0,0,1318,77282,0,0,392,8364,0,0;QS=3,0;MQSB=0.955805;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,9,83:3:0 0,9,95:3:0 +X 2656 . G <*> 0 . DP=24;I16=17,7,0,0,781,25689,0,0,1378,80882,0,0,390,8320,0,0;QS=3,0;MQSB=0.95083;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,116:4:0 0,9,74:3:0 +X 2657 . C <*> 0 . DP=24;I16=17,6,0,0,871,33435,0,0,1349,80041,0,0,381,8241,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,9,98:3:0 0,9,99:3:0 +X 2658 . T <*> 0 . DP=23;I16=17,6,0,0,897,35255,0,0,1318,77282,0,0,389,8319,0,0;QS=3,0;MQSB=0.92854;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,133:4:0 0,9,107:3:0 +X 2659 . A <*> 0 . DP=23;I16=17,6,0,0,817,29729,0,0,1318,77282,0,0,389,8361,0,0;QS=3,0;MQSB=0.92854;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,120:4:0 0,9,93:3:0 +X 2660 . G <*> 0 . DP=23;I16=17,6,0,0,900,35462,0,0,1318,77282,0,0,389,8379,0,0;QS=3,0;MQSB=0.92854;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,126:4:0 0,9,94:3:0 +X 2661 . A <*> 0 . DP=24;I16=18,6,0,0,871,32185,0,0,1378,80882,0,0,390,8422,0,0;QS=3,0;MQSB=0.923116;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,127:4:0 0,9,104:3:0 +X 2662 . T <*> 0 . DP=24;I16=17,6,0,0,836,30812,0,0,1349,80041,0,0,366,7816,0,0;QS=3,0;MQSB=0.83771;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,122:4:0 0,9,99:3:0 +X 2663 . A <*> 0 . DP=24;I16=17,6,0,0,827,30583,0,0,1318,77282,0,0,389,8341,0,0;QS=3,0;MQSB=0.92854;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,104:4:0 0,9,101:3:0 +X 2664 . C <*> 0 . DP=23;I16=17,6,0,0,787,28083,0,0,1318,77282,0,0,388,8270,0,0;QS=3,0;MQSB=0.92854;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,107:4:0 0,9,91:3:0 +X 2665 . G <*> 0 . DP=23;I16=17,6,0,0,728,23290,0,0,1318,77282,0,0,386,8178,0,0;QS=3,0;MQSB=0.92854;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,112:4:0 0,9,78:3:0 +X 2666 . T <*> 0 . DP=23;I16=17,5,0,0,799,29273,0,0,1289,76441,0,0,367,7825,0,0;QS=3,0;MQSB=0.981001;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,105:3:0 0,9,94:3:0 +X 2667 . C <*> 0 . DP=23;I16=16,5,0,0,792,30190,0,0,1260,75600,0,0,345,7393,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,96:3:0 0,9,98:3:0 +X 2668 . C <*> 0 . DP=24;I16=18,6,0,0,832,29692,0,0,1378,80882,0,0,381,8069,0,0;QS=3,0;MQSB=0.923116;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,107:4:0 0,9,95:3:0 +X 2669 . C <*> 0 . DP=23;I16=18,5,0,0,829,30953,0,0,1318,77282,0,0,383,8087,0,0;QS=3,0;MQSB=0.889264;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,120:4:0 0,9,88:3:0 +X 2670 . T <*> 0 . DP=23;I16=17,5,0,0,841,32669,0,0,1289,76441,0,0,368,7828,0,0;QS=3,0;MQSB=0.801124;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,131:4:0 0,9,100:3:0 +X 2671 . C <*> 0 . DP=22;I16=17,5,0,0,842,32448,0,0,1258,73682,0,0,386,8110,0,0;QS=3,0;MQSB=0.895399;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,128:4:0 0,6,70:2:0 +X 2672 . C <*> 0 . DP=22;I16=17,5,0,0,808,30180,0,0,1258,73682,0,0,388,8164,0,0;QS=3,0;MQSB=0.895399;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,129:4:0 0,6,75:2:0 +X 2673 . C <*> 0 . DP=22;I16=17,5,0,0,842,32528,0,0,1258,73682,0,0,390,8246,0,0;QS=3,0;MQSB=0.895399;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,133:4:0 0,6,75:2:0 +X 2674 . T <*> 0 . DP=23;I16=17,6,0,0,860,33242,0,0,1318,77282,0,0,392,8356,0,0;QS=3,0;MQSB=0.92854;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,142:4:0 0,6,79:2:0 +X 2675 . T <*> 0 . DP=22;I16=16,6,0,0,756,26986,0,0,1258,73682,0,0,394,8392,0,0;QS=3,0;MQSB=0.934321;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,134:4:0 0,6,74:2:0 +X 2676 . T <*> 0 . DP=22;I16=16,6,0,0,774,28022,0,0,1258,73682,0,0,396,8452,0,0;QS=3,0;MQSB=0.934321;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,135:4:0 0,6,75:2:0 +X 2677 . C <*> 0 . DP=22;I16=16,6,0,0,866,34444,0,0,1258,73682,0,0,398,8536,0,0;QS=3,0;MQSB=0.934321;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,131:4:0 0,6,77:2:0 +X 2678 . T <*> 0 . DP=22;I16=16,5,0,0,818,32216,0,0,1229,72841,0,0,374,7970,0,0;QS=3,0;MQSB=0.978919;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,111:3:0 0,6,80:2:0 +X 2679 . T <*> 0 . DP=22;I16=16,6,0,0,808,29912,0,0,1258,73682,0,0,400,8680,0,0;QS=3,0;MQSB=0.934321;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,137:4:0 0,6,75:2:0 +X 2680 . C <*> 0 . DP=23;I16=16,7,0,0,873,33605,0,0,1318,77282,0,0,400,8740,0,0;QS=3,0;MQSB=0.955805;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,131:4:0 0,6,70:2:0 +X 2681 . T <*> 0 . DP=22;I16=15,7,0,0,820,31248,0,0,1258,73682,0,0,402,8824,0,0;QS=3,0;MQSB=0.961028;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,133:4:0 0,6,75:2:0 +X 2682 . G <*> 0 . DP=22;I16=15,7,0,0,831,31865,0,0,1258,73682,0,0,403,8881,0,0;QS=3,0;MQSB=0.961028;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,135:4:0 0,6,64:2:0 +X 2683 . G <*> 0 . DP=22;I16=13,6,0,0,702,26368,0,0,1109,65641,0,0,394,8926,0,0;QS=3,0;MQSB=0.850016;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,136:4:0 0,6,53:2:0 +X 2684 . G <*> 0 . DP=22;I16=14,7,0,0,754,27678,0,0,1229,72841,0,0,403,9057,0,0;QS=3,0;MQSB=0.872525;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,128:4:0 0,6,62:2:0 +X 2685 . G <*> 0 . DP=22;I16=15,7,0,0,736,25916,0,0,1258,73682,0,0,406,9184,0,0;QS=3,0;MQSB=0.961028;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,130:4:0 0,6,45:2:0 +X 2686 . C <*> 0 . DP=22;I16=15,7,0,0,803,29933,0,0,1258,73682,0,0,406,9278,0,0;QS=3,0;MQSB=0.961028;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,134:4:0 0,6,68:2:0 +X 2687 . A <*> 0 . DP=21;I16=13,7,0,0,716,26356,0,0,1169,69241,0,0,406,9340,0,0;QS=3,0;MQSB=0.875769;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,136:4:0 0,6,61:2:0 +X 2688 . C <*> 0 . DP=20;I16=13,7,0,0,750,28308,0,0,1169,69241,0,0,407,9417,0,0;QS=3,0;MQSB=0.875769;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,134:4:0 0,6,66:2:0 +X 2689 . A <*> 0 . DP=19;I16=12,7,0,0,741,29105,0,0,1109,65641,0,0,409,9507,0,0;QS=3,0;MQSB=0.879351;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,140:4:0 0,6,73:2:0 +X 2690 . G <*> 0 . DP=20;I16=12,8,0,0,751,28929,0,0,1169,69241,0,0,411,9609,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,135:4:0 0,6,61:2:0 +X 2691 . G <*> 0 . DP=20;I16=12,7,0,0,682,25006,0,0,1109,65641,0,0,403,9603,0,0;QS=3,0;MQSB=0.879351;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,132:4:0 0,6,63:2:0 +X 2692 . T <*> 0 . DP=20;I16=12,8,0,0,648,21758,0,0,1169,69241,0,0,417,9853,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,125:4:0 0,6,72:2:0 +X 2693 . C <*> 0 . DP=20;I16=12,8,0,0,779,30645,0,0,1169,69241,0,0,418,9898,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,130:4:0 0,6,70:2:0 +X 2694 . A <*> 0 . DP=21;I16=13,8,0,0,723,25649,0,0,1229,72841,0,0,417,9859,0,0;QS=3,0;MQSB=0.895122;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,126:4:0 0,6,73:2:0 +X 2695 . C <*> 0 . DP=20;I16=12,8,0,0,757,28835,0,0,1169,69241,0,0,418,9834,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,130:4:0 0,6,63:2:0 +X 2696 . A <*> 0 . DP=20;I16=12,8,0,0,733,27357,0,0,1169,69241,0,0,419,9823,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,130:4:0 0,6,69:2:0 +X 2697 . C <*> 0 . DP=20;I16=12,8,0,0,738,27604,0,0,1169,69241,0,0,419,9777,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,128:4:0 0,6,66:2:0 +X 2698 . T <*> 0 . DP=21;I16=12,8,0,0,788,31268,0,0,1169,69241,0,0,419,9747,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,144:4:0 0,6,77:2:0 +X 2699 . C <*> 0 . DP=22;I16=13,9,0,0,864,34148,0,0,1258,73682,0,0,443,10309,0,0;QS=3,0;MQSB=0.686045;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,135:4:0 0,9,98:3:0 +X 2700 . T <*> 0 . DP=22;I16=13,9,0,0,850,33296,0,0,1258,73682,0,0,444,10310,0,0;QS=3,0;MQSB=0.686045;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,141:4:0 0,9,105:3:0 +X 2701 . C <*> 0 . DP=22;I16=13,9,0,0,863,34157,0,0,1258,73682,0,0,444,10278,0,0;QS=3,0;MQSB=0.686045;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,140:4:0 0,9,94:3:0 +X 2702 . T <*> 0 . DP=22;I16=13,9,0,0,837,32525,0,0,1258,73682,0,0,444,10262,0,0;QS=3,0;MQSB=0.686045;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,143:4:0 0,9,83:3:0 +X 2703 . T <*> 0 . DP=21;I16=12,8,0,0,717,25881,0,0,1169,69241,0,0,420,9636,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,130:4:0 0,3,32:1:0 +X 2704 . C <*> 0 . DP=21;I16=12,9,0,0,794,30766,0,0,1198,70082,0,0,445,10225,0,0;QS=3,0;MQSB=0.695144;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,137:4:0 0,6,55:2:0 +X 2705 . C <*> 0 . DP=21;I16=12,9,0,0,809,31649,0,0,1198,70082,0,0,445,10205,0,0;QS=3,0;MQSB=0.695144;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,136:4:0 0,6,56:2:0 +X 2706 . A <*> 0 . DP=22;I16=12,10,0,0,820,31386,0,0,1258,73682,0,0,444,10150,0,0;QS=3,0;MQSB=0.731218;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,141:4:0 0,6,70:2:0 +X 2707 . G <*> 0 . DP=22;I16=12,10,0,0,832,32104,0,0,1258,73682,0,0,444,10110,0,0;QS=3,0;MQSB=0.731218;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,139:4:0 0,6,60:2:0 +X 2708 . G <*> 0 . DP=22;I16=12,10,0,0,777,28329,0,0,1258,73682,0,0,444,10086,0,0;QS=3,0;MQSB=0.731218;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,136:4:0 0,6,57:2:0 +X 2709 . T <*> 0 . DP=22;I16=12,9,0,0,761,28341,0,0,1229,72841,0,0,418,9404,0,0;QS=3,0;MQSB=0.913101;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,137:4:0 0,3,39:1:0 +X 2710 . C <*> 0 . DP=23;I16=12,10,0,0,840,32478,0,0,1289,76441,0,0,417,9365,0,0;QS=3,0;MQSB=0.924723;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,134:4:0 0,3,38:1:0 +X 2711 . T <*> 0 . DP=24;I16=13,11,0,0,893,33721,0,0,1378,80882,0,0,442,9970,0,0;QS=3,0;MQSB=0.75304;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,12,138:4:0 0,6,72:2:0 +X 2712 . A <*> 0 . DP=24;I16=13,11,0,0,889,33333,0,0,1378,80882,0,0,443,9971,0,0;QS=3,0;MQSB=0.75304;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,12,141:4:0 0,6,65:2:0 +X 2713 . G T,<*> 0 . DP=25;I16=13,11,0,1,915,35485,14,196,1378,80882,29,841,419,9369,25,625;QS=2.72549,0.27451,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.569783;BQB=1;MQ0F=0 PL:DP:DV 0,57,255,57,255,255:19:0 0,12,131,12,131,131:4:0 8,0,31,11,34,42:2:1 +X 2714 . G <*> 0 . DP=25;I16=13,11,0,0,891,33457,0,0,1378,80882,0,0,444,9990,0,0;QS=3,0;MQSB=0.75304;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,12,132:4:0 0,6,64:2:0 +X 2715 . A <*> 0 . DP=25;I16=13,12,0,0,888,32012,0,0,1407,81723,0,0,446,10014,0,0;QS=3,0;MQSB=0.569783;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,12,135:4:0 0,6,63:2:0 +X 2716 . T <*> 0 . DP=26;I16=13,13,0,0,937,34241,0,0,1467,85323,0,0,446,10012,0,0;QS=3,0;MQSB=0.606531;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,12,134:4:0 0,9,90:3:0 +X 2717 . G <*> 0 . DP=26;I16=13,12,0,0,939,35995,0,0,1438,84482,0,0,422,9410,0,0;QS=3,0;MQSB=0.778801;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,12,134:4:0 0,6,72:2:0 +X 2718 . C <*> 0 . DP=24;I16=12,11,0,0,864,33118,0,0,1318,77282,0,0,425,9457,0,0;QS=3,0;MQSB=0.7613;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,130:4:0 0,6,65:2:0 +X 2719 . A <*> 0 . DP=24;I16=12,12,0,0,911,35371,0,0,1347,78123,0,0,452,10102,0,0;QS=3,0;MQSB=0.582748;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,139:4:0 0,9,99:3:0 +X 2720 . G <*> 0 . DP=24;I16=12,12,0,0,940,37044,0,0,1347,78123,0,0,453,10095,0,0;QS=3,0;MQSB=0.582748;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,136:4:0 0,9,97:3:0 +X 2721 . C <*> 0 . DP=24;I16=12,11,0,0,881,34499,0,0,1318,77282,0,0,429,9485,0,0;QS=3,0;MQSB=0.7613;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,131:4:0 0,6,76:2:0 +X 2722 . T <*> 0 . DP=24;I16=11,13,0,0,898,34310,0,0,1347,78123,0,0,456,10146,0,0;QS=3,0;MQSB=0.633229;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,156:5:0 0,9,98:3:0 +X 2723 . G <*> 0 . DP=25;I16=12,13,0,0,941,36257,0,0,1407,81723,0,0,459,10203,0,0;QS=3,0;MQSB=0.619223;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,184:6:0 0,9,76:3:0 +X 2724 . A <*> 0 . DP=25;I16=12,13,0,0,917,34211,0,0,1407,81723,0,0,462,10234,0,0;QS=3,0;MQSB=0.619223;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,188:6:0 0,9,84:3:0 +X 2725 . G <*> 0 . DP=25;I16=12,12,0,0,916,35656,0,0,1378,80882,0,0,438,9566,0,0;QS=3,0;MQSB=0.786628;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,185:6:0 0,6,67:2:0 +X 2726 . G <*> 0 . DP=25;I16=11,12,0,0,841,31809,0,0,1287,74523,0,0,437,9545,0,0;QS=3,0;MQSB=0.597127;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,186:6:0 0,6,46:2:0 +X 2727 . G <*> 0 . DP=25;I16=12,13,0,0,889,32233,0,0,1407,81723,0,0,464,10182,0,0;QS=3,0;MQSB=0.619223;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,194:7:0 0,6,56:2:0 +X 2728 . G <*> 0 . DP=25;I16=12,13,0,0,883,32287,0,0,1407,81723,0,0,467,10219,0,0;QS=3,0;MQSB=0.619223;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,189:7:0 0,6,50:2:0 +X 2729 . T <*> 0 . DP=25;I16=12,13,0,0,871,31019,0,0,1407,81723,0,0,469,10233,0,0;QS=3,0;MQSB=0.619223;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,189:7:0 0,6,62:2:0 +X 2730 . G <*> 0 . DP=25;I16=12,13,0,0,907,34299,0,0,1407,81723,0,0,471,10275,0,0;QS=3,0;MQSB=0.619223;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,192:7:0 0,6,49:2:0 +X 2731 . C <*> 0 . DP=25;I16=12,13,0,0,893,33027,0,0,1407,81723,0,0,473,10345,0,0;QS=3,0;MQSB=0.619223;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,192:7:0 0,6,52:2:0 +X 2732 . C <*> 0 . DP=25;I16=12,13,0,0,882,32170,0,0,1407,81723,0,0,473,10343,0,0;QS=3,0;MQSB=0.619223;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,195:7:0 0,6,38:2:0 +X 2733 . C A,<*> 0 . DP=25;I16=12,12,0,1,835,30063,13,169,1378,80882,29,841,448,9744,25,625;QS=2.64865,0.351351,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.619223;BQB=1;MQ0F=0 PL:DP:DV 0,48,255,48,255,255:16:0 0,21,187,21,187,187:7:0 7,0,18,10,21,28:2:1 +X 2734 . C <*> 0 . DP=25;I16=12,12,0,0,890,33726,0,0,1378,80882,0,0,449,9797,0,0;QS=3,0;MQSB=0.786628;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,24,208:8:0 0,3,39:1:0 +X 2735 . T <*> 0 . DP=26;I16=13,12,0,0,955,36875,0,0,1438,84482,0,0,451,9877,0,0;QS=3,0;MQSB=0.778801;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,228:8:0 0,3,41:1:0 +X 2736 . C <*> 0 . DP=26;I16=13,11,0,0,921,35553,0,0,1409,83641,0,0,428,9308,0,0;QS=3,0;MQSB=0.931547;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,24,220:8:0 0,3,33:1:0 +X 2737 . T <*> 0 . DP=26;I16=13,13,0,0,967,36581,0,0,1467,85323,0,0,475,10403,0,0;QS=3,0;MQSB=0.606531;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,228:8:0 0,6,64:2:0 +X 2738 . T <*> 0 . DP=26;I16=13,13,0,0,895,31873,0,0,1467,85323,0,0,474,10374,0,0;QS=3,0;MQSB=0.606531;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,201:8:0 0,6,47:2:0 +X 2739 . A <*> 0 . DP=26;I16=13,12,0,0,871,31051,0,0,1407,81723,0,0,448,9698,0,0;QS=3,0;MQSB=0.569783;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,224:8:0 0,9,78:3:0 +X 2740 . C <*> 0 . DP=26;I16=14,11,0,0,952,36456,0,0,1438,84482,0,0,448,9674,0,0;QS=3,0;MQSB=0.745495;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,24,216:8:0 0,6,71:2:0 +X 2741 . C <*> 0 . DP=26;I16=14,11,0,0,945,36141,0,0,1438,84482,0,0,448,9678,0,0;QS=3,0;MQSB=0.745495;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,24,215:8:0 0,6,75:2:0 +X 2742 . A <*> 0 . DP=27;I16=15,12,0,0,949,34263,0,0,1527,88923,0,0,472,10284,0,0;QS=3,0;MQSB=0.547344;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,27,230:9:0 0,9,92:3:0 +X 2743 . T <*> 0 . DP=27;I16=15,12,0,0,955,34479,0,0,1527,88923,0,0,471,10243,0,0;QS=3,0;MQSB=0.547344;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,27,224:9:0 0,9,99:3:0 +X 2744 . C <*> 0 . DP=26;I16=15,10,0,0,955,36951,0,0,1438,84482,0,0,445,9557,0,0;QS=3,0;MQSB=0.707404;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,234:9:0 0,6,76:2:0 +X 2745 . T <*> 0 . DP=26;I16=15,11,0,0,962,36786,0,0,1467,85323,0,0,469,10151,0,0;QS=3,0;MQSB=0.505697;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,243:9:0 0,9,104:3:0 +X 2746 . A <*> 0 . DP=26;I16=15,10,0,0,912,33536,0,0,1438,84482,0,0,443,9525,0,0;QS=3,0;MQSB=0.707404;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,235:9:0 0,6,78:2:0 +X 2747 . A <*> 0 . DP=26;I16=15,11,0,0,945,35117,0,0,1467,85323,0,0,467,10179,0,0;QS=3,0;MQSB=0.505697;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,238:9:0 0,9,96:3:0 +X 2748 . T <*> 0 . DP=27;I16=15,12,0,0,1005,37901,0,0,1527,88923,0,0,465,10187,0,0;QS=3,0;MQSB=0.547344;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,27,246:9:0 0,9,103:3:0 +X 2749 . C <*> 0 . DP=26;I16=14,12,0,0,975,37353,0,0,1467,85323,0,0,463,10123,0,0;QS=3,0;MQSB=0.558035;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,232:9:0 0,9,98:3:0 +X 2750 . T <*> 0 . DP=26;I16=15,11,0,0,982,37714,0,0,1498,88082,0,0,462,10086,0,0;QS=3,0;MQSB=0.738577;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,227:8:0 0,12,130:4:0 +X 2751 . G <*> 0 . DP=26;I16=15,10,0,0,945,36031,0,0,1469,87241,0,0,437,9451,0,0;QS=3,0;MQSB=0.9171;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,205:8:0 0,9,103:3:0 +X 2752 . T <*> 0 . DP=26;I16=15,11,0,0,870,30288,0,0,1498,88082,0,0,460,9998,0,0;QS=3,0;MQSB=0.738577;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,189:8:0 0,12,119:4:0 +X 2753 . G <*> 0 . DP=26;I16=15,11,0,0,867,30913,0,0,1498,88082,0,0,458,9948,0,0;QS=3,0;MQSB=0.738577;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,202:8:0 0,12,116:4:0 +X 2754 . C <*> 0 . DP=25;I16=14,10,0,0,873,32607,0,0,1409,83641,0,0,436,9484,0,0;QS=3,0;MQSB=0.919431;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,24,205:8:0 0,9,104:3:0 +X 2755 . C <*> 0 . DP=25;I16=14,10,0,0,865,32243,0,0,1409,83641,0,0,436,9528,0,0;QS=3,0;MQSB=0.919431;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,24,209:8:0 0,9,97:3:0 +X 2756 . C <*> 0 . DP=25;I16=14,9,0,0,838,31276,0,0,1380,82800,0,0,411,8971,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,204:8:0 0,9,97:3:0 +X 2757 . T <*> 0 . DP=25;I16=14,11,0,0,904,33980,0,0,1438,84482,0,0,455,10011,0,0;QS=3,0;MQSB=0.745495;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,212:7:0 0,15,147:5:0 +X 2758 . T <*> 0 . DP=25;I16=14,10,0,0,841,30293,0,0,1409,83641,0,0,439,9801,0,0;QS=3,0;MQSB=0.919431;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,195:7:0 0,12,133:4:0 +X 2759 . A <*> 0 . DP=25;I16=14,11,0,0,884,31728,0,0,1438,84482,0,0,457,10195,0,0;QS=3,0;MQSB=0.745495;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,192:7:0 0,15,147:5:0 +X 2760 . T <*> 0 . DP=25;I16=14,11,0,0,907,33965,0,0,1438,84482,0,0,457,10275,0,0;QS=3,0;MQSB=0.745495;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,204:7:0 0,15,150:5:0 +X 2761 . T <*> 0 . DP=23;I16=13,9,0,0,838,32530,0,0,1289,76441,0,0,444,10130,0,0;QS=3,0;MQSB=0.910098;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,185:6:0 0,12,141:4:0 +X 2762 . T <*> 0 . DP=24;I16=13,11,0,0,869,32261,0,0,1378,80882,0,0,459,10395,0,0;QS=3,0;MQSB=0.75304;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,178:6:0 0,18,177:6:0 +X 2763 . C A,<*> 0 . DP=24;I16=13,10,0,1,843,31711,13,169,1349,80041,29,841,448,10290,12,144;QS=2.93333,0.0666667,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.75304;BQB=1;MQ0F=0 PL:DP:DV 0,36,255,36,255,255:12:0 0,18,170,18,170,170:6:0 0,5,147,15,150,153:6:1 +X 2764 . C <*> 0 . DP=24;I16=13,10,0,0,854,32376,0,0,1349,80041,0,0,450,10374,0,0;QS=3,0;MQSB=0.921963;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,163:6:0 0,15,162:5:0 +X 2765 . T <*> 0 . DP=24;I16=12,11,0,0,853,32173,0,0,1318,77282,0,0,457,10469,0,0;QS=3,0;MQSB=0.7613;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,154:5:0 0,18,189:6:0 +X 2766 . C <*> 0 . DP=24;I16=12,11,0,0,887,34485,0,0,1349,80041,0,0,448,10398,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,160:5:0 0,18,186:6:0 +X 2767 . T <*> 0 . DP=24;I16=12,12,0,0,905,34757,0,0,1378,80882,0,0,458,10510,0,0;QS=3,0;MQSB=0.786628;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,153:5:0 0,21,217:7:0 +X 2768 . G <*> 0 . DP=23;I16=11,11,0,0,852,33258,0,0,1289,76441,0,0,452,10462,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,141:5:0 0,18,197:6:0 +X 2769 . C <*> 0 . DP=23;I16=11,12,0,0,832,31390,0,0,1318,77282,0,0,459,10481,0,0;QS=3,0;MQSB=0.795196;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,142:5:0 0,21,202:7:0 +X 2770 . T <*> 0 . DP=23;I16=11,12,0,0,828,30854,0,0,1318,77282,0,0,459,10471,0,0;QS=3,0;MQSB=0.795196;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,152:5:0 0,21,199:7:0 +X 2771 . T <*> 0 . DP=23;I16=11,11,0,0,817,30957,0,0,1258,73682,0,0,454,10456,0,0;QS=3,0;MQSB=0.770381;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,154:5:0 0,18,198:6:0 +X 2772 . T <*> 0 . DP=23;I16=11,12,0,0,856,32206,0,0,1318,77282,0,0,459,10511,0,0;QS=3,0;MQSB=0.795196;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,160:5:0 0,21,210:7:0 +X 2773 . A <*> 0 . DP=23;I16=11,12,0,0,828,30664,0,0,1318,77282,0,0,459,10561,0,0;QS=3,0;MQSB=0.795196;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,140:5:0 0,21,209:7:0 +X 2774 . G <*> 0 . DP=22;I16=11,11,0,0,843,32715,0,0,1258,73682,0,0,458,10530,0,0;QS=3,0;MQSB=0.770381;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,154:5:0 0,21,207:7:0 +X 2775 . T <*> 0 . DP=22;I16=10,11,0,0,748,27720,0,0,1198,70082,0,0,432,9892,0,0;QS=3,0;MQSB=0.780412;MQ0F=0 PL:DP:DV 0,30,253:10:0 0,12,115:4:0 0,21,203:7:0 +X 2776 . G <*> 0 . DP=22;I16=12,10,0,0,803,30251,0,0,1289,76441,0,0,456,10470,0,0;QS=3,0;MQSB=0.924723;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,135:5:0 0,21,210:7:0 +X 2777 . A <*> 0 . DP=22;I16=12,10,0,0,852,33524,0,0,1289,76441,0,0,456,10438,0,0;QS=3,0;MQSB=0.924723;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,148:5:0 0,21,220:7:0 +X 2778 . G <*> 0 . DP=23;I16=12,11,0,0,861,33049,0,0,1349,80041,0,0,456,10422,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,154:5:0 0,21,224:7:0 +X 2779 . G <*> 0 . DP=23;I16=11,11,0,0,834,32014,0,0,1289,76441,0,0,432,9798,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,136:4:0 0,21,219:7:0 +X 2780 . A <*> 0 . DP=23;I16=11,11,0,0,792,29162,0,0,1289,76441,0,0,433,9817,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,33,244:11:0 0,12,133:4:0 0,21,215:7:0 +X 2781 . A <*> 0 . DP=23;I16=11,11,0,0,844,33092,0,0,1289,76441,0,0,441,10141,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,30,253:10:0 0,15,151:5:0 0,21,233:7:0 +X 2782 . G <*> 0 . DP=23;I16=12,11,0,0,840,31826,0,0,1349,80041,0,0,458,10438,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,154:5:0 0,21,218:7:0 +X 2783 . A <*> 0 . DP=23;I16=11,11,0,0,860,33888,0,0,1289,76441,0,0,432,9790,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,142:4:0 0,21,230:7:0 +X 2784 . G <*> 0 . DP=23;I16=12,11,0,0,860,33092,0,0,1349,80041,0,0,456,10410,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,143:5:0 0,21,212:7:0 +X 2785 . G <*> 0 . DP=23;I16=11,11,0,0,797,29747,0,0,1289,76441,0,0,429,9749,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,134:4:0 0,21,204:7:0 +X 2786 . C <*> 0 . DP=24;I16=12,12,0,0,831,29497,0,0,1409,83641,0,0,451,10309,0,0;QS=3,0;MQSB=0.941765;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,141:5:0 0,21,199:7:0 +X 2787 . C <*> 0 . DP=24;I16=11,12,0,0,792,28454,0,0,1349,80041,0,0,424,9642,0,0;QS=3,0;MQSB=0.944319;MQ0F=0 PL:DP:DV 0,36,252:12:0 0,12,127:4:0 0,21,200:7:0 +X 2788 . C <*> 0 . DP=23;I16=11,11,0,0,791,29517,0,0,1289,76441,0,0,421,9523,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,125:4:0 0,21,209:7:0 +X 2789 . C <*> 0 . DP=24;I16=13,11,0,0,880,33470,0,0,1409,83641,0,0,443,10051,0,0;QS=3,0;MQSB=0.931547;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,150:5:0 0,21,226:7:0 +X 2790 . T <*> 0 . DP=23;I16=13,10,0,0,886,34738,0,0,1349,80041,0,0,442,9976,0,0;QS=3,0;MQSB=0.921963;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,165:5:0 0,21,227:7:0 +X 2791 . G <*> 0 . DP=23;I16=13,10,0,0,873,34037,0,0,1349,80041,0,0,441,9923,0,0;QS=3,0;MQSB=0.921963;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,155:5:0 0,21,226:7:0 +X 2792 . G <*> 0 . DP=23;I16=13,10,0,0,832,30870,0,0,1349,80041,0,0,438,9792,0,0;QS=3,0;MQSB=0.921963;MQ0F=0 PL:DP:DV 0,33,254:11:0 0,15,146:5:0 0,21,221:7:0 +X 2793 . T <*> 0 . DP=23;I16=13,10,0,0,827,30693,0,0,1349,80041,0,0,435,9683,0,0;QS=3,0;MQSB=0.921963;MQ0F=0 PL:DP:DV 0,33,247:11:0 0,15,157:5:0 0,21,214:7:0 +X 2794 . C <*> 0 . DP=22;I16=12,10,0,0,786,29122,0,0,1289,76441,0,0,433,9595,0,0;QS=3,0;MQSB=0.924723;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,145:5:0 0,21,201:7:0 +X 2795 . C <*> 0 . DP=22;I16=11,10,0,0,814,31804,0,0,1229,72841,0,0,428,9518,0,0;QS=3,0;MQSB=0.927743;MQ0F=0 PL:DP:DV 0,27,240:9:0 0,15,159:5:0 0,21,222:7:0 +X 2796 . A <*> 0 . DP=22;I16=11,10,0,0,762,28412,0,0,1229,72841,0,0,427,9475,0,0;QS=3,0;MQSB=0.927743;MQ0F=0 PL:DP:DV 0,27,221:9:0 0,15,156:5:0 0,21,211:7:0 +X 2797 . T <*> 0 . DP=22;I16=12,10,0,0,792,29116,0,0,1289,76441,0,0,427,9451,0,0;QS=3,0;MQSB=0.924723;MQ0F=0 PL:DP:DV 0,30,243:10:0 0,15,148:5:0 0,21,214:7:0 +X 2798 . G <*> 0 . DP=22;I16=12,10,0,0,817,31105,0,0,1289,76441,0,0,424,9394,0,0;QS=3,0;MQSB=0.924723;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,152:5:0 0,21,205:7:0 +X 2799 . A <*> 0 . DP=21;I16=11,10,0,0,788,30210,0,0,1229,72841,0,0,421,9309,0,0;QS=3,0;MQSB=0.927743;MQ0F=0 PL:DP:DV 0,27,220:9:0 0,15,167:5:0 0,21,218:7:0 +X 2800 . A <*> 0 . DP=21;I16=11,10,0,0,836,33616,0,0,1229,72841,0,0,418,9246,0,0;QS=3,0;MQSB=0.927743;MQ0F=0 PL:DP:DV 0,27,237:9:0 0,15,164:5:0 0,21,237:7:0 +X 2801 . G <*> 0 . DP=21;I16=11,10,0,0,792,30182,0,0,1229,72841,0,0,415,9205,0,0;QS=3,0;MQSB=0.927743;MQ0F=0 PL:DP:DV 0,27,234:9:0 0,15,157:5:0 0,21,214:7:0 +X 2802 . G <*> 0 . DP=21;I16=11,9,0,0,729,27275,0,0,1169,69241,0,0,387,8559,0,0;QS=3,0;MQSB=0.916401;MQ0F=0 PL:DP:DV 0,24,229:8:0 0,15,135:5:0 0,21,215:7:0 +X 2803 . G <*> 0 . DP=21;I16=11,10,0,0,737,26709,0,0,1229,72841,0,0,406,9036,0,0;QS=3,0;MQSB=0.927743;MQ0F=0 PL:DP:DV 0,27,233:9:0 0,15,125:5:0 0,21,207:7:0 +X 2804 . G <*> 0 . DP=21;I16=11,10,0,0,727,26103,0,0,1229,72841,0,0,400,8908,0,0;QS=3,0;MQSB=0.927743;MQ0F=0 PL:DP:DV 0,27,218:9:0 0,15,129:5:0 0,21,210:7:0 +X 2805 . C <*> 0 . DP=21;I16=10,10,0,0,714,26194,0,0,1169,69241,0,0,372,8316,0,0;QS=3,0;MQSB=0.931063;MQ0F=0 PL:DP:DV 0,27,229:9:0 0,12,111:4:0 0,21,205:7:0 +X 2806 . C <*> 0 . DP=20;I16=11,8,0,0,682,25074,0,0,1109,65641,0,0,379,8611,0,0;QS=3,0;MQSB=0.902014;MQ0F=0 PL:DP:DV 0,24,215:8:0 0,15,138:5:0 0,18,191:6:0 +X 2807 . T <*> 0 . DP=20;I16=11,9,0,0,755,29373,0,0,1169,69241,0,0,384,8640,0,0;QS=3,0;MQSB=0.916401;MQ0F=0 PL:DP:DV 0,24,221:8:0 0,15,152:5:0 0,21,227:7:0 +X 2808 . T <*> 0 . DP=20;I16=11,9,0,0,749,28383,0,0,1169,69241,0,0,379,8587,0,0;QS=3,0;MQSB=0.916401;MQ0F=0 PL:DP:DV 0,24,209:8:0 0,15,157:5:0 0,21,225:7:0 +X 2809 . T <*> 0 . DP=20;I16=11,8,0,0,697,26019,0,0,1109,65641,0,0,349,7927,0,0;QS=3,0;MQSB=0.902014;MQ0F=0 PL:DP:DV 0,21,189:7:0 0,15,148:5:0 0,21,226:7:0 +X 2810 . C <*> 0 . DP=20;I16=12,8,0,0,754,28900,0,0,1169,69241,0,0,368,8436,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,24,229:8:0 0,15,150:5:0 0,21,215:7:0 +X 2811 . A <*> 0 . DP=19;I16=11,8,0,0,759,30405,0,0,1109,65641,0,0,364,8340,0,0;QS=3,0;MQSB=0.902014;MQ0F=0 PL:DP:DV 0,21,209:7:0 0,15,166:5:0 0,21,228:7:0 +X 2812 . G <*> 0 . DP=20;I16=11,9,0,0,758,29062,0,0,1169,69241,0,0,359,8213,0,0;QS=3,0;MQSB=0.916401;MQ0F=0 PL:DP:DV 0,24,229:8:0 0,15,150:5:0 0,21,216:7:0 +X 2813 . A <*> 0 . DP=19;I16=11,8,0,0,702,27106,0,0,1140,68400,0,0,356,8104,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,195:7:0 0,15,160:5:0 0,21,217:7:0 +X 2814 . G <*> 0 . DP=19;I16=11,8,0,0,703,26579,0,0,1140,68400,0,0,353,8013,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,217:7:0 0,15,147:5:0 0,21,204:7:0 +X 2815 . A <*> 0 . DP=19;I16=10,7,0,0,597,21979,0,0,1020,61200,0,0,326,7470,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,170:6:0 0,12,122:4:0 0,21,208:7:0 +X 2816 . C <*> 0 . DP=19;I16=11,8,0,0,630,21880,0,0,1140,68400,0,0,343,7685,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,193:7:0 0,15,134:5:0 0,21,180:7:0 +X 2817 . G <*> 0 . DP=20;I16=11,8,0,0,612,20368,0,0,1140,68400,0,0,339,7547,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,200:7:0 0,15,115:5:0 0,21,178:7:0 +X 2818 . G <*> 0 . DP=20;I16=11,8,0,0,688,25280,0,0,1140,68400,0,0,335,7377,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,216:7:0 0,15,132:5:0 0,21,206:7:0 +X 2819 . G <*> 0 . DP=20;I16=11,8,0,0,696,25880,0,0,1140,68400,0,0,331,7227,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,222:7:0 0,15,142:5:0 0,21,195:7:0 +X 2820 . G <*> 0 . DP=20;I16=10,8,0,0,624,22228,0,0,1080,64800,0,0,320,7048,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,205:7:0 0,12,119:4:0 0,21,188:7:0 +X 2821 . A <*> 0 . DP=20;I16=9,7,0,0,496,16222,0,0,960,57600,0,0,279,6157,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,159:6:0 0,9,93:3:0 0,21,171:7:0 +X 2822 . C <*> 0 . DP=19;I16=8,9,0,0,543,18163,0,0,1020,61200,0,0,310,7064,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,203:7:0 0,9,79:3:0 0,21,168:7:0 +X 2823 . C <*> 0 . DP=18;I16=9,7,0,0,550,19506,0,0,960,57600,0,0,300,6640,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,201:7:0 0,6,58:2:0 0,21,192:7:0 +X 2824 . C <*> 0 . DP=18;I16=9,7,0,0,584,21560,0,0,960,57600,0,0,299,6567,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,219:8:0 0,3,37:1:0 0,21,210:7:0 +X 2825 . C <*> 0 . DP=18;I16=9,8,0,0,606,22286,0,0,1020,61200,0,0,324,7134,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,234:8:0 0,3,37:1:0 0,24,208:8:0 +X 2826 . T <*> 0 . DP=18;I16=9,8,0,0,604,21766,0,0,1020,61200,0,0,323,7043,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,222:8:0 0,3,33:1:0 0,24,220:8:0 +X 2827 . G <*> 0 . DP=18;I16=9,8,0,0,597,21643,0,0,1020,61200,0,0,322,6970,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,230:8:0 0,3,28:1:0 0,24,214:8:0 +X 2828 . A <*> 0 . DP=20;I16=9,9,0,0,598,20740,0,0,1080,64800,0,0,321,6915,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,213:9:0 0,3,36:1:0 0,24,219:8:0 +X 2829 . G <*> 0 . DP=20;I16=9,9,0,0,649,23719,0,0,1080,64800,0,0,305,6591,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,239:8:0 0,3,31:1:0 0,27,227:9:0 +X 2830 . G <*> 0 . DP=20;I16=9,10,0,0,661,23841,0,0,1140,68400,0,0,323,6867,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,248:9:0 0,3,34:1:0 0,27,222:9:0 +X 2831 . A <*> 0 . DP=21;I16=10,10,0,0,682,24052,0,0,1200,72000,0,0,324,6876,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,223:9:0 0,3,34:1:0 0,30,254:10:0 +X 2832 . G <*> 0 . DP=21;I16=10,8,0,0,626,22384,0,0,1080,64800,0,0,281,5883,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,230:8:0 0,3,31:1:0 0,27,223:9:0 +X 2833 . C <*> 0 . DP=21;I16=10,10,0,0,712,25708,0,0,1200,72000,0,0,327,6915,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,233:9:0 0,3,37:1:0 0,30,255:10:0 +X 2834 . C <*> 0 . DP=21;I16=10,9,0,0,674,24470,0,0,1140,68400,0,0,306,6464,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,230:8:0 0,3,36:1:0 0,30,243:10:0 +X 2835 . C <*> 0 . DP=20;I16=9,9,0,0,617,21835,0,0,1080,64800,0,0,305,6381,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,202:8:0 0,3,39:1:0 0,27,235:9:0 +X 2836 . C <*> 0 . DP=20;I16=9,9,0,0,580,19624,0,0,1080,64800,0,0,306,6412,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,206:8:0 0,3,39:1:0 0,27,200:9:0 +X 2837 . G <*> 0 . DP=21;I16=9,10,0,0,558,17614,0,0,1140,68400,0,0,330,7086,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,207:9:0 0,3,31:1:0 0,27,193:9:0 +X 2838 . A <*> 0 . DP=20;I16=9,10,0,0,640,22674,0,0,1140,68400,0,0,331,7065,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,245:9:0 0,3,17:1:0 0,27,220:9:0 +X 2839 . G <*> 0 . DP=20;I16=9,8,0,0,623,23267,0,0,1020,61200,0,0,282,5816,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,248:8:0 0,3,26:1:0 0,24,212:8:0 +X 2840 . C <*> 0 . DP=20;I16=9,10,0,0,644,22798,0,0,1140,68400,0,0,333,7089,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,233:9:0 0,3,32:1:0 0,27,227:9:0 +X 2841 . A <*> 0 . DP=20;I16=9,9,0,0,675,25801,0,0,1080,64800,0,0,309,6509,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,252:9:0 0,3,35:1:0 0,24,234:8:0 +X 2842 . G <*> 0 . DP=20;I16=9,10,0,0,688,25554,0,0,1140,68400,0,0,332,7056,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,3,31:1:0 0,27,233:9:0 +X 2843 . C <*> 0 . DP=20;I16=8,10,0,0,651,23969,0,0,1080,64800,0,0,309,6517,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,0,0:0:0 0,24,211:8:0 +X 2844 . A <*> 0 . DP=20;I16=8,11,0,0,685,25399,0,0,1140,68400,0,0,331,6969,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,0,0:0:0 0,27,231:9:0 +X 2845 . G <*> 0 . DP=20;I16=8,10,0,0,673,25399,0,0,1080,64800,0,0,311,6561,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,0,0:0:0 0,24,228:8:0 +X 2846 . C <*> 0 . DP=20;I16=8,10,0,0,617,22007,0,0,1080,64800,0,0,311,6577,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,243:10:0 0,0,0:0:0 0,24,218:8:0 +X 2847 . C <*> 0 . DP=20;I16=7,11,0,0,580,19468,0,0,1080,64800,0,0,321,6917,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,241:10:0 0,0,0:0:0 0,24,187:8:0 +X 2848 . G <*> 0 . DP=19;I16=7,10,0,0,542,17884,0,0,1020,61200,0,0,323,6999,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,218:9:0 0,0,0:0:0 0,24,191:8:0 +X 2849 . T <*> 0 . DP=19;I16=7,11,0,0,609,21717,0,0,1080,64800,0,0,341,7357,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,231:9:0 0,0,0:0:0 0,27,214:9:0 +X 2850 . C <*> 0 . DP=19;I16=7,11,0,0,574,18980,0,0,1080,64800,0,0,343,7461,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,234:9:0 0,0,0:0:0 0,27,188:9:0 +X 2851 . G <*> 0 . DP=17;I16=6,11,0,0,589,20831,0,0,1020,61200,0,0,346,7584,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,239:9:0 0,0,0:0:0 0,24,194:8:0 +X 2852 . T <*> 0 . DP=17;I16=6,11,0,0,625,23241,0,0,1020,61200,0,0,348,7676,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,244:9:0 0,0,0:0:0 0,24,214:8:0 +X 2853 . G <*> 0 . DP=17;I16=6,11,0,0,635,23949,0,0,1020,61200,0,0,349,7739,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,0,0:0:0 0,24,202:8:0 +X 2854 . T <*> 0 . DP=17;I16=6,11,0,0,602,21990,0,0,1020,61200,0,0,348,7722,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,238:9:0 0,0,0:0:0 0,24,207:8:0 +X 2855 . C <*> 0 . DP=17;I16=6,10,0,0,577,21539,0,0,960,57600,0,0,337,7623,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,0,0:0:0 0,21,185:7:0 +X 2856 . T <*> 0 . DP=17;I16=6,8,0,0,530,20570,0,0,840,50400,0,0,289,6507,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,252:9:0 0,0,0:0:0 0,15,167:5:0 +X 2857 . C <*> 0 . DP=18;I16=6,10,0,0,577,21641,0,0,960,57600,0,0,336,7664,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,0,0:0:0 0,21,185:7:0 +X 2858 . A <*> 0 . DP=19;I16=6,12,0,0,634,23006,0,0,1080,64800,0,0,355,8081,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,254:10:0 0,3,39:1:0 0,21,185:7:0 +X 2859 . C <*> 0 . DP=19;I16=6,13,0,0,646,23056,0,0,1140,68400,0,0,361,8139,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,3,26:1:0 0,24,194:8:0 +X 2860 . C <*> 0 . DP=19;I16=6,13,0,0,655,23687,0,0,1140,68400,0,0,360,8166,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,251:10:0 0,3,37:1:0 0,24,200:8:0 +X 2861 . C <*> 0 . DP=20;I16=7,12,0,0,708,26756,0,0,1140,68400,0,0,333,7537,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,3,38:1:0 0,21,203:7:0 +X 2862 . A <*> 0 . DP=20;I16=6,13,0,0,749,29753,0,0,1140,68400,0,0,332,7554,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,3,43:1:0 0,24,225:8:0 +X 2863 . G <*> 0 . DP=19;I16=7,12,0,0,707,26901,0,0,1140,68400,0,0,356,8166,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,3,35:1:0 0,21,195:7:0 +X 2864 . G <*> 0 . DP=19;I16=7,11,0,0,677,25833,0,0,1080,64800,0,0,352,8070,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,3,36:1:0 0,18,185:6:0 +X 2865 . G <*> 0 . DP=19;I16=7,12,0,0,671,24569,0,0,1140,68400,0,0,350,7994,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,3,27:1:0 0,21,193:7:0 +X 2866 . T <*> 0 . DP=18;I16=6,11,0,0,591,21071,0,0,1020,61200,0,0,338,7834,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,3,32:1:0 0,15,147:5:0 +X 2867 . G <*> 0 . DP=18;I16=7,11,0,0,655,24279,0,0,1080,64800,0,0,347,7889,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,58:2:0 0,15,150:5:0 +X 2868 . T <*> 0 . DP=18;I16=7,11,0,0,640,23702,0,0,1080,64800,0,0,347,7859,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,68:2:0 0,15,157:5:0 +X 2869 . C <*> 0 . DP=18;I16=7,11,0,0,655,24737,0,0,1080,64800,0,0,346,7794,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,56:2:0 0,15,165:5:0 +X 2870 . T <*> 0 . DP=18;I16=7,11,0,0,700,27480,0,0,1080,64800,0,0,345,7743,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,70:2:0 0,15,176:5:0 +X 2871 . G <*> 0 . DP=18;I16=7,11,0,0,700,27554,0,0,1080,64800,0,0,344,7706,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,68:2:0 0,15,172:5:0 +X 2872 . A <*> 0 . DP=18;I16=7,11,0,0,651,23869,0,0,1080,64800,0,0,343,7683,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,66:2:0 0,15,171:5:0 +X 2873 . A <*> 0 . DP=18;I16=7,11,0,0,664,25000,0,0,1080,64800,0,0,342,7674,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,61:2:0 0,15,159:5:0 +X 2874 . A <*> 0 . DP=18;I16=7,11,0,0,636,23286,0,0,1080,64800,0,0,341,7679,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,57:2:0 0,15,162:5:0 +X 2875 . C <*> 0 . DP=18;I16=7,11,0,0,664,25148,0,0,1080,64800,0,0,340,7698,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,63:2:0 0,15,166:5:0 +X 2876 . A <*> 0 . DP=18;I16=6,11,0,0,666,26684,0,0,1020,61200,0,0,314,7106,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,6,74:2:0 0,15,185:5:0 +X 2877 . G <*> 0 . DP=17;I16=6,11,0,0,659,26009,0,0,1020,61200,0,0,339,7777,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,67:2:0 0,12,148:4:0 +X 2878 . A <*> 0 . DP=17;I16=7,10,0,0,628,23656,0,0,1020,61200,0,0,340,7834,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,6,69:2:0 0,15,166:5:0 +X 2879 . T <*> 0 . DP=18;I16=7,11,0,0,671,25359,0,0,1080,64800,0,0,342,7902,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,253:10:0 0,9,96:3:0 0,15,175:5:0 +X 2880 . G <*> 0 . DP=19;I16=8,11,0,0,708,26694,0,0,1140,68400,0,0,345,7983,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,118:4:0 0,15,173:5:0 +X 2881 . T <*> 0 . DP=19;I16=6,11,0,0,618,23304,0,0,1020,61200,0,0,299,6829,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,209:8:0 0,12,124:4:0 0,15,178:5:0 +X 2882 . G <*> 0 . DP=19;I16=8,11,0,0,700,26464,0,0,1140,68400,0,0,353,8191,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,118:4:0 0,15,176:5:0 +X 2883 . G <*> 0 . DP=19;I16=8,11,0,0,707,26939,0,0,1140,68400,0,0,357,8319,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,121:4:0 0,15,175:5:0 +X 2884 . A <*> 0 . DP=19;I16=7,11,0,0,649,24531,0,0,1080,64800,0,0,335,7787,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,229:9:0 0,12,121:4:0 0,15,181:5:0 +X 2885 . G <*> 0 . DP=19;I16=8,11,0,0,737,29253,0,0,1140,68400,0,0,362,8470,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,113:4:0 0,15,182:5:0 +X 2886 . G A,<*> 0 . DP=18;I16=7,9,1,0,571,21281,20,400,960,57600,60,3600,334,7882,6,36;QS=2.76471,0.235294,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=1;BQB=1;MQ0F=0 PL:DP:DV 0,27,236,27,236,236:9:0 11,0,51,17,54,66:3:1 0,15,171,15,171,171:5:0 +X 2887 . T <*> 0 . DP=19;I16=9,9,0,0,581,20407,0,0,1080,64800,0,0,341,7905,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,213:10:0 0,9,94:3:0 0,15,166:5:0 +X 2888 . C <*> 0 . DP=20;I16=10,10,0,0,714,26630,0,0,1200,72000,0,0,368,8532,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,94:4:0 0,15,159:5:0 +X 2889 . T <*> 0 . DP=19;I16=9,10,0,0,712,27106,0,0,1140,68400,0,0,372,8550,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,114:4:0 0,15,175:5:0 +X 2890 . C <*> 0 . DP=19;I16=9,10,0,0,613,20711,0,0,1140,68400,0,0,376,8584,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,247:10:0 0,12,95:4:0 0,15,139:5:0 +X 2891 . G <*> 0 . DP=20;I16=9,11,0,0,674,23754,0,0,1200,72000,0,0,380,8634,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,242:10:0 0,15,141:5:0 0,15,143:5:0 +X 2892 . G <*> 0 . DP=21;I16=9,12,0,0,731,26677,0,0,1260,75600,0,0,385,8701,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,142:5:0 0,15,164:5:0 +X 2893 . G <*> 0 . DP=21;I16=9,12,0,0,696,24498,0,0,1260,75600,0,0,389,8687,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,251:11:0 0,15,141:5:0 0,15,150:5:0 +X 2894 . T <*> 0 . DP=21;I16=9,12,0,0,716,25490,0,0,1260,75600,0,0,393,8693,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,137:5:0 0,15,155:5:0 +X 2895 . G <*> 0 . DP=22;I16=9,12,0,0,773,29225,0,0,1260,75600,0,0,372,8094,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,149:6:0 0,15,166:5:0 +X 2896 . A <*> 0 . DP=22;I16=8,12,0,0,732,27684,0,0,1200,72000,0,0,361,7885,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,151:5:0 0,15,163:5:0 +X 2897 . G <*> 0 . DP=22;I16=10,12,0,0,783,28783,0,0,1320,79200,0,0,407,8835,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,161:6:0 0,15,168:5:0 +X 2898 . G <*> 0 . DP=22;I16=10,12,0,0,724,25596,0,0,1320,79200,0,0,412,8926,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,254:11:0 0,18,143:6:0 0,15,169:5:0 +X 2899 . C <*> 0 . DP=22;I16=8,11,0,0,625,21143,0,0,1140,68400,0,0,356,7640,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,228:9:0 0,15,130:5:0 0,15,147:5:0 +X 2900 . G <*> 0 . DP=24;I16=11,13,0,0,782,26700,0,0,1440,86400,0,0,420,9078,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,164:6:0 0,15,153:5:0 +X 2901 . T <*> 0 . DP=24;I16=11,13,0,0,821,29195,0,0,1440,86400,0,0,426,9192,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,174:6:0 0,15,166:5:0 +X 2902 . G <*> 0 . DP=24;I16=11,13,0,0,898,34176,0,0,1440,86400,0,0,432,9334,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,171:6:0 0,15,164:5:0 +X 2903 . G <*> 0 . DP=24;I16=11,13,0,0,894,33764,0,0,1440,86400,0,0,437,9455,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,183:6:0 0,15,168:5:0 +X 2904 . C <*> 0 . DP=24;I16=11,13,0,0,892,34010,0,0,1440,86400,0,0,440,9506,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,176:6:0 0,15,169:5:0 +X 2905 . T <*> 0 . DP=25;I16=12,13,0,0,926,34994,0,0,1500,90000,0,0,442,9536,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,175:6:0 0,15,174:5:0 +X 2906 . C <*> 0 . DP=25;I16=12,13,0,0,960,37070,0,0,1500,90000,0,0,444,9544,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,178:6:0 0,15,173:5:0 +X 2907 . A <*> 0 . DP=25;I16=11,13,0,0,933,36707,0,0,1440,86400,0,0,429,9275,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,202:6:0 0,15,170:5:0 +X 2908 . G <*> 0 . DP=25;I16=12,13,0,0,943,36315,0,0,1500,90000,0,0,446,9548,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,167:6:0 0,15,164:5:0 +X 2909 . A <*> 0 . DP=25;I16=10,13,0,0,864,32764,0,0,1380,82800,0,0,425,9105,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,182:6:0 0,15,171:5:0 +X 2910 . T <*> 0 . DP=25;I16=11,13,0,0,870,32054,0,0,1440,86400,0,0,447,9575,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,181:6:0 0,15,166:5:0 +X 2911 . A <*> 0 . DP=25;I16=11,14,0,0,871,31227,0,0,1500,90000,0,0,473,10259,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,174:6:0 0,18,188:6:0 +X 2912 . C <*> 0 . DP=24;I16=11,13,0,0,899,34121,0,0,1440,86400,0,0,474,10298,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,173:6:0 0,18,189:6:0 +X 2913 . A <*> 0 . DP=24;I16=10,13,0,0,879,34357,0,0,1380,82800,0,0,449,9691,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,164:5:0 0,18,199:6:0 +X 2914 . G <*> 0 . DP=24;I16=11,13,0,0,899,34575,0,0,1440,86400,0,0,472,10262,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,170:6:0 0,18,187:6:0 +X 2915 . G <*> 0 . DP=24;I16=11,13,0,0,867,32523,0,0,1440,86400,0,0,470,10236,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,177:6:0 0,18,178:6:0 +X 2916 . G <*> 0 . DP=24;I16=11,12,0,0,813,29935,0,0,1380,82800,0,0,443,9613,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,173:6:0 0,15,155:5:0 +X 2917 . A <*> 0 . DP=25;I16=11,13,0,0,864,31926,0,0,1440,86400,0,0,459,10181,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,185:6:0 0,18,178:6:0 +X 2918 . G <*> 0 . DP=25;I16=13,12,0,0,903,33489,0,0,1500,90000,0,0,462,10122,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,165:6:0 0,18,170:6:0 +X 2919 . T <*> 0 . DP=25;I16=12,12,0,0,837,29647,0,0,1440,86400,0,0,443,9765,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,169:6:0 0,18,178:6:0 +X 2920 . G <*> 0 . DP=25;I16=12,12,0,0,850,31266,0,0,1440,86400,0,0,433,9389,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,132:5:0 0,18,180:6:0 +X 2921 . G <*> 0 . DP=25;I16=13,12,0,0,874,31518,0,0,1500,90000,0,0,455,9951,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,159:6:0 0,18,176:6:0 +X 2922 . C <*> 0 . DP=26;I16=13,12,0,0,872,31374,0,0,1500,90000,0,0,438,9718,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,160:6:0 0,18,172:6:0 +X 2923 . C <*> 0 . DP=26;I16=13,12,0,0,873,31687,0,0,1500,90000,0,0,437,9735,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,172:6:0 0,18,175:6:0 +X 2924 . C <*> 0 . DP=25;I16=13,12,0,0,940,36016,0,0,1500,90000,0,0,449,9921,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,173:6:0 0,18,184:6:0 +X 2925 . A <*> 0 . DP=25;I16=13,12,0,0,912,33580,0,0,1500,90000,0,0,448,9964,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,174:6:0 0,18,189:6:0 +X 2926 . C <*> 0 . DP=25;I16=13,12,0,0,902,33224,0,0,1500,90000,0,0,445,9931,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,176:6:0 0,18,174:6:0 +X 2927 . A <*> 0 . DP=25;I16=12,12,0,0,896,33828,0,0,1440,86400,0,0,417,9295,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,162:5:0 0,18,191:6:0 +X 2928 . G <*> 0 . DP=24;I16=13,11,0,0,862,32078,0,0,1440,86400,0,0,440,9930,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,170:6:0 0,18,161:6:0 +X 2929 . C <*> 0 . DP=23;I16=13,9,0,0,794,29716,0,0,1320,79200,0,0,430,9878,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,153:5:0 0,15,149:5:0 +X 2930 . T <*> 0 . DP=23;I16=13,10,0,0,822,30260,0,0,1380,82800,0,0,438,10006,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,168:6:0 0,15,157:5:0 +X 2931 . C <*> 0 . DP=23;I16=13,10,0,0,803,28963,0,0,1380,82800,0,0,436,10020,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,162:6:0 0,15,140:5:0 +X 2932 . G <*> 0 . DP=22;I16=12,10,0,0,728,25158,0,0,1320,79200,0,0,435,10049,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,171:6:0 0,12,117:4:0 +X 2933 . G <*> 0 . DP=22;I16=11,10,0,0,760,28336,0,0,1260,75600,0,0,430,10034,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,175:6:0 0,12,116:4:0 +X 2934 . C <*> 0 . DP=21;I16=12,9,0,0,759,28241,0,0,1260,75600,0,0,432,10052,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,161:6:0 0,9,104:3:0 +X 2935 . C <*> 0 . DP=21;I16=12,9,0,0,766,28494,0,0,1260,75600,0,0,431,10075,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,178:6:0 0,9,94:3:0 +X 2936 . T <*> 0 . DP=21;I16=11,9,0,0,760,29284,0,0,1200,72000,0,0,429,10063,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,188:6:0 0,9,98:3:0 +X 2937 . G <*> 0 . DP=20;I16=11,9,0,0,728,27374,0,0,1200,72000,0,0,428,10066,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,177:6:0 0,9,79:3:0 +X 2938 . T <*> 0 . DP=20;I16=11,9,0,0,719,26217,0,0,1200,72000,0,0,427,10083,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,188:6:0 0,9,101:3:0 +X 2939 . C <*> 0 . DP=19;I16=11,8,0,0,729,28277,0,0,1140,68400,0,0,427,10113,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,163:5:0 0,9,106:3:0 +X 2940 . T <*> 0 . DP=19;I16=11,8,0,0,739,29133,0,0,1140,68400,0,0,427,10155,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,171:5:0 0,9,109:3:0 +X 2941 . T <*> 0 . DP=19;I16=11,8,0,0,702,26358,0,0,1140,68400,0,0,427,10209,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,170:5:0 0,9,99:3:0 +X 2942 . T <*> 0 . DP=19;I16=11,8,0,0,695,25671,0,0,1140,68400,0,0,427,10275,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,169:5:0 0,9,100:3:0 +X 2943 . G <*> 0 . DP=18;I16=11,6,0,0,621,23187,0,0,1020,61200,0,0,401,9627,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,228:9:0 0,15,170:5:0 0,9,86:3:0 +X 2944 . A <*> 0 . DP=18;I16=10,7,0,0,642,24406,0,0,1020,61200,0,0,399,9563,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,239:9:0 0,15,168:5:0 0,9,111:3:0 +X 2945 . A <*> 0 . DP=18;I16=11,7,0,0,637,23199,0,0,1080,64800,0,0,422,10132,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,242:10:0 0,15,152:5:0 0,9,107:3:0 +X 2946 . A <*> 0 . DP=18;I16=11,7,0,0,692,26794,0,0,1080,64800,0,0,420,10084,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,174:5:0 0,9,108:3:0 +X 2947 . G <*> 0 . DP=18;I16=11,7,0,0,639,23329,0,0,1080,64800,0,0,418,10044,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,160:5:0 0,9,78:3:0 +X 2948 . G <*> 0 . DP=19;I16=11,8,0,0,702,26272,0,0,1140,68400,0,0,415,9961,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,163:5:0 0,12,116:4:0 +X 2949 . C <*> 0 . DP=19;I16=10,8,0,0,657,24565,0,0,1080,64800,0,0,388,9260,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,125:4:0 0,12,124:4:0 +X 2950 . C <*> 0 . DP=19;I16=11,8,0,0,667,24359,0,0,1140,68400,0,0,411,9817,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,131:5:0 0,12,115:4:0 +X 2951 . A <*> 0 . DP=20;I16=11,8,0,0,682,24956,0,0,1140,68400,0,0,409,9757,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,250:10:0 0,15,149:5:0 0,12,133:4:0 +X 2952 . C <*> 0 . DP=20;I16=11,9,0,0,647,21709,0,0,1200,72000,0,0,408,9706,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,128:5:0 0,12,112:4:0 +X 2953 . G <*> 0 . DP=21;I16=11,9,0,0,620,19954,0,0,1200,72000,0,0,407,9665,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,237:11:0 0,15,132:5:0 0,12,111:4:0 +X 2954 . T <*> 0 . DP=21;I16=11,10,0,0,742,26662,0,0,1260,75600,0,0,414,9666,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,175:6:0 0,12,135:4:0 +X 2955 . G <*> 0 . DP=22;I16=11,11,0,0,787,28475,0,0,1320,79200,0,0,412,9568,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,170:6:0 0,12,127:4:0 +X 2956 . A <*> 0 . DP=22;I16=11,11,0,0,747,26449,0,0,1320,79200,0,0,410,9438,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,161:6:0 0,12,125:4:0 +X 2957 . C <*> 0 . DP=22;I16=10,10,0,0,693,24757,0,0,1200,72000,0,0,358,8078,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,143:6:0 0,9,104:3:0 +X 2958 . C <*> 0 . DP=21;I16=11,10,0,0,784,29744,0,0,1260,75600,0,0,407,9237,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,172:6:0 0,12,135:4:0 +X 2959 . T <*> 0 . DP=21;I16=11,10,0,0,791,30411,0,0,1260,75600,0,0,406,9164,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,182:6:0 0,12,139:4:0 +X 2960 . G <*> 0 . DP=21;I16=11,10,0,0,778,29502,0,0,1260,75600,0,0,405,9109,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,178:6:0 0,12,126:4:0 +X 2961 . G <*> 0 . DP=20;I16=10,9,0,0,657,23303,0,0,1140,68400,0,0,380,8446,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,231:10:0 0,18,176:6:0 0,9,111:3:0 +X 2962 . C <*> 0 . DP=21;I16=10,10,0,0,731,27459,0,0,1200,72000,0,0,385,8615,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,151:5:0 0,12,132:4:0 +X 2963 . C <*> 0 . DP=21;I16=10,10,0,0,722,26502,0,0,1200,72000,0,0,378,8274,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,169:6:0 0,9,100:3:0 +X 2964 . C <*> 0 . DP=22;I16=11,10,0,0,752,27740,0,0,1260,75600,0,0,379,8275,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,148:5:0 0,15,151:5:0 +X 2965 . A <*> 0 . DP=22;I16=11,11,0,0,804,29606,0,0,1320,79200,0,0,397,8539,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,176:6:0 0,15,155:5:0 +X 2966 . C <*> 0 . DP=22;I16=11,11,0,0,705,23557,0,0,1320,79200,0,0,396,8468,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,254:11:0 0,18,146:6:0 0,15,142:5:0 +X 2967 . G <*> 0 . DP=24;I16=11,13,0,0,767,25405,0,0,1440,86400,0,0,393,8325,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,162:6:0 0,18,135:6:0 +X 2968 . G <*> 0 . DP=23;I16=11,12,0,0,812,29824,0,0,1380,82800,0,0,393,8213,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,152:5:0 0,18,162:6:0 +X 2969 . C <*> 0 . DP=23;I16=11,12,0,0,866,32982,0,0,1380,82800,0,0,393,8133,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,151:5:0 0,18,181:6:0 +X 2970 . T <*> 0 . DP=24;I16=11,12,0,0,816,29806,0,0,1380,82800,0,0,393,8085,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,154:5:0 0,18,189:6:0 +X 2971 . G <*> 0 . DP=24;I16=12,12,0,0,878,33010,0,0,1440,86400,0,0,392,7970,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,173:6:0 0,18,184:6:0 +X 2972 . G <*> 0 . DP=24;I16=12,12,0,0,839,30363,0,0,1440,86400,0,0,391,7889,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,175:6:0 0,18,161:6:0 +X 2973 . C <*> 0 . DP=24;I16=12,12,0,0,854,31154,0,0,1440,86400,0,0,390,7842,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,177:6:0 0,18,165:6:0 +X 2974 . A <*> 0 . DP=24;I16=12,12,0,0,869,32231,0,0,1440,86400,0,0,388,7778,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,169:6:0 0,18,174:6:0 +X 2975 . G <*> 0 . DP=24;I16=12,12,0,0,857,31835,0,0,1440,86400,0,0,384,7648,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,173:6:0 0,18,167:6:0 +X 2976 . G <*> 0 . DP=25;I16=13,12,0,0,866,31118,0,0,1500,90000,0,0,380,7554,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,180:7:0 0,18,171:6:0 +X 2977 . T <*> 0 . DP=26;I16=13,12,0,0,760,25216,0,0,1469,87241,0,0,373,7437,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,151:6:0 0,18,155:6:0 +X 2978 . G <*> 0 . DP=25;I16=12,12,0,0,862,31574,0,0,1409,83641,0,0,362,7290,0,0;QS=3,0;MQSB=0.941765;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,168:6:0 0,18,167:6:0 +X 2979 . G <*> 0 . DP=24;I16=12,12,0,0,816,28440,0,0,1409,83641,0,0,370,7340,0,0;QS=3,0;MQSB=0.941765;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,164:6:0 0,15,142:5:0 +X 2980 . G <*> 0 . DP=23;I16=12,11,0,0,834,30882,0,0,1349,80041,0,0,369,7293,0,0;QS=3,0;MQSB=0.944319;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,144:5:0 0,15,148:5:0 +X 2981 . A <*> 0 . DP=23;I16=9,11,0,0,622,20306,0,0,1169,69241,0,0,318,6244,0,0;QS=3,0;MQSB=0.916401;MQ0F=0 PL:DP:DV 0,30,201:10:0 0,15,145:5:0 0,15,150:5:0 +X 2982 . C <*> 0 . DP=23;I16=10,11,0,0,706,24366,0,0,1229,72841,0,0,340,6884,0,0;QS=3,0;MQSB=0.927743;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,93:3:0 0,15,144:5:0 +X 2983 . C <*> 0 . DP=23;I16=12,11,0,0,781,27427,0,0,1349,80041,0,0,363,7197,0,0;QS=3,0;MQSB=0.944319;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,137:5:0 0,15,142:5:0 +X 2984 . C <*> 0 . DP=23;I16=12,11,0,0,861,32655,0,0,1349,80041,0,0,361,7229,0,0;QS=3,0;MQSB=0.944319;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,154:5:0 0,15,157:5:0 +X 2985 . A <*> 0 . DP=23;I16=12,11,0,0,798,28906,0,0,1349,80041,0,0,359,7293,0,0;QS=3,0;MQSB=0.944319;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,161:5:0 0,15,151:5:0 +X 2986 . G <*> 0 . DP=21;I16=11,10,0,0,701,24335,0,0,1229,72841,0,0,358,7388,0,0;QS=3,0;MQSB=0.939898;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,129:5:0 0,12,126:4:0 +X 2987 . C <*> 0 . DP=21;I16=10,10,0,0,720,26782,0,0,1169,69241,0,0,350,7448,0,0;QS=3,0;MQSB=0.931063;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,136:4:0 0,12,132:4:0 +X 2988 . T <*> 0 . DP=20;I16=10,10,0,0,693,25143,0,0,1169,69241,0,0,358,7612,0,0;QS=3,0;MQSB=0.931063;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,132:5:0 0,12,136:4:0 +X 2989 . G <*> 0 . DP=20;I16=10,10,0,0,708,25886,0,0,1169,69241,0,0,358,7736,0,0;QS=3,0;MQSB=0.931063;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,141:5:0 0,12,125:4:0 +X 2990 . C <*> 0 . DP=20;I16=10,10,0,0,697,25083,0,0,1169,69241,0,0,357,7833,0,0;QS=3,0;MQSB=0.931063;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,149:5:0 0,12,129:4:0 +X 2991 . A <*> 0 . DP=20;I16=10,10,0,0,717,26309,0,0,1169,69241,0,0,356,7952,0,0;QS=3,0;MQSB=0.931063;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,151:5:0 0,12,131:4:0 +X 2992 . G <*> 0 . DP=18;I16=10,8,0,0,625,22505,0,0,1049,62041,0,0,356,8042,0,0;QS=3,0;MQSB=0.938795;MQ0F=0 PL:DP:DV 0,30,243:10:0 0,12,130:4:0 0,12,120:4:0 +X 2993 . G <*> 0 . DP=18;I16=10,8,0,0,646,23620,0,0,1049,62041,0,0,354,8050,0,0;QS=3,0;MQSB=0.938795;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,118:4:0 0,12,123:4:0 +X 2994 . G <*> 0 . DP=18;I16=10,8,0,0,620,21828,0,0,1049,62041,0,0,351,8025,0,0;QS=3,0;MQSB=0.938795;MQ0F=0 PL:DP:DV 0,30,254:10:0 0,12,115:4:0 0,12,116:4:0 +X 2995 . G <*> 0 . DP=18;I16=10,8,0,0,628,22284,0,0,1049,62041,0,0,348,8018,0,0;QS=3,0;MQSB=0.938795;MQ0F=0 PL:DP:DV 0,30,248:10:0 0,12,110:4:0 0,12,135:4:0 +X 2996 . T <*> 0 . DP=17;I16=8,8,0,0,497,16697,0,0,929,54841,0,0,323,7493,0,0;QS=3,0;MQSB=0.915545;MQ0F=0 PL:DP:DV 0,30,215:10:0 0,9,75:3:0 0,9,107:3:0 +X 2997 . C <*> 0 . DP=17;I16=9,8,0,0,603,21925,0,0,989,58441,0,0,341,7901,0,0;QS=3,0;MQSB=0.928603;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,85:3:0 0,12,115:4:0 +X 2998 . C <*> 0 . DP=17;I16=9,8,0,0,576,19964,0,0,989,58441,0,0,337,7841,0,0;QS=3,0;MQSB=0.928603;MQ0F=0 PL:DP:DV 0,30,247:10:0 0,9,84:3:0 0,12,123:4:0 +X 2999 . A <*> 0 . DP=17;I16=9,8,0,0,599,22077,0,0,989,58441,0,0,333,7797,0,0;QS=3,0;MQSB=0.928603;MQ0F=0 PL:DP:DV 0,30,238:10:0 0,9,109:3:0 0,12,136:4:0 +X 3000 . G <*> 0 . DP=15;I16=8,7,0,0,554,20620,0,0,869,51241,0,0,331,7767,0,0;QS=3,0;MQSB=0.921243;MQ0F=0 PL:DP:DV 0,24,220:8:0 0,9,102:3:0 0,12,135:4:0 +X 3001 . C <*> 0 . DP=15;I16=7,7,0,0,521,19695,0,0,809,47641,0,0,309,7349,0,0;QS=3,0;MQSB=0.885987;MQ0F=0 PL:DP:DV 0,21,213:7:0 0,9,103:3:0 0,12,128:4:0 +X 3002 . A <*> 0 . DP=15;I16=8,7,0,0,542,20082,0,0,869,51241,0,0,326,7692,0,0;QS=3,0;MQSB=0.921243;MQ0F=0 PL:DP:DV 0,24,224:8:0 0,9,92:3:0 0,12,139:4:0 +X 3003 . G <*> 0 . DP=15;I16=8,7,0,0,540,19814,0,0,869,51241,0,0,322,7594,0,0;QS=3,0;MQSB=0.921243;MQ0F=0 PL:DP:DV 0,24,230:8:0 0,9,96:3:0 0,12,120:4:0 +X 3004 . C <*> 0 . DP=15;I16=8,7,0,0,525,19113,0,0,869,51241,0,0,318,7504,0,0;QS=3,0;MQSB=0.921243;MQ0F=0 PL:DP:DV 0,24,211:8:0 0,9,100:3:0 0,12,129:4:0 +X 3005 . A <*> 0 . DP=14;I16=7,7,0,0,491,17343,0,0,809,47641,0,0,315,7421,0,0;QS=3,0;MQSB=0.885987;MQ0F=0 PL:DP:DV 0,21,197:7:0 0,9,95:3:0 0,12,124:4:0 +X 3006 . C <*> 0 . DP=16;I16=7,8,0,0,516,18376,0,0,869,51241,0,0,312,7344,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,24,200:8:0 0,9,95:3:0 0,12,135:4:0 +X 3007 . C <*> 0 . DP=16;I16=7,8,0,0,553,20853,0,0,869,51241,0,0,310,7274,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,24,214:8:0 0,9,103:3:0 0,12,144:4:0 +X 3008 . C <*> 0 . DP=16;I16=7,8,0,0,576,22238,0,0,869,51241,0,0,308,7212,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,24,228:8:0 0,9,105:3:0 0,12,145:4:0 +X 3009 . A <*> 0 . DP=16;I16=7,8,0,0,493,16739,0,0,869,51241,0,0,306,7158,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,24,200:8:0 0,9,83:3:0 0,12,130:4:0 +X 3010 . C <*> 0 . DP=15;I16=7,7,0,0,534,20464,0,0,809,47641,0,0,300,7096,0,0;QS=3,0;MQSB=0.885987;MQ0F=0 PL:DP:DV 0,21,211:7:0 0,9,106:3:0 0,12,135:4:0 +X 3011 . A <*> 0 . DP=16;I16=7,8,0,0,559,21173,0,0,869,51241,0,0,302,7074,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,24,218:8:0 0,9,104:3:0 0,12,145:4:0 +X 3012 . G <*> 0 . DP=16;I16=7,8,0,0,503,17903,0,0,869,51241,0,0,300,7044,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,24,193:8:0 0,9,93:3:0 0,12,141:4:0 +X 3013 . C <*> 0 . DP=16;I16=7,9,0,0,549,19967,0,0,898,52082,0,0,305,7071,0,0;QS=3,0;MQSB=0.994413;MQ0F=0 PL:DP:DV 0,27,207:9:0 0,9,98:3:0 0,12,141:4:0 +X 3014 . A <*> 0 . DP=18;I16=6,9,0,0,542,20362,0,0,838,48482,0,0,289,6959,0,0;QS=3,0;MQSB=0.984496;MQ0F=0 PL:DP:DV 0,24,195:8:0 0,9,109:3:0 0,12,141:4:0 +X 3015 . G <*> 0 . DP=20;I16=7,9,0,0,549,19441,0,0,929,54841,0,0,311,7547,0,0;QS=3,0;MQSB=0.892753;MQ0F=0 PL:DP:DV 0,24,206:8:0 0,12,116:4:0 0,12,131:4:0 +X 3016 . C <*> 0 . DP=20;I16=7,13,0,0,690,24374,0,0,1138,66482,0,0,337,7783,0,0;QS=3,0;MQSB=0.972138;MQ0F=0 PL:DP:DV 0,33,248:11:0 0,15,136:5:0 0,12,132:4:0 +X 3017 . C A,<*> 0 . DP=20;I16=7,12,0,1,650,23264,23,529,1109,65641,29,841,329,7715,11,121;QS=2.93801,0.0619946,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.972138;BQB=1;MQ0F=0 PL:DP:DV 0,10,224,30,227,236:11:1 0,15,133,15,133,133:5:0 0,12,128,12,128,128:4:0 +X 3018 . A <*> 0 . DP=21;I16=6,10,0,0,475,15057,0,0,929,54841,0,0,295,6991,0,0;QS=3,0;MQSB=0.863243;MQ0F=0 PL:DP:DV 0,27,192:9:0 0,12,111:4:0 0,9,81:3:0 +X 3019 . C <*> 0 . DP=20;I16=6,12,0,0,618,21842,0,0,1049,62041,0,0,336,7818,0,0;QS=3,0;MQSB=0.85394;MQ0F=0 PL:DP:DV 0,30,242:10:0 0,15,129:5:0 0,9,104:3:0 +X 3020 . C <*> 0 . DP=20;I16=6,12,0,0,588,21046,0,0,1049,62041,0,0,340,7888,0,0;QS=3,0;MQSB=0.85394;MQ0F=0 PL:DP:DV 0,30,221:10:0 0,15,129:5:0 0,9,114:3:0 +X 3021 . T <*> 0 . DP=21;I16=5,13,0,0,618,22454,0,0,1049,62041,0,0,343,7921,0,0;QS=3,0;MQSB=0.814433;MQ0F=0 PL:DP:DV 0,30,216:10:0 0,15,147:5:0 0,9,109:3:0 +X 3022 . G <*> 0 . DP=20;I16=5,13,0,0,672,25292,0,0,1049,62041,0,0,348,7968,0,0;QS=3,0;MQSB=0.814433;MQ0F=0 PL:DP:DV 0,30,234:10:0 0,15,153:5:0 0,9,109:3:0 +X 3023 . T G,<*> 0 . DP=20;I16=5,12,0,1,554,19110,18,324,989,58441,60,3600,336,7740,17,289;QS=2.94231,0.0576923,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.814433;BQB=1;MQ0F=0 PL:DP:DV 0,12,191,27,194,199:10:1 0,15,125,15,125,125:5:0 0,9,111,9,111,111:3:0 +X 3024 . G <*> 0 . DP=20;I16=5,14,0,0,684,25122,0,0,1109,65641,0,0,382,8680,0,0;QS=3,0;MQSB=0.810584;MQ0F=0 PL:DP:DV 0,30,235:10:0 0,18,152:6:0 0,9,113:3:0 +X 3025 . G <*> 0 . DP=20;I16=5,14,0,0,625,21465,0,0,1109,65641,0,0,386,8722,0,0;QS=3,0;MQSB=0.810584;MQ0F=0 PL:DP:DV 0,30,225:10:0 0,18,133:6:0 0,9,109:3:0 +X 3026 . C <*> 0 . DP=20;I16=5,13,0,0,632,23132,0,0,1018,59282,0,0,367,8217,0,0;QS=3,0;MQSB=0.925212;MQ0F=0 PL:DP:DV 0,33,235:11:0 0,12,105:4:0 0,9,107:3:0 +X 3027 . A <*> 0 . DP=21;I16=6,15,0,0,693,24199,0,0,1198,70082,0,0,413,9199,0,0;QS=3,0;MQSB=0.940481;MQ0F=0 PL:DP:DV 0,33,222:11:0 0,21,175:7:0 0,9,108:3:0 +X 3028 . G <*> 0 . DP=21;I16=6,15,0,0,753,27935,0,0,1198,70082,0,0,417,9239,0,0;QS=3,0;MQSB=0.940481;MQ0F=0 PL:DP:DV 0,33,241:11:0 0,21,192:7:0 0,9,107:3:0 +X 3029 . G <*> 0 . DP=21;I16=6,15,0,0,787,29949,0,0,1198,70082,0,0,421,9303,0,0;QS=3,0;MQSB=0.940481;MQ0F=0 PL:DP:DV 0,33,251:11:0 0,21,189:7:0 0,9,109:3:0 +X 3030 . G <*> 0 . DP=22;I16=6,16,0,0,720,24728,0,0,1258,73682,0,0,424,9342,0,0;QS=3,0;MQSB=0.934321;MQ0F=0 PL:DP:DV 0,36,229:12:0 0,21,174:7:0 0,9,106:3:0 +X 3031 . A <*> 0 . DP=22;I16=5,16,0,0,693,24631,0,0,1198,70082,0,0,403,8783,0,0;QS=3,0;MQSB=0.902014;MQ0F=0 PL:DP:DV 0,36,222:12:0 0,18,162:6:0 0,9,113:3:0 +X 3032 . G <*> 0 . DP=22;I16=6,15,0,0,727,26093,0,0,1229,72841,0,0,405,8775,0,0;QS=3,0;MQSB=0.843281;MQ0F=0 PL:DP:DV 0,33,237:11:0 0,21,180:7:0 0,9,106:3:0 +X 3033 . G <*> 0 . DP=22;I16=6,15,0,0,697,24039,0,0,1198,70082,0,0,429,9407,0,0;QS=3,0;MQSB=0.940481;MQ0F=0 PL:DP:DV 0,33,235:11:0 0,21,160:7:0 0,9,106:3:0 +X 3034 . A <*> 0 . DP=23;I16=6,14,0,0,617,20947,0,0,1138,66482,0,0,387,8491,0,0;QS=3,0;MQSB=0.947033;MQ0F=0 PL:DP:DV 0,33,203:11:0 0,15,134:5:0 0,12,126:4:0 +X 3035 . G <*> 0 . DP=23;I16=7,13,0,0,641,22007,0,0,1138,66482,0,0,385,8379,0,0;QS=3,0;MQSB=0.972138;MQ0F=0 PL:DP:DV 0,30,208:10:0 0,18,151:6:0 0,12,128:4:0 +X 3036 . C <*> 0 . DP=23;I16=6,15,0,0,688,23652,0,0,1198,70082,0,0,388,8258,0,0;QS=3,0;MQSB=0.940481;MQ0F=0 PL:DP:DV 0,36,216:12:0 0,15,132:5:0 0,12,140:4:0 +X 3037 . T <*> 0 . DP=24;I16=7,16,0,0,797,28671,0,0,1318,77282,0,0,439,9521,0,0;QS=3,0;MQSB=0.955805;MQ0F=0 PL:DP:DV 0,36,242:12:0 0,21,170:7:0 0,12,143:4:0 +X 3038 . T <*> 0 . DP=25;I16=8,17,0,0,815,27469,0,0,1438,84482,0,0,441,9561,0,0;QS=3,0;MQSB=0.966223;MQ0F=0 PL:DP:DV 0,42,249:14:0 0,21,190:7:0 0,12,125:4:0 +X 3039 . G <*> 0 . DP=25;I16=8,17,0,0,780,25946,0,0,1438,84482,0,0,444,9630,0,0;QS=3,0;MQSB=0.966223;MQ0F=0 PL:DP:DV 0,42,249:14:0 0,21,156:7:0 0,12,127:4:0 +X 3040 . T <*> 0 . DP=25;I16=7,15,0,0,701,23777,0,0,1258,73682,0,0,385,8279,0,0;QS=3,0;MQSB=0.961028;MQ0F=0 PL:DP:DV 0,36,239:12:0 0,18,154:6:0 0,12,130:4:0 +X 3041 . G <*> 0 . DP=25;I16=8,16,0,0,824,29228,0,0,1378,80882,0,0,420,8982,0,0;QS=3,0;MQSB=0.970446;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,186:7:0 0,12,135:4:0 +X 3042 . G <*> 0 . DP=25;I16=8,15,0,0,795,28227,0,0,1349,80041,0,0,409,8839,0,0;QS=3,0;MQSB=0.889418;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,148:6:0 0,12,120:4:0 +X 3043 . T <*> 0 . DP=25;I16=8,16,0,0,723,23191,0,0,1378,80882,0,0,435,9415,0,0;QS=3,0;MQSB=0.970446;MQ0F=0 PL:DP:DV 0,39,233:13:0 0,21,151:7:0 0,12,124:4:0 +X 3044 . A C,<*> 0 . DP=26;I16=8,15,0,1,665,20809,15,225,1318,77282,60,3600,392,8498,14,196;QS=2.96104,0.038961,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.970446;BQB=1;MQ0F=0 PL:DP:DV 0,26,216,39,219,220:14:1 0,18,133,18,133,133:6:0 0,12,124,12,124,124:4:0 +X 3045 . C <*> 0 . DP=26;I16=8,16,0,0,754,25232,0,0,1378,80882,0,0,403,8627,0,0;QS=3,0;MQSB=0.970446;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,133:6:0 0,12,122:4:0 +X 3046 . A <*> 0 . DP=25;I16=8,15,0,0,748,26170,0,0,1349,80041,0,0,400,8540,0,0;QS=3,0;MQSB=0.889418;MQ0F=0 PL:DP:DV 0,39,245:13:0 0,18,160:6:0 0,12,141:4:0 +X 3047 . G <*> 0 . DP=25;I16=8,15,0,0,766,26998,0,0,1318,77282,0,0,396,8432,0,0;QS=3,0;MQSB=0.974802;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,143:6:0 0,12,129:4:0 +X 3048 . T <*> 0 . DP=25;I16=8,11,0,0,608,20554,0,0,1109,65641,0,0,320,6762,0,0;QS=3,0;MQSB=0.902014;MQ0F=0 PL:DP:DV 0,30,226:10:0 0,15,128:5:0 0,12,129:4:0 +X 3049 . G <*> 0 . DP=24;I16=8,16,0,0,831,29557,0,0,1378,80882,0,0,426,9068,0,0;QS=3,0;MQSB=0.970446;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,161:6:0 0,9,105:3:0 +X 3050 . G <*> 0 . DP=24;I16=8,14,0,0,729,25093,0,0,1258,73682,0,0,379,8041,0,0;QS=3,0;MQSB=0.979255;MQ0F=0 PL:DP:DV 0,39,253:13:0 0,18,159:6:0 0,9,100:3:0 +X 3051 . A <*> 0 . DP=23;I16=8,15,0,0,724,24200,0,0,1318,77282,0,0,423,9091,0,0;QS=3,0;MQSB=0.974802;MQ0F=0 PL:DP:DV 0,42,243:14:0 0,18,152:6:0 0,9,103:3:0 +X 3052 . C <*> 0 . DP=23;I16=7,13,0,0,612,19876,0,0,1169,69241,0,0,363,7779,0,0;QS=3,0;MQSB=0.962269;MQ0F=0 PL:DP:DV 0,36,226:12:0 0,15,117:5:0 0,9,93:3:0 +X 3053 . A <*> 0 . DP=22;I16=8,11,0,0,616,21288,0,0,1078,62882,0,0,360,7740,0,0;QS=3,0;MQSB=0.992359;MQ0F=0 PL:DP:DV 0,33,234:11:0 0,15,118:5:0 0,9,110:3:0 +X 3054 . G <*> 0 . DP=22;I16=8,14,0,0,761,27617,0,0,1258,73682,0,0,414,8932,0,0;QS=3,0;MQSB=0.979255;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,126:5:0 0,9,99:3:0 +X 3055 . G <*> 0 . DP=22;I16=8,9,0,0,566,19890,0,0,958,55682,0,0,333,7219,0,0;QS=3,0;MQSB=0.998843;MQ0F=0 PL:DP:DV 0,30,228:10:0 0,12,111:4:0 0,9,105:3:0 +X 3056 . C <*> 0 . DP=22;I16=7,14,0,0,701,24685,0,0,1198,70082,0,0,420,9298,0,0;QS=3,0;MQSB=0.966484;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,125:4:0 0,12,122:4:0 +X 3057 . C <*> 0 . DP=23;I16=8,13,0,0,706,24988,0,0,1198,70082,0,0,411,9253,0,0;QS=3,0;MQSB=0.983744;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,128:5:0 0,9,92:3:0 +X 3058 . C <*> 0 . DP=23;I16=9,14,0,0,707,23327,0,0,1318,77282,0,0,429,9471,0,0;QS=3,0;MQSB=0.987676;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,131:5:0 0,12,116:4:0 +X 3059 . T G,<*> 0 . DP=23;I16=9,11,0,1,638,21954,16,256,1169,69241,60,3600,355,7761,22,484;QS=2.95876,0.0412371,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.913101;BQB=1;MQ0F=0 PL:DP:DV 0,22,234,36,237,239:13:1 0,15,144,15,144,144:5:0 0,9,94,9,94,94:3:0 +X 3060 . G <*> 0 . DP=24;I16=9,10,0,0,578,19136,0,0,1109,65641,0,0,324,6992,0,0;QS=3,0;MQSB=0.920044;MQ0F=0 PL:DP:DV 0,33,221:11:0 0,12,121:4:0 0,12,116:4:0 +X 3061 . C <*> 0 . DP=24;I16=9,15,0,0,770,25918,0,0,1378,80882,0,0,446,10136,0,0;QS=3,0;MQSB=0.984127;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,138:5:0 0,15,145:5:0 +X 3062 . C <*> 0 . DP=23;I16=9,13,0,0,727,25019,0,0,1289,76441,0,0,419,9551,0,0;QS=3,0;MQSB=0.910098;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,137:5:0 0,15,134:5:0 +X 3063 . C <*> 0 . DP=23;I16=9,13,0,0,651,21695,0,0,1258,73682,0,0,415,9511,0,0;QS=3,0;MQSB=0.991121;MQ0F=0 PL:DP:DV 0,36,233:12:0 0,15,130:5:0 0,15,133:5:0 +X 3064 . A <*> 0 . DP=23;I16=9,12,0,0,691,24125,0,0,1198,70082,0,0,385,8815,0,0;QS=3,0;MQSB=0.994334;MQ0F=0 PL:DP:DV 0,36,254:12:0 0,12,118:4:0 0,15,144:5:0 +X 3065 . G <*> 0 . DP=22;I16=7,14,0,0,653,21733,0,0,1198,70082,0,0,426,9986,0,0;QS=3,0;MQSB=0.966484;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,109:4:0 0,12,118:4:0 +X 3066 . A <*> 0 . DP=21;I16=7,10,0,0,501,16143,0,0,989,58441,0,0,326,7598,0,0;QS=3,0;MQSB=0.887766;MQ0F=0 PL:DP:DV 0,27,202:9:0 0,12,109:4:0 0,12,104:4:0 +X 3067 . T <*> 0 . DP=21;I16=7,12,0,0,535,16779,0,0,1078,62882,0,0,373,8787,0,0;QS=3,0;MQSB=0.977926;MQ0F=0 PL:DP:DV 0,36,223:12:0 0,9,82:3:0 0,12,103:4:0 +X 3068 . G <*> 0 . DP=20;I16=7,12,0,0,645,22781,0,0,1109,65641,0,0,396,9312,0,0;QS=3,0;MQSB=0.879351;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,115:4:0 0,9,84:3:0 +X 3069 . G <*> 0 . DP=20;I16=7,10,0,0,468,14412,0,0,989,58441,0,0,346,8070,0,0;QS=3,0;MQSB=0.887766;MQ0F=0 PL:DP:DV 0,33,203:11:0 0,12,102:4:0 0,6,57:2:0 +X 3070 . C <*> 0 . DP=20;I16=6,13,0,0,627,22135,0,0,1078,62882,0,0,414,9878,0,0;QS=3,0;MQSB=0.953977;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,98:3:0 0,9,98:3:0 +X 3071 . C <*> 0 . DP=20;I16=7,13,0,0,715,26563,0,0,1138,66482,0,0,419,9893,0,0;QS=3,0;MQSB=0.972138;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,123:4:0 0,9,98:3:0 +X 3072 . C <*> 0 . DP=20;I16=6,13,0,0,696,25784,0,0,1109,65641,0,0,414,9866,0,0;QS=3,0;MQSB=0.965977;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,128:4:0 0,9,106:3:0 +X 3073 . C <*> 0 . DP=20;I16=6,13,0,0,706,26822,0,0,1109,65641,0,0,414,9872,0,0;QS=3,0;MQSB=0.965977;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,135:4:0 0,9,115:3:0 +X 3074 . C <*> 0 . DP=20;I16=6,13,0,0,724,28052,0,0,1109,65641,0,0,414,9886,0,0;QS=3,0;MQSB=0.965977;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,135:4:0 0,9,116:3:0 +X 3075 . C <*> 0 . DP=21;I16=6,13,0,0,630,21614,0,0,1109,65641,0,0,389,9283,0,0;QS=3,0;MQSB=0.965977;MQ0F=0 PL:DP:DV 0,33,239:11:0 0,15,140:5:0 0,9,94:3:0 +X 3076 . G <*> 0 . DP=21;I16=6,14,0,0,645,21809,0,0,1169,69241,0,0,415,9939,0,0;QS=3,0;MQSB=0.969852;MQ0F=0 PL:DP:DV 0,36,252:12:0 0,15,126:5:0 0,9,91:3:0 +X 3077 . C <*> 0 . DP=20;I16=5,15,0,0,694,25228,0,0,1169,69241,0,0,417,9979,0,0;QS=3,0;MQSB=0.976472;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,116:4:0 0,9,111:3:0 +X 3078 . C <*> 0 . DP=20;I16=5,15,0,0,767,29761,0,0,1169,69241,0,0,420,10028,0,0;QS=3,0;MQSB=0.976472;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,113:4:0 0,9,111:3:0 +X 3079 . T <*> 0 . DP=20;I16=5,15,0,0,749,28479,0,0,1169,69241,0,0,422,10038,0,0;QS=3,0;MQSB=0.976472;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,119:4:0 0,9,116:3:0 +X 3080 . G <*> 0 . DP=21;I16=6,15,0,0,785,29901,0,0,1229,72841,0,0,424,10060,0,0;QS=3,0;MQSB=0.973096;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,124:4:0 0,9,103:3:0 +X 3081 . C <*> 0 . DP=21;I16=6,15,0,0,752,27438,0,0,1229,72841,0,0,425,9997,0,0;QS=3,0;MQSB=0.973096;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,118:4:0 0,9,92:3:0 +X 3082 . C <*> 0 . DP=21;I16=6,15,0,0,787,30211,0,0,1229,72841,0,0,426,9952,0,0;QS=3,0;MQSB=0.973096;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,118:4:0 0,9,112:3:0 +X 3083 . T C,<*> 0 . DP=21;I16=6,14,0,1,764,29458,33,1089,1169,69241,60,3600,401,9249,25,625;QS=2.93666,0.0633397,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.973096;BQB=1;MQ0F=0 PL:DP:DV 0,9,255,39,255,255:14:1 0,12,130,12,130,130:4:0 0,9,113,9,113,113:3:0 +X 3084 . G <*> 0 . DP=23;I16=6,17,0,0,859,32755,0,0,1349,80041,0,0,426,9812,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,118:4:0 0,12,135:4:0 +X 3085 . T <*> 0 . DP=23;I16=6,16,0,0,824,31132,0,0,1289,76441,0,0,426,9718,0,0;QS=3,0;MQSB=0.97584;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,124:4:0 0,12,135:4:0 +X 3086 . G <*> 0 . DP=23;I16=6,17,0,0,853,32429,0,0,1349,80041,0,0,428,9648,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,125:4:0 0,12,131:4:0 +X 3087 . G <*> 0 . DP=23;I16=6,17,0,0,897,35253,0,0,1349,80041,0,0,429,9599,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,130:4:0 0,12,137:4:0 +X 3088 . A <*> 0 . DP=22;I16=6,16,0,0,834,31738,0,0,1289,76441,0,0,431,9571,0,0;QS=3,0;MQSB=0.97584;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,110:3:0 0,12,135:4:0 +X 3089 . A <*> 0 . DP=23;I16=7,16,0,0,919,36903,0,0,1349,80041,0,0,432,9514,0,0;QS=3,0;MQSB=0.973027;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,113:3:0 0,15,175:5:0 +X 3090 . G <*> 0 . DP=23;I16=7,16,0,0,885,34349,0,0,1349,80041,0,0,433,9431,0,0;QS=3,0;MQSB=0.973027;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,103:3:0 0,15,160:5:0 +X 3091 . T <*> 0 . DP=23;I16=7,16,0,0,840,31352,0,0,1349,80041,0,0,434,9374,0,0;QS=3,0;MQSB=0.973027;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,105:3:0 0,15,153:5:0 +X 3092 . T <*> 0 . DP=24;I16=8,16,0,0,895,33673,0,0,1409,83641,0,0,434,9294,0,0;QS=3,0;MQSB=0.970446;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,109:3:0 0,15,165:5:0 +X 3093 . G <*> 0 . DP=25;I16=9,16,0,0,955,37033,0,0,1469,87241,0,0,434,9192,0,0;QS=3,0;MQSB=0.968069;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,133:4:0 0,15,157:5:0 +X 3094 . A <*> 0 . DP=25;I16=9,15,0,0,891,33319,0,0,1409,83641,0,0,425,9019,0,0;QS=3,0;MQSB=0.96464;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,134:4:0 0,15,161:5:0 +X 3095 . C <*> 0 . DP=25;I16=9,15,0,0,891,33469,0,0,1409,83641,0,0,425,8955,0,0;QS=3,0;MQSB=0.96464;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,131:4:0 0,15,163:5:0 +X 3096 . C <*> 0 . DP=25;I16=9,16,0,0,952,36626,0,0,1469,87241,0,0,436,9014,0,0;QS=3,0;MQSB=0.968069;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,121:4:0 0,15,167:5:0 +X 3097 . A <*> 0 . DP=25;I16=9,16,0,0,972,38200,0,0,1469,87241,0,0,436,8984,0,0;QS=3,0;MQSB=0.968069;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,144:4:0 0,15,174:5:0 +X 3098 . G <*> 0 . DP=25;I16=9,16,0,0,959,37269,0,0,1469,87241,0,0,436,8986,0,0;QS=3,0;MQSB=0.968069;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,134:4:0 0,15,166:5:0 +X 3099 . A <*> 0 . DP=25;I16=9,16,0,0,888,32632,0,0,1469,87241,0,0,435,8971,0,0;QS=3,0;MQSB=0.968069;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,124:4:0 0,15,165:5:0 +X 3100 . C <*> 0 . DP=25;I16=9,16,0,0,870,31084,0,0,1469,87241,0,0,434,8990,0,0;QS=3,0;MQSB=0.968069;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,126:4:0 0,15,159:5:0 +X 3101 . C <*> 0 . DP=25;I16=9,16,0,0,960,37090,0,0,1469,87241,0,0,432,8992,0,0;QS=3,0;MQSB=0.968069;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,134:4:0 0,15,161:5:0 +X 3102 . A <*> 0 . DP=26;I16=10,16,0,0,952,35186,0,0,1529,90841,0,0,430,9026,0,0;QS=3,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,134:4:0 0,18,189:6:0 +X 3103 . T <*> 0 . DP=26;I16=10,16,0,0,920,33094,0,0,1529,90841,0,0,427,8993,0,0;QS=3,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,131:4:0 0,18,187:6:0 +X 3104 . C T,<*> 0 . DP=25;I16=8,15,2,0,900,35584,80,3202,1349,80041,120,7200,385,8143,40,850;QS=2.58763,0.412371,0;VDB=0.8;SGB=0.346553;RPB=0.717391;MQB=0.956522;MQSB=0.962269;BQB=0.978261;MQ0F=0 PL:DP:DV 0,48,255,48,255,255:16:0 0,12,144,12,144,144:4:0 59,0,93,68,99,157:5:2 +X 3105 . T <*> 0 . DP=25;I16=10,15,0,0,959,37057,0,0,1469,87241,0,0,422,8976,0,0;QS=3,0;MQSB=0.962269;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,149:4:0 0,15,169:5:0 +X 3106 . G <*> 0 . DP=23;I16=10,13,0,0,881,33891,0,0,1380,82800,0,0,420,8940,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,132:4:0 0,15,167:5:0 +X 3107 . T <*> 0 . DP=24;I16=10,14,0,0,878,32496,0,0,1440,86400,0,0,418,8932,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,132:4:0 0,18,195:6:0 +X 3108 . C <*> 0 . DP=24;I16=10,14,0,0,909,34897,0,0,1440,86400,0,0,417,8953,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,137:4:0 0,18,189:6:0 +X 3109 . A <*> 0 . DP=24;I16=10,14,0,0,905,34249,0,0,1440,86400,0,0,416,9004,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,136:4:0 0,18,195:6:0 +X 3110 . C <*> 0 . DP=24;I16=10,13,0,0,919,37099,0,0,1380,82800,0,0,413,8933,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,105:3:0 0,18,189:6:0 +X 3111 . A <*> 0 . DP=25;I16=10,14,0,0,961,38943,0,0,1440,86400,0,0,410,8888,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,111:3:0 0,18,205:6:0 +X 3112 . G <*> 0 . DP=25;I16=10,14,0,0,958,39370,0,0,1440,86400,0,0,407,8821,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,116:3:0 0,18,191:6:0 +X 3113 . C <*> 0 . DP=25;I16=10,14,0,0,961,39641,0,0,1440,86400,0,0,403,8735,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,112:3:0 0,18,193:6:0 +X 3114 . A <*> 0 . DP=24;I16=10,13,0,0,928,38448,0,0,1380,82800,0,0,400,8680,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,116:3:0 0,18,200:6:0 +X 3115 . G <*> 0 . DP=23;I16=10,12,0,0,872,35800,0,0,1320,79200,0,0,397,8603,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,117:3:0 0,18,195:6:0 +X 3116 . G <*> 0 . DP=23;I16=10,12,0,0,870,35372,0,0,1320,79200,0,0,394,8552,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,108:3:0 0,18,194:6:0 +X 3117 . T <*> 0 . DP=22;I16=9,13,0,0,771,27537,0,0,1320,79200,0,0,399,8575,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,96:3:0 0,18,177:6:0 +X 3118 . A <*> 0 . DP=22;I16=9,13,0,0,813,30285,0,0,1320,79200,0,0,397,8537,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,111:3:0 0,18,193:6:0 +X 3119 . A <*> 0 . DP=22;I16=9,13,0,0,886,35954,0,0,1320,79200,0,0,393,8423,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,120:3:0 0,18,207:6:0 +X 3120 . G <*> 0 . DP=22;I16=9,13,0,0,839,32281,0,0,1320,79200,0,0,389,8333,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,104:3:0 0,18,182:6:0 +X 3121 . A <*> 0 . DP=22;I16=10,12,0,0,777,28399,0,0,1320,79200,0,0,386,8266,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,111:3:0 0,18,194:6:0 +X 3122 . C <*> 0 . DP=22;I16=10,12,0,0,848,33002,0,0,1320,79200,0,0,384,8222,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,110:3:0 0,18,192:6:0 +X 3123 . T <*> 0 . DP=22;I16=10,12,0,0,854,33456,0,0,1320,79200,0,0,382,8202,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,114:3:0 0,18,204:6:0 +X 3124 . C <*> 0 . DP=22;I16=10,11,0,0,882,38286,0,0,1260,75600,0,0,381,8205,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,104:3:0 0,15,178:5:0 +X 3125 . T <*> 0 . DP=22;I16=10,11,0,0,860,36764,0,0,1260,75600,0,0,380,8230,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,106:3:0 0,15,185:5:0 +X 3126 . G <*> 0 . DP=22;I16=10,11,0,0,834,34998,0,0,1260,75600,0,0,379,8277,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,97:3:0 0,15,174:5:0 +X 3127 . C <*> 0 . DP=23;I16=10,11,0,0,847,36381,0,0,1260,75600,0,0,378,8346,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,87:3:0 0,15,175:5:0 +X 3128 . T <*> 0 . DP=22;I16=9,12,0,0,850,35972,0,0,1229,72841,0,0,402,9010,0,0;QS=3,0;MQSB=0.950149;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,107:3:0 0,15,182:5:0 +X 3129 . T <*> 0 . DP=22;I16=9,12,0,0,809,32621,0,0,1229,72841,0,0,401,9067,0,0;QS=3,0;MQSB=0.950149;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,107:3:0 0,15,178:5:0 +X 3130 . T <*> 0 . DP=21;I16=9,10,0,0,744,30322,0,0,1140,68400,0,0,376,8516,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,82:2:0 0,15,169:5:0 +X 3131 . C <*> 0 . DP=21;I16=9,10,0,0,792,34778,0,0,1140,68400,0,0,376,8606,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,83:2:0 0,15,170:5:0 +X 3132 . T <*> 0 . DP=21;I16=9,11,0,0,819,35197,0,0,1169,69241,0,0,400,9288,0,0;QS=3,0;MQSB=0.943233;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,109:3:0 0,15,174:5:0 +X 3133 . G <*> 0 . DP=21;I16=9,11,0,0,800,34016,0,0,1169,69241,0,0,398,9312,0,0;QS=3,0;MQSB=0.943233;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,97:3:0 0,15,166:5:0 +X 3134 . G <*> 0 . DP=22;I16=10,11,0,0,773,30227,0,0,1229,72841,0,0,396,9352,0,0;QS=3,0;MQSB=0.939898;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,97:3:0 0,15,163:5:0 +X 3135 . G <*> 0 . DP=22;I16=9,12,0,0,812,33714,0,0,1229,72841,0,0,396,9408,0,0;QS=3,0;MQSB=0.950149;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,94:3:0 0,12,151:4:0 +X 3136 . C <*> 0 . DP=22;I16=9,12,0,0,811,33469,0,0,1229,72841,0,0,396,9430,0,0;QS=3,0;MQSB=0.950149;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,102:3:0 0,12,140:4:0 +X 3137 . A <*> 0 . DP=22;I16=10,11,0,0,786,31226,0,0,1229,72841,0,0,396,9416,0,0;QS=3,0;MQSB=0.939898;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,95:3:0 0,12,142:4:0 +X 3138 . A <*> 0 . DP=21;I16=9,11,0,0,720,28200,0,0,1169,69241,0,0,398,9414,0,0;QS=3,0;MQSB=0.943233;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,98:3:0 0,12,147:4:0 +X 3139 . C <*> 0 . DP=21;I16=9,11,0,0,755,31433,0,0,1169,69241,0,0,400,9424,0,0;QS=3,0;MQSB=0.943233;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,91:3:0 0,12,139:4:0 +X 3140 . C <*> 0 . DP=21;I16=9,11,0,0,790,33238,0,0,1169,69241,0,0,402,9446,0,0;QS=3,0;MQSB=0.943233;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,102:3:0 0,12,145:4:0 +X 3141 . C <*> 0 . DP=21;I16=9,11,0,0,819,35401,0,0,1169,69241,0,0,404,9480,0,0;QS=3,0;MQSB=0.943233;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,101:3:0 0,12,150:4:0 +X 3142 . A <*> 0 . DP=21;I16=9,11,0,0,822,35744,0,0,1169,69241,0,0,405,9477,0,0;QS=3,0;MQSB=0.943233;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,107:3:0 0,12,155:4:0 +X 3143 . G <*> 0 . DP=22;I16=10,11,0,0,846,36468,0,0,1198,70082,0,0,406,9488,0,0;QS=3,0;MQSB=0.99938;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,104:3:0 0,12,151:4:0 +X 3144 . C <*> 0 . DP=23;I16=12,10,0,0,855,35905,0,0,1258,73682,0,0,409,9513,0,0;QS=3,0;MQSB=0.997828;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,104:3:0 0,15,165:5:0 +X 3145 . A <*> 0 . DP=23;I16=12,10,0,0,869,35937,0,0,1258,73682,0,0,414,9554,0,0;QS=3,0;MQSB=0.997828;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,106:3:0 0,15,174:5:0 +X 3146 . G <*> 0 . DP=23;I16=12,10,0,0,895,38345,0,0,1258,73682,0,0,419,9613,0,0;QS=3,0;MQSB=0.997828;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,105:3:0 0,15,179:5:0 +X 3147 . G <*> 0 . DP=24;I16=11,11,0,0,851,34815,0,0,1289,76441,0,0,419,9623,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,123:4:0 0,15,172:5:0 +X 3148 . T <*> 0 . DP=24;I16=12,11,0,0,795,30097,0,0,1318,77282,0,0,428,9682,0,0;QS=3,0;MQSB=0.999527;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,107:4:0 0,15,149:5:0 +X 3149 . G <*> 0 . DP=24;I16=12,11,0,0,910,38142,0,0,1318,77282,0,0,433,9743,0,0;QS=3,0;MQSB=0.999527;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,120:4:0 0,15,167:5:0 +X 3150 . A <*> 0 . DP=24;I16=12,11,0,0,854,33784,0,0,1318,77282,0,0,438,9822,0,0;QS=3,0;MQSB=0.999527;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,129:4:0 0,15,167:5:0 +X 3151 . C <*> 0 . DP=24;I16=12,11,0,0,873,35315,0,0,1318,77282,0,0,442,9870,0,0;QS=3,0;MQSB=0.999527;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,125:4:0 0,15,163:5:0 +X 3152 . C <*> 0 . DP=24;I16=12,11,0,0,857,34239,0,0,1318,77282,0,0,445,9889,0,0;QS=3,0;MQSB=0.999527;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,123:4:0 0,15,155:5:0 +X 3153 . C <*> 0 . DP=24;I16=12,11,0,0,891,36711,0,0,1318,77282,0,0,448,9930,0,0;QS=3,0;MQSB=0.999527;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,125:4:0 0,15,166:5:0 +X 3154 . T <*> 0 . DP=25;I16=13,11,0,0,938,38052,0,0,1378,80882,0,0,451,9993,0,0;QS=3,0;MQSB=0.998323;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,133:4:0 0,18,194:6:0 +X 3155 . G <*> 0 . DP=25;I16=13,11,0,0,953,39423,0,0,1378,80882,0,0,454,10030,0,0;QS=3,0;MQSB=0.998323;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,127:4:0 0,18,180:6:0 +X 3156 . G <*> 0 . DP=25;I16=13,11,0,0,946,38818,0,0,1378,80882,0,0,457,10093,0,0;QS=3,0;MQSB=0.998323;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,126:4:0 0,18,189:6:0 +X 3157 . A <*> 0 . DP=24;I16=12,12,0,0,896,33648,0,0,1378,80882,0,0,486,10806,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,130:4:0 0,18,193:6:0 +X 3158 . A <*> 0 . DP=24;I16=12,12,0,0,856,31670,0,0,1378,80882,0,0,490,10918,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,125:4:0 0,18,192:6:0 +X 3159 . T <*> 0 . DP=24;I16=11,12,0,0,864,32952,0,0,1349,80041,0,0,477,10749,0,0;QS=3,0;MQSB=0.944319;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,134:4:0 0,18,194:6:0 +X 3160 . T <*> 0 . DP=24;I16=12,12,0,0,907,34719,0,0,1378,80882,0,0,494,11018,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,134:4:0 0,18,193:6:0 +X 3161 . C <*> 0 . DP=24;I16=12,12,0,0,880,33336,0,0,1378,80882,0,0,494,11006,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,123:4:0 0,18,196:6:0 +X 3162 . C <*> 0 . DP=24;I16=12,12,0,0,916,35764,0,0,1378,80882,0,0,494,11018,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,127:4:0 0,18,188:6:0 +X 3163 . T A,<*> 0 . DP=24;I16=11,12,1,0,895,35099,13,169,1349,80041,29,841,473,10603,20,400;QS=2.97436,0.025641,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=1;BQB=1;MQ0F=0 PL:DP:DV 0,28,255,39,255,255:14:1 0,12,137,12,137,137:4:0 0,18,200,18,200,200:6:0 +X 3164 . G <*> 0 . DP=24;I16=12,11,0,0,887,34437,0,0,1349,80041,0,0,467,10385,0,0;QS=3,0;MQSB=0.944319;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,106:3:0 0,18,188:6:0 +X 3165 . T <*> 0 . DP=24;I16=12,12,0,0,880,32654,0,0,1378,80882,0,0,490,10990,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,133:4:0 0,18,189:6:0 +X 3166 . C <*> 0 . DP=24;I16=12,11,0,0,871,33389,0,0,1349,80041,0,0,463,10369,0,0;QS=3,0;MQSB=0.944319;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,111:3:0 0,18,193:6:0 +X 3167 . C <*> 0 . DP=23;I16=12,11,0,0,879,34199,0,0,1318,77282,0,0,487,11021,0,0;QS=3,0;MQSB=0.999527;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,131:4:0 0,18,189:6:0 +X 3168 . A <*> 0 . DP=23;I16=12,11,0,0,874,33294,0,0,1318,77282,0,0,486,11070,0,0;QS=3,0;MQSB=0.999527;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,125:4:0 0,18,192:6:0 +X 3169 . T <*> 0 . DP=23;I16=11,11,0,0,824,31124,0,0,1289,76441,0,0,458,10416,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,128:4:0 0,18,187:6:0 +X 3170 . C <*> 0 . DP=23;I16=11,11,0,0,877,35167,0,0,1289,76441,0,0,453,10307,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,129:4:0 0,18,201:6:0 +X 3171 . T <*> 0 . DP=23;I16=11,11,0,0,843,32615,0,0,1289,76441,0,0,448,10216,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,127:4:0 0,18,201:6:0 +X 3172 . G <*> 0 . DP=23;I16=12,11,0,0,813,29605,0,0,1318,77282,0,0,468,10768,0,0;QS=3,0;MQSB=0.999527;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,120:4:0 0,18,176:6:0 +X 3173 . G <*> 0 . DP=23;I16=11,11,0,0,801,29659,0,0,1289,76441,0,0,436,9988,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,126:4:0 0,18,174:6:0 +X 3174 . C <*> 0 . DP=24;I16=13,11,0,0,938,36926,0,0,1378,80882,0,0,454,10476,0,0;QS=3,0;MQSB=0.998323;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,127:4:0 0,18,194:6:0 +X 3175 . A <*> 0 . DP=25;I16=13,11,0,0,914,35230,0,0,1409,83641,0,0,422,9684,0,0;QS=3,0;MQSB=0.931547;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,127:4:0 0,21,209:7:0 +X 3176 . G <*> 0 . DP=24;I16=14,10,0,0,909,34913,0,0,1378,80882,0,0,442,10164,0,0;QS=3,0;MQSB=0.993166;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,97:3:0 0,21,205:7:0 +X 3177 . G <*> 0 . DP=23;I16=14,9,0,0,793,28159,0,0,1318,77282,0,0,438,10040,0,0;QS=3,0;MQSB=0.987676;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,93:3:0 0,21,195:7:0 +X 3178 . T <*> 0 . DP=23;I16=13,9,0,0,754,26290,0,0,1289,76441,0,0,408,9262,0,0;QS=3,0;MQSB=0.910098;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,96:3:0 0,21,173:7:0 +X 3179 . G <*> 0 . DP=23;I16=13,9,0,0,802,29686,0,0,1289,76441,0,0,403,9131,0,0;QS=3,0;MQSB=0.910098;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,97:3:0 0,21,188:7:0 +X 3180 . G <*> 0 . DP=22;I16=12,9,0,0,701,24107,0,0,1229,72841,0,0,398,8970,0,0;QS=3,0;MQSB=0.913101;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,92:3:0 0,21,175:7:0 +X 3181 . G <*> 0 . DP=22;I16=13,9,0,0,795,29503,0,0,1258,73682,0,0,418,9452,0,0;QS=3,0;MQSB=0.991121;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,99:3:0 0,21,193:7:0 +X 3182 . C <*> 0 . DP=22;I16=12,9,0,0,772,28878,0,0,1198,70082,0,0,396,9038,0,0;QS=3,0;MQSB=0.994334;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,99:3:0 0,21,184:7:0 +X 3183 . A <*> 0 . DP=22;I16=12,9,0,0,766,28304,0,0,1229,72841,0,0,382,8546,0,0;QS=3,0;MQSB=0.913101;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,106:3:0 0,21,193:7:0 +X 3184 . T <*> 0 . DP=21;I16=12,8,0,0,721,26533,0,0,1169,69241,0,0,377,8409,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,30,248:10:0 0,9,106:3:0 0,21,196:7:0 +X 3185 . T <*> 0 . DP=20;I16=13,7,0,0,740,27660,0,0,1138,66482,0,0,397,8865,0,0;QS=3,0;MQSB=0.972138;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,103:3:0 0,18,174:6:0 +X 3186 . G <*> 0 . DP=20;I16=13,7,0,0,741,28311,0,0,1138,66482,0,0,391,8665,0,0;QS=3,0;MQSB=0.972138;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,103:3:0 0,18,169:6:0 +X 3187 . A <*> 0 . DP=20;I16=13,7,0,0,693,24927,0,0,1138,66482,0,0,385,8485,0,0;QS=3,0;MQSB=0.972138;MQ0F=0 PL:DP:DV 0,33,247:11:0 0,9,102:3:0 0,18,171:6:0 +X 3188 . A <*> 0 . DP=20;I16=13,7,0,0,704,25746,0,0,1138,66482,0,0,379,8325,0,0;QS=3,0;MQSB=0.972138;MQ0F=0 PL:DP:DV 0,33,249:11:0 0,9,100:3:0 0,18,174:6:0 +X 3189 . A <*> 0 . DP=21;I16=13,8,0,0,763,28171,0,0,1198,70082,0,0,373,8185,0,0;QS=3,0;MQSB=0.983744;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,125:4:0 0,18,174:6:0 +X 3190 . C <*> 0 . DP=20;I16=11,8,0,0,675,24915,0,0,1109,65641,0,0,344,7440,0,0;QS=3,0;MQSB=0.902014;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,123:4:0 0,15,148:5:0 +X 3191 . T <*> 0 . DP=21;I16=11,9,0,0,773,30203,0,0,1169,69241,0,0,340,7340,0,0;QS=3,0;MQSB=0.916401;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,130:4:0 0,15,171:5:0 +X 3192 . G <*> 0 . DP=21;I16=12,9,0,0,751,27785,0,0,1198,70082,0,0,362,7886,0,0;QS=3,0;MQSB=0.994334;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,125:4:0 0,15,152:5:0 +X 3193 . G <*> 0 . DP=21;I16=12,9,0,0,756,27614,0,0,1198,70082,0,0,359,7829,0,0;QS=3,0;MQSB=0.994334;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,121:4:0 0,15,148:5:0 +X 3194 . T C,<*> 0 . DP=21;I16=10,10,1,0,730,26992,18,324,1169,69241,29,841,332,7168,25,625;QS=2.95652,0.0434783,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.99938;BQB=1;MQ0F=0 PL:DP:DV 0,18,255,33,255,255:12:1 0,9,98,9,98,98:3:0 0,18,178,18,178,178:6:0 +X 3195 . T <*> 0 . DP=21;I16=11,10,0,0,776,29184,0,0,1198,70082,0,0,356,7778,0,0;QS=3,0;MQSB=0.99938;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,95:3:0 0,18,189:6:0 +X 3196 . T <*> 0 . DP=21;I16=10,10,0,0,722,26472,0,0,1169,69241,0,0,329,7111,0,0;QS=3,0;MQSB=0.931063;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,91:3:0 0,18,186:6:0 +X 3197 . A <*> 0 . DP=22;I16=12,9,0,0,715,24911,0,0,1229,72841,0,0,352,7718,0,0;QS=3,0;MQSB=0.950149;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,103:3:0 0,18,179:6:0 +X 3198 . A <*> 0 . DP=21;I16=12,8,0,0,745,28155,0,0,1169,69241,0,0,345,7675,0,0;QS=3,0;MQSB=0.953497;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,105:3:0 0,18,198:6:0 +X 3199 . A <*> 0 . DP=21;I16=11,9,0,0,736,27514,0,0,1200,72000,0,0,326,7080,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,105:3:0 0,18,196:6:0 +X 3200 . A <*> 0 . DP=20;I16=11,9,0,0,735,27533,0,0,1169,69241,0,0,350,7660,0,0;QS=3,0;MQSB=0.943233;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,108:3:0 0,18,195:6:0 +X 3201 . A <*> 0 . DP=20;I16=11,8,0,0,706,26814,0,0,1109,65641,0,0,338,7486,0,0;QS=3,0;MQSB=0.946915;MQ0F=0 PL:DP:DV 0,30,248:10:0 0,9,107:3:0 0,18,198:6:0 +X 3202 . T <*> 0 . DP=20;I16=10,9,0,0,692,25620,0,0,1140,68400,0,0,321,6907,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,249:10:0 0,9,109:3:0 0,18,187:6:0 +X 3203 . G A,<*> 0 . DP=19;I16=9,9,1,0,644,23760,19,361,1080,64800,29,841,320,6872,25,625;QS=2.94823,0.0517711,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.934728;BQB=1;MQ0F=0 PL:DP:DV 0,14,239,30,242,248:11:1 0,9,105,9,105,105:3:0 0,15,160,15,160,160:5:0 +X 3204 . T <*> 0 . DP=19;I16=9,8,0,0,619,22955,0,0,1020,61200,0,0,306,6686,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,234:9:0 0,9,101:3:0 0,15,169:5:0 +X 3205 . C <*> 0 . DP=19;I16=9,9,0,0,672,25340,0,0,1080,64800,0,0,318,6856,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,99:3:0 0,15,157:5:0 +X 3206 . A <*> 0 . DP=19;I16=10,9,0,0,661,23623,0,0,1109,65641,0,0,342,7500,0,0;QS=3,0;MQSB=0.934728;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,91:3:0 0,15,165:5:0 +X 3207 . C <*> 0 . DP=19;I16=9,9,0,0,642,23618,0,0,1080,64800,0,0,316,6912,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,90:3:0 0,15,158:5:0 +X 3208 . A <*> 0 . DP=18;I16=10,8,0,0,619,22023,0,0,1049,62041,0,0,341,7591,0,0;QS=3,0;MQSB=0.938795;MQ0F=0 PL:DP:DV 0,33,247:11:0 0,9,95:3:0 0,12,142:4:0 +X 3209 . C <*> 0 . DP=19;I16=11,8,0,0,681,24747,0,0,1109,65641,0,0,340,7612,0,0;QS=3,0;MQSB=0.946915;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,106:3:0 0,12,134:4:0 +X 3210 . C <*> 0 . DP=18;I16=11,7,0,0,664,24900,0,0,1049,62041,0,0,340,7602,0,0;QS=3,0;MQSB=0.951002;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,101:3:0 0,12,141:4:0 +X 3211 . A <*> 0 . DP=17;I16=11,6,0,0,645,24627,0,0,989,58441,0,0,341,7611,0,0;QS=3,0;MQSB=0.955563;MQ0F=0 PL:DP:DV 0,30,243:10:0 0,9,106:3:0 0,12,140:4:0 +X 3212 . T <*> 0 . DP=17;I16=10,6,0,0,575,21295,0,0,960,57600,0,0,316,6964,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,222:9:0 0,9,100:3:0 0,12,144:4:0 +X 3213 . A <*> 0 . DP=17;I16=10,6,0,0,597,22631,0,0,960,57600,0,0,316,6962,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,228:9:0 0,9,117:3:0 0,12,138:4:0 +X 3214 . G <*> 0 . DP=17;I16=11,6,0,0,615,23103,0,0,989,58441,0,0,341,7605,0,0;QS=3,0;MQSB=0.955563;MQ0F=0 PL:DP:DV 0,30,243:10:0 0,9,110:3:0 0,12,134:4:0 +X 3215 . G <*> 0 . DP=17;I16=11,6,0,0,591,21523,0,0,989,58441,0,0,340,7592,0,0;QS=3,0;MQSB=0.955563;MQ0F=0 PL:DP:DV 0,30,241:10:0 0,9,93:3:0 0,12,128:4:0 +X 3216 . C <*> 0 . DP=17;I16=11,6,0,0,623,23303,0,0,989,58441,0,0,339,7597,0,0;QS=3,0;MQSB=0.955563;MQ0F=0 PL:DP:DV 0,30,242:10:0 0,9,94:3:0 0,12,138:4:0 +X 3217 . C <*> 0 . DP=17;I16=11,6,0,0,570,19896,0,0,989,58441,0,0,337,7569,0,0;QS=3,0;MQSB=0.955563;MQ0F=0 PL:DP:DV 0,30,236:10:0 0,9,84:3:0 0,12,123:4:0 +X 3218 . G C,<*> 0 . DP=18;I16=10,7,1,0,547,18185,29,841,1020,61200,29,841,310,6932,24,576;QS=2.91667,0.0833333,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.951002;BQB=1;MQ0F=0 PL:DP:DV 0,4,202,30,205,221:11:1 0,9,96,9,96,96:3:0 0,12,112,12,112,112:4:0 +X 3219 . G A,<*> 0 . DP=18;I16=10,7,1,0,606,22158,19,361,1020,61200,29,841,308,6888,23,529;QS=2.94837,0.0516304,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.951002;BQB=1;MQ0F=0 PL:DP:DV 0,14,234,30,237,243:11:1 0,9,107,9,107,107:3:0 0,12,126,12,126,126:4:0 +X 3220 . G <*> 0 . DP=18;I16=11,7,0,0,631,22827,0,0,1049,62041,0,0,326,7248,0,0;QS=3,0;MQSB=0.951002;MQ0F=0 PL:DP:DV 0,33,252:11:0 0,9,112:3:0 0,12,126:4:0 +X 3221 . C <*> 0 . DP=17;I16=9,7,0,0,598,22586,0,0,960,57600,0,0,301,6659,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,244:9:0 0,9,103:3:0 0,12,139:4:0 +X 3222 . A <*> 0 . DP=17;I16=10,7,0,0,623,23037,0,0,989,58441,0,0,318,6972,0,0;QS=3,0;MQSB=0.943335;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,100:3:0 0,12,133:4:0 +X 3223 . C <*> 0 . DP=17;I16=10,7,0,0,611,22603,0,0,989,58441,0,0,312,6764,0,0;QS=3,0;MQSB=0.943335;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,96:3:0 0,12,132:4:0 +X 3224 . A <*> 0 . DP=16;I16=10,6,0,0,609,23381,0,0,929,54841,0,0,307,6575,0,0;QS=3,0;MQSB=0.948436;MQ0F=0 PL:DP:DV 0,27,238:9:0 0,9,97:3:0 0,12,141:4:0 +X 3225 . G <*> 0 . DP=17;I16=11,6,0,0,604,22692,0,0,989,58441,0,0,302,6404,0,0;QS=3,0;MQSB=0.955563;MQ0F=0 PL:DP:DV 0,27,247:9:0 0,12,108:4:0 0,12,134:4:0 +X 3226 . T <*> 0 . DP=18;I16=11,6,0,0,582,20466,0,0,1020,61200,0,0,282,5996,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,224:9:0 0,12,112:4:0 0,12,131:4:0 +X 3227 . G <*> 0 . DP=18;I16=12,5,0,0,618,23008,0,0,989,58441,0,0,270,5496,0,0;QS=3,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,91:3:0 0,12,125:4:0 +X 3228 . G <*> 0 . DP=18;I16=11,6,0,0,611,22581,0,0,1020,61200,0,0,278,5816,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,248:9:0 0,12,118:4:0 0,12,121:4:0 +X 3229 . C <*> 0 . DP=19;I16=12,7,0,0,686,25394,0,0,1109,65641,0,0,289,5925,0,0;QS=3,0;MQSB=0.957193;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,118:4:0 0,12,126:4:0 +X 3230 . T <*> 0 . DP=19;I16=12,6,0,0,669,25441,0,0,1049,62041,0,0,261,5187,0,0;QS=3,0;MQSB=0.961295;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,107:3:0 0,12,139:4:0 +X 3231 . C <*> 0 . DP=19;I16=12,7,0,0,682,25046,0,0,1109,65641,0,0,283,5725,0,0;QS=3,0;MQSB=0.957193;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,112:4:0 0,12,128:4:0 +X 3232 . A <*> 0 . DP=19;I16=11,7,0,0,597,20779,0,0,1080,64800,0,0,270,5564,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,229:10:0 0,12,117:4:0 0,12,132:4:0 +X 3233 . C <*> 0 . DP=19;I16=12,7,0,0,573,18239,0,0,1109,65641,0,0,277,5629,0,0;QS=3,0;MQSB=0.957193;MQ0F=0 PL:DP:DV 0,33,238:11:0 0,12,91:4:0 0,12,110:4:0 +X 3234 . G T,<*> 0 . DP=19;I16=10,6,1,0,511,17305,22,484,960,57600,29,841,233,4849,8,64;QS=2.93855,0.0614525,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.955563;BQB=1;MQ0F=0 PL:DP:DV 0,11,222,30,225,234:11:1 0,6,63,6,63,63:2:0 0,12,100,12,100,100:4:0 +X 3235 . C <*> 0 . DP=18;I16=12,6,0,0,625,22649,0,0,1049,62041,0,0,274,5582,0,0;QS=3,0;MQSB=0.961295;MQ0F=0 PL:DP:DV 0,30,249:10:0 0,12,119:4:0 0,12,123:4:0 +X 3236 . C <*> 0 . DP=18;I16=12,6,0,0,668,25124,0,0,1049,62041,0,0,273,5567,0,0;QS=3,0;MQSB=0.961295;MQ0F=0 PL:DP:DV 0,30,244:10:0 0,12,137:4:0 0,12,134:4:0 +X 3237 . T <*> 0 . DP=17;I16=11,6,0,0,589,21235,0,0,989,58441,0,0,273,5573,0,0;QS=3,0;MQSB=0.955563;MQ0F=0 PL:DP:DV 0,27,230:9:0 0,12,102:4:0 0,12,136:4:0 +X 3238 . G <*> 0 . DP=17;I16=11,6,0,0,609,22539,0,0,989,58441,0,0,273,5599,0,0;QS=3,0;MQSB=0.955563;MQ0F=0 PL:DP:DV 0,27,243:9:0 0,12,104:4:0 0,12,129:4:0 +X 3239 . T <*> 0 . DP=17;I16=11,6,0,0,574,20204,0,0,989,58441,0,0,273,5645,0,0;QS=3,0;MQSB=0.955563;MQ0F=0 PL:DP:DV 0,27,220:9:0 0,12,107:4:0 0,12,131:4:0 +X 3240 . A <*> 0 . DP=19;I16=12,7,0,0,624,21552,0,0,1109,65641,0,0,273,5711,0,0;QS=3,0;MQSB=0.957193;MQ0F=0 PL:DP:DV 0,33,248:11:0 0,12,101:4:0 0,12,132:4:0 +X 3241 . A <*> 0 . DP=19;I16=11,6,0,0,619,23121,0,0,1020,61200,0,0,249,5173,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,252:10:0 0,9,96:3:0 0,12,143:4:0 +X 3242 . T <*> 0 . DP=19;I16=12,7,0,0,655,23279,0,0,1140,68400,0,0,277,5911,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,252:10:0 0,12,104:4:0 0,15,152:5:0 +X 3243 . C <*> 0 . DP=19;I16=12,7,0,0,682,25216,0,0,1140,68400,0,0,281,6047,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,111:4:0 0,15,148:5:0 +X 3244 . C <*> 0 . DP=18;I16=11,6,0,0,587,21119,0,0,1020,61200,0,0,281,6139,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,221:8:0 0,12,116:4:0 0,15,142:5:0 +X 3245 . C <*> 0 . DP=17;I16=10,7,0,0,631,23851,0,0,1020,61200,0,0,290,6282,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,12,126:4:0 0,12,131:4:0 +X 3246 . A <*> 0 . DP=17;I16=10,7,0,0,646,24716,0,0,1020,61200,0,0,295,6427,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,12,129:4:0 0,12,139:4:0 +X 3247 . G <*> 0 . DP=17;I16=10,7,0,0,606,22554,0,0,1020,61200,0,0,300,6590,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,12,92:4:0 0,12,133:4:0 +X 3248 . C <*> 0 . DP=16;I16=10,6,0,0,603,23115,0,0,960,57600,0,0,306,6770,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,9,99:3:0 0,12,132:4:0 +X 3249 . C <*> 0 . DP=16;I16=10,6,0,0,587,21913,0,0,960,57600,0,0,311,6917,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,246:9:0 0,9,99:3:0 0,12,133:4:0 +X 3250 . C <*> 0 . DP=16;I16=10,6,0,0,616,24080,0,0,960,57600,0,0,316,7082,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,9,95:3:0 0,12,137:4:0 +X 3251 . T <*> 0 . DP=16;I16=10,6,0,0,585,22193,0,0,960,57600,0,0,319,7165,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,241:9:0 0,9,104:3:0 0,12,135:4:0 +X 3252 . T <*> 0 . DP=16;I16=10,6,0,0,553,19781,0,0,960,57600,0,0,321,7215,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,239:9:0 0,9,84:3:0 0,12,126:4:0 +X 3253 . T <*> 0 . DP=16;I16=10,6,0,0,589,21933,0,0,960,57600,0,0,323,7281,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,245:9:0 0,9,102:3:0 0,12,132:4:0 +X 3254 . G <*> 0 . DP=17;I16=10,7,0,0,631,23737,0,0,1020,61200,0,0,325,7363,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,9,100:3:0 0,15,154:5:0 +X 3255 . G <*> 0 . DP=16;I16=9,7,0,0,554,20088,0,0,960,57600,0,0,328,7410,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,243:9:0 0,9,93:3:0 0,12,120:4:0 +X 3256 . G <*> 0 . DP=16;I16=8,7,0,0,571,21985,0,0,900,54000,0,0,306,6846,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,6,62:2:0 0,12,142:4:0 +X 3257 . A <*> 0 . DP=16;I16=9,7,0,0,585,21881,0,0,960,57600,0,0,334,7546,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,243:9:0 0,9,94:3:0 0,12,144:4:0 +X 3258 . G <*> 0 . DP=17;I16=9,8,0,0,647,25407,0,0,1020,61200,0,0,337,7635,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,81:3:0 0,12,146:4:0 +X 3259 . G <*> 0 . DP=17;I16=9,8,0,0,605,22237,0,0,1020,61200,0,0,341,7739,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,79:3:0 0,12,139:4:0 +X 3260 . C <*> 0 . DP=17;I16=9,7,0,0,616,23908,0,0,960,57600,0,0,319,7183,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,6,64:2:0 0,12,133:4:0 +X 3261 . C <*> 0 . DP=18;I16=9,9,0,0,655,24475,0,0,1080,64800,0,0,347,7891,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,90:3:0 0,12,138:4:0 +X 3262 . A <*> 0 . DP=19;I16=10,9,0,0,712,27036,0,0,1140,68400,0,0,351,7989,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,123:4:0 0,12,148:4:0 +X 3263 . G <*> 0 . DP=19;I16=10,9,0,0,715,27317,0,0,1140,68400,0,0,356,8104,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,116:4:0 0,12,146:4:0 +X 3264 . G <*> 0 . DP=19;I16=10,9,0,0,676,24734,0,0,1140,68400,0,0,361,8237,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,93:4:0 0,12,143:4:0 +X 3265 . G <*> 0 . DP=19;I16=10,9,0,0,701,26199,0,0,1140,68400,0,0,365,8339,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,109:4:0 0,12,137:4:0 +X 3266 . T <*> 0 . DP=19;I16=9,9,0,0,597,20769,0,0,1080,64800,0,0,357,8229,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,82:4:0 0,9,113:3:0 +X 3267 . G <*> 0 . DP=19;I16=10,9,0,0,659,24285,0,0,1140,68400,0,0,367,8299,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,76:4:0 0,12,133:4:0 +X 3268 . G <*> 0 . DP=19;I16=10,9,0,0,668,24306,0,0,1140,68400,0,0,367,8255,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,92:4:0 0,12,142:4:0 +X 3269 . G <*> 0 . DP=19;I16=10,9,0,0,714,27122,0,0,1140,68400,0,0,367,8227,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,115:4:0 0,12,137:4:0 +X 3270 . T <*> 0 . DP=20;I16=10,9,0,0,606,20364,0,0,1140,68400,0,0,361,8141,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,251:11:0 0,12,83:4:0 0,12,136:4:0 +X 3271 . G <*> 0 . DP=19;I16=10,9,0,0,709,26993,0,0,1140,68400,0,0,362,8108,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,100:4:0 0,12,143:4:0 +X 3272 . G <*> 0 . DP=19;I16=10,9,0,0,672,24398,0,0,1140,68400,0,0,363,8093,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,97:4:0 0,12,140:4:0 +X 3273 . A <*> 0 . DP=20;I16=10,10,0,0,735,27355,0,0,1200,72000,0,0,363,8047,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,153:5:0 0,12,147:4:0 +X 3274 . T <*> 0 . DP=19;I16=9,10,0,0,699,26089,0,0,1140,68400,0,0,365,8021,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,142:5:0 0,12,149:4:0 +X 3275 . C <*> 0 . DP=19;I16=9,10,0,0,727,28197,0,0,1140,68400,0,0,367,8015,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,137:5:0 0,12,139:4:0 +X 3276 . A <*> 0 . DP=19;I16=9,10,0,0,681,25123,0,0,1140,68400,0,0,369,8029,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,253:10:0 0,15,150:5:0 0,12,141:4:0 +X 3277 . C <*> 0 . DP=19;I16=9,10,0,0,733,28485,0,0,1140,68400,0,0,371,8063,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,153:5:0 0,12,146:4:0 +X 3278 . T <*> 0 . DP=19;I16=9,10,0,0,737,28901,0,0,1140,68400,0,0,373,8117,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,168:5:0 0,12,153:4:0 +X 3279 . T <*> 0 . DP=19;I16=9,10,0,0,714,27132,0,0,1140,68400,0,0,375,8191,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,148:5:0 0,12,150:4:0 +X 3280 . G <*> 0 . DP=20;I16=9,11,0,0,758,29178,0,0,1200,72000,0,0,376,8234,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,143:5:0 0,12,146:4:0 +X 3281 . A <*> 0 . DP=21;I16=10,11,0,0,822,32654,0,0,1260,75600,0,0,378,8296,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,179:6:0 0,12,157:4:0 +X 3282 . G <*> 0 . DP=21;I16=10,11,0,0,815,32059,0,0,1260,75600,0,0,381,8379,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,173:6:0 0,12,150:4:0 +X 3283 . G <*> 0 . DP=21;I16=10,11,0,0,790,30110,0,0,1260,75600,0,0,384,8484,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,161:6:0 0,12,146:4:0 +X 3284 . T <*> 0 . DP=21;I16=10,11,0,0,748,27628,0,0,1260,75600,0,0,385,8511,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,155:6:0 0,12,146:4:0 +X 3285 . C <*> 0 . DP=21;I16=10,11,0,0,776,29442,0,0,1260,75600,0,0,386,8560,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,169:6:0 0,12,143:4:0 +X 3286 . A <*> 0 . DP=21;I16=10,11,0,0,826,32732,0,0,1260,75600,0,0,387,8631,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,187:6:0 0,12,153:4:0 +X 3287 . G <*> 0 . DP=21;I16=10,11,0,0,804,31448,0,0,1260,75600,0,0,387,8673,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,164:6:0 0,12,150:4:0 +X 3288 . G <*> 0 . DP=22;I16=10,11,0,0,754,27862,0,0,1260,75600,0,0,379,8635,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,141:5:0 0,15,164:5:0 +X 3289 . A <*> 0 . DP=24;I16=13,11,0,0,897,34439,0,0,1440,86400,0,0,386,8714,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,166:6:0 0,15,178:5:0 +X 3290 . G <*> 0 . DP=23;I16=12,10,0,0,832,31964,0,0,1320,79200,0,0,380,8684,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,112:4:0 0,15,168:5:0 +X 3291 . T <*> 0 . DP=22;I16=11,9,0,0,707,25481,0,0,1200,72000,0,0,358,8112,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,95:3:0 0,15,168:5:0 +X 3292 . T <*> 0 . DP=22;I16=13,9,0,0,783,28439,0,0,1320,79200,0,0,397,8929,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,127:5:0 0,15,164:5:0 +X 3293 . C <*> 0 . DP=22;I16=13,9,0,0,852,33430,0,0,1320,79200,0,0,400,8992,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,136:5:0 0,15,170:5:0 +X 3294 . A <*> 0 . DP=22;I16=13,9,0,0,818,30684,0,0,1320,79200,0,0,403,9077,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,145:5:0 0,15,162:5:0 +X 3295 . A <*> 0 . DP=22;I16=14,8,0,0,820,31004,0,0,1320,79200,0,0,407,9183,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,140:5:0 0,12,143:4:0 +X 3296 . G <*> 0 . DP=22;I16=14,8,0,0,837,32209,0,0,1320,79200,0,0,411,9259,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,133:5:0 0,12,140:4:0 +X 3297 . A <*> 0 . DP=22;I16=14,8,0,0,787,28771,0,0,1320,79200,0,0,415,9355,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,134:5:0 0,12,140:4:0 +X 3298 . C <*> 0 . DP=22;I16=13,9,0,0,826,31506,0,0,1320,79200,0,0,420,9470,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,113:4:0 0,12,135:4:0 +X 3299 . C <*> 0 . DP=22;I16=13,9,0,0,857,33829,0,0,1320,79200,0,0,425,9553,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,117:4:0 0,12,140:4:0 +X 3300 . A <*> 0 . DP=22;I16=13,9,0,0,861,33855,0,0,1320,79200,0,0,430,9654,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,134:4:0 0,12,144:4:0 +X 3301 . G <*> 0 . DP=22;I16=13,9,0,0,869,34495,0,0,1320,79200,0,0,433,9675,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,131:4:0 0,12,141:4:0 +X 3302 . C <*> 0 . DP=23;I16=14,9,0,0,863,32885,0,0,1380,82800,0,0,436,9718,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,115:4:0 0,15,155:5:0 +X 3303 . C <*> 0 . DP=23;I16=14,9,0,0,887,34451,0,0,1380,82800,0,0,440,9784,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,125:4:0 0,15,153:5:0 +X 3304 . T <*> 0 . DP=23;I16=14,9,0,0,886,34388,0,0,1380,82800,0,0,443,9825,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,134:4:0 0,15,167:5:0 +X 3305 . G <*> 0 . DP=23;I16=14,9,0,0,878,33846,0,0,1380,82800,0,0,446,9892,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,119:4:0 0,15,151:5:0 +X 3306 . G <*> 0 . DP=23;I16=14,9,0,0,886,34386,0,0,1380,82800,0,0,448,9934,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,127:4:0 0,15,150:5:0 +X 3307 . C <*> 0 . DP=23;I16=14,8,0,0,812,30814,0,0,1320,79200,0,0,428,9508,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,116:4:0 0,15,153:5:0 +X 3308 . C <*> 0 . DP=23;I16=14,9,0,0,835,31367,0,0,1380,82800,0,0,450,9986,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,118:4:0 0,15,151:5:0 +X 3309 . A <*> 0 . DP=23;I16=14,9,0,0,875,33541,0,0,1380,82800,0,0,451,9995,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,128:4:0 0,15,162:5:0 +X 3310 . A <*> 0 . DP=24;I16=15,9,0,0,882,32950,0,0,1440,86400,0,0,453,10027,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,152:5:0 0,15,164:5:0 +X 3311 . C <*> 0 . DP=24;I16=15,9,0,0,913,35161,0,0,1440,86400,0,0,456,10084,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,145:5:0 0,15,157:5:0 +X 3312 . A <*> 0 . DP=26;I16=16,9,0,0,950,36336,0,0,1500,90000,0,0,459,10167,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,153:5:0 0,15,160:5:0 +X 3313 . T <*> 0 . DP=26;I16=16,10,0,0,987,37617,0,0,1560,93600,0,0,488,10902,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,180:6:0 0,15,161:5:0 +X 3314 . G <*> 0 . DP=26;I16=16,10,0,0,1007,39401,0,0,1560,93600,0,0,491,10989,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,171:6:0 0,15,161:5:0 +X 3315 . G <*> 0 . DP=26;I16=15,10,0,0,945,36073,0,0,1500,90000,0,0,484,10866,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,172:6:0 0,15,159:5:0 +X 3316 . T <*> 0 . DP=26;I16=15,10,0,0,853,29881,0,0,1500,90000,0,0,464,10216,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,157:6:0 0,12,122:4:0 +X 3317 . G <*> 0 . DP=27;I16=16,11,0,0,997,37431,0,0,1620,97200,0,0,488,10806,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,164:6:0 0,18,167:6:0 +X 3318 . A <*> 0 . DP=26;I16=15,10,0,0,904,33212,0,0,1500,90000,0,0,481,10699,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,155:5:0 0,18,185:6:0 +X 3319 . A <*> 0 . DP=25;I16=15,10,0,0,912,34090,0,0,1500,90000,0,0,482,10682,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,139:5:0 0,18,188:6:0 +X 3320 . A <*> 0 . DP=25;I16=15,10,0,0,888,32722,0,0,1500,90000,0,0,483,10691,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,133:5:0 0,18,178:6:0 +X 3321 . C <*> 0 . DP=25;I16=14,10,0,0,900,34142,0,0,1440,86400,0,0,471,10531,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,157:5:0 0,18,186:6:0 +X 3322 . C <*> 0 . DP=25;I16=15,10,0,0,980,38582,0,0,1500,90000,0,0,483,10683,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,164:5:0 0,18,198:6:0 +X 3323 . C <*> 0 . DP=25;I16=15,10,0,0,922,34948,0,0,1500,90000,0,0,483,10715,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,146:5:0 0,18,201:6:0 +X 3324 . C <*> 0 . DP=25;I16=15,10,0,0,869,31271,0,0,1500,90000,0,0,482,10720,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,142:5:0 0,18,186:6:0 +X 3325 . G <*> 0 . DP=25;I16=15,10,0,0,827,28293,0,0,1500,90000,0,0,481,10747,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,134:5:0 0,18,163:6:0 +X 3326 . T <*> 0 . DP=24;I16=13,10,0,0,842,31362,0,0,1380,82800,0,0,464,10506,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,150:5:0 0,18,186:6:0 +X 3327 . C <*> 0 . DP=24;I16=14,10,0,0,938,37076,0,0,1440,86400,0,0,481,10863,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,154:5:0 0,18,190:6:0 +X 3328 . T <*> 0 . DP=25;I16=15,10,0,0,959,37033,0,0,1500,90000,0,0,480,10900,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,163:5:0 0,21,213:7:0 +X 3329 . A <*> 0 . DP=24;I16=15,9,0,0,888,33082,0,0,1440,86400,0,0,481,10955,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,149:5:0 0,21,207:7:0 +X 3330 . C <*> 0 . DP=25;I16=16,9,0,0,954,37064,0,0,1500,90000,0,0,481,10979,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,168:5:0 0,21,203:7:0 +X 3331 . T <*> 0 . DP=25;I16=16,9,0,0,960,37332,0,0,1500,90000,0,0,482,11024,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,165:5:0 0,21,224:7:0 +X 3332 . A <*> 0 . DP=25;I16=16,9,0,0,933,35065,0,0,1500,90000,0,0,483,11091,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,165:5:0 0,21,211:7:0 +X 3333 . A <*> 0 . DP=26;I16=16,10,0,0,976,37344,0,0,1560,93600,0,0,483,11131,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,166:5:0 0,24,241:8:0 +X 3334 . A <*> 0 . DP=25;I16=15,10,0,0,972,38210,0,0,1500,90000,0,0,485,11195,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,168:5:0 0,24,241:8:0 +X 3335 . A <*> 0 . DP=25;I16=15,10,0,0,970,38200,0,0,1500,90000,0,0,486,11232,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,170:5:0 0,24,239:8:0 +X 3336 . A <*> 0 . DP=25;I16=15,10,0,0,929,35277,0,0,1500,90000,0,0,485,11191,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,166:5:0 0,24,232:8:0 +X 3337 . T <*> 0 . DP=25;I16=15,10,0,0,902,32856,0,0,1500,90000,0,0,484,11172,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,157:5:0 0,24,224:8:0 +X 3338 . A <*> 0 . DP=25;I16=15,10,0,0,892,32056,0,0,1500,90000,0,0,481,11075,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,153:5:0 0,24,214:8:0 +X 3339 . C <*> 0 . DP=25;I16=15,10,0,0,964,37444,0,0,1500,90000,0,0,478,11000,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,167:5:0 0,24,232:8:0 +X 3340 . A <*> 0 . DP=23;I16=14,9,0,0,890,34616,0,0,1380,82800,0,0,477,10945,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,173:5:0 0,24,233:8:0 +X 3341 . A <*> 0 . DP=23;I16=14,9,0,0,885,34459,0,0,1380,82800,0,0,476,10908,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,167:5:0 0,24,238:8:0 +X 3342 . A <*> 0 . DP=23;I16=14,9,0,0,862,33262,0,0,1380,82800,0,0,475,10889,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,170:5:0 0,24,240:8:0 +X 3343 . A <*> 0 . DP=22;I16=13,9,0,0,866,34280,0,0,1320,79200,0,0,474,10836,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,173:5:0 0,21,231:7:0 +X 3344 . A <*> 0 . DP=22;I16=13,9,0,0,859,33731,0,0,1320,79200,0,0,473,10797,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,173:5:0 0,21,226:7:0 +X 3345 . T <*> 0 . DP=22;I16=13,9,0,0,822,31100,0,0,1320,79200,0,0,472,10772,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,254:10:0 0,15,159:5:0 0,21,220:7:0 +X 3346 . T <*> 0 . DP=22;I16=13,9,0,0,847,32679,0,0,1320,79200,0,0,470,10712,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,168:5:0 0,21,221:7:0 +X 3347 . A <*> 0 . DP=23;I16=14,9,0,0,888,34650,0,0,1380,82800,0,0,468,10668,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,185:6:0 0,21,227:7:0 +X 3348 . G <*> 0 . DP=23;I16=14,9,0,0,873,33609,0,0,1380,82800,0,0,467,10641,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,171:6:0 0,21,219:7:0 +X 3349 . C <*> 0 . DP=24;I16=14,9,0,0,815,29785,0,0,1380,82800,0,0,465,10583,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,166:6:0 0,21,205:7:0 +X 3350 . C <*> 0 . DP=24;I16=14,10,0,0,939,37249,0,0,1440,86400,0,0,464,10546,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,209:7:0 0,21,220:7:0 +X 3351 . T <*> 0 . DP=24;I16=14,10,0,0,943,37255,0,0,1440,86400,0,0,463,10531,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,210:7:0 0,21,228:7:0 +X 3352 . G <*> 0 . DP=24;I16=14,10,0,0,887,33267,0,0,1440,86400,0,0,462,10538,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,192:7:0 0,21,214:7:0 +X 3353 . G <*> 0 . DP=24;I16=14,10,0,0,864,32092,0,0,1440,86400,0,0,461,10567,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,190:7:0 0,21,214:7:0 +X 3354 . C <*> 0 . DP=24;I16=14,10,0,0,848,30714,0,0,1440,86400,0,0,459,10567,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,178:7:0 0,21,209:7:0 +X 3355 . G <*> 0 . DP=23;I16=14,9,0,0,738,24386,0,0,1380,82800,0,0,457,10537,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,232:10:0 0,21,170:7:0 0,18,166:6:0 +X 3356 . T <*> 0 . DP=23;I16=14,9,0,0,847,31689,0,0,1380,82800,0,0,454,10476,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,191:7:0 0,18,195:6:0 +X 3357 . G <*> 0 . DP=23;I16=14,9,0,0,863,32919,0,0,1380,82800,0,0,449,10335,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,193:7:0 0,18,192:6:0 +X 3358 . G <*> 0 . DP=22;I16=14,8,0,0,810,30184,0,0,1320,79200,0,0,445,10215,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,239:9:0 0,21,200:7:0 0,18,187:6:0 +X 3359 . T <*> 0 . DP=23;I16=13,8,0,0,743,26737,0,0,1260,75600,0,0,404,9318,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,228:9:0 0,21,194:7:0 0,15,162:5:0 +X 3360 . G <*> 0 . DP=23;I16=15,8,0,0,822,30058,0,0,1380,82800,0,0,436,9932,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,186:7:0 0,18,175:6:0 +X 3361 . G <*> 0 . DP=22;I16=15,7,0,0,751,26793,0,0,1320,79200,0,0,433,9819,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,218:9:0 0,21,187:7:0 0,18,175:6:0 +X 3362 . C <*> 0 . DP=22;I16=15,7,0,0,768,27462,0,0,1320,79200,0,0,430,9724,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,230:9:0 0,21,178:7:0 0,18,173:6:0 +X 3363 . G <*> 0 . DP=21;I16=14,7,0,0,662,21572,0,0,1260,75600,0,0,428,9646,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,194:9:0 0,18,155:6:0 0,18,161:6:0 +X 3364 . C <*> 0 . DP=21;I16=14,7,0,0,818,32184,0,0,1260,75600,0,0,423,9437,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,241:9:0 0,18,191:6:0 0,18,194:6:0 +X 3365 . A <*> 0 . DP=21;I16=14,7,0,0,791,29983,0,0,1260,75600,0,0,418,9250,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,226:9:0 0,18,186:6:0 0,18,190:6:0 +X 3366 . T <*> 0 . DP=21;I16=14,7,0,0,759,28053,0,0,1260,75600,0,0,413,9085,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,221:9:0 0,18,185:6:0 0,18,177:6:0 +X 3367 . G <*> 0 . DP=21;I16=14,7,0,0,767,28539,0,0,1260,75600,0,0,408,8942,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,235:9:0 0,18,185:6:0 0,18,169:6:0 +X 3368 . C <*> 0 . DP=21;I16=14,7,0,0,807,31329,0,0,1260,75600,0,0,403,8821,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,245:9:0 0,18,181:6:0 0,18,189:6:0 +X 3369 . C <*> 0 . DP=21;I16=14,7,0,0,789,30271,0,0,1260,75600,0,0,398,8722,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,228:9:0 0,18,186:6:0 0,18,193:6:0 +X 3370 . T <*> 0 . DP=21;I16=13,7,0,0,798,31960,0,0,1200,72000,0,0,392,8596,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,239:9:0 0,18,201:6:0 0,15,178:5:0 +X 3371 . G <*> 0 . DP=20;I16=13,7,0,0,739,27875,0,0,1200,72000,0,0,387,8493,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,233:9:0 0,18,173:6:0 0,15,169:5:0 +X 3372 . T <*> 0 . DP=20;I16=13,6,0,0,693,25677,0,0,1140,68400,0,0,359,7883,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,220:9:0 0,15,154:5:0 0,15,167:5:0 +X 3373 . A <*> 0 . DP=20;I16=13,7,0,0,729,27019,0,0,1200,72000,0,0,375,8253,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,226:9:0 0,18,162:6:0 0,15,174:5:0 +X 3374 . A <*> 0 . DP=19;I16=13,6,0,0,719,27437,0,0,1140,68400,0,0,369,8115,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,225:9:0 0,15,167:5:0 0,15,164:5:0 +X 3375 . T <*> 0 . DP=20;I16=12,6,0,0,683,26039,0,0,1080,64800,0,0,337,7321,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,221:8:0 0,15,155:5:0 0,15,172:5:0 +X 3376 . C <*> 0 . DP=20;I16=13,7,0,0,739,27867,0,0,1200,72000,0,0,356,7796,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,254:10:0 0,15,146:5:0 0,15,173:5:0 +X 3377 . C <*> 0 . DP=20;I16=13,7,0,0,741,27905,0,0,1200,72000,0,0,350,7666,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,252:10:0 0,15,149:5:0 0,15,173:5:0 +X 3378 . C <*> 0 . DP=20;I16=13,7,0,0,775,30179,0,0,1200,72000,0,0,343,7507,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,161:5:0 0,15,172:5:0 +X 3379 . A <*> 0 . DP=20;I16=13,7,0,0,736,27530,0,0,1200,72000,0,0,336,7370,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,245:10:0 0,15,157:5:0 0,15,169:5:0 +X 3380 . G <*> 0 . DP=19;I16=13,6,0,0,729,28249,0,0,1140,68400,0,0,330,7254,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,233:9:0 0,15,157:5:0 0,15,178:5:0 +X 3381 . C <*> 0 . DP=19;I16=13,6,0,0,742,29288,0,0,1140,68400,0,0,324,7158,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,241:9:0 0,15,155:5:0 0,15,178:5:0 +X 3382 . T <*> 0 . DP=17;I16=12,5,0,0,649,25245,0,0,1020,61200,0,0,320,7080,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,222:9:0 0,9,105:3:0 0,15,184:5:0 +X 3383 . A <*> 0 . DP=17;I16=12,4,0,0,556,19808,0,0,960,57600,0,0,291,6393,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,196:9:0 0,6,71:2:0 0,15,167:5:0 +X 3384 . C <*> 0 . DP=19;I16=14,5,0,0,701,26181,0,0,1140,68400,0,0,311,6923,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,235:10:0 0,9,98:3:0 0,18,187:6:0 +X 3385 . T <*> 0 . DP=19;I16=14,5,0,0,730,28456,0,0,1140,68400,0,0,307,6797,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,237:10:0 0,9,109:3:0 0,18,195:6:0 +X 3386 . T <*> 0 . DP=19;I16=14,5,0,0,642,22450,0,0,1140,68400,0,0,302,6642,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,197:10:0 0,9,104:3:0 0,18,188:6:0 +X 3387 . G <*> 0 . DP=20;I16=14,6,0,0,723,26761,0,0,1200,72000,0,0,296,6460,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,230:10:0 0,9,105:3:0 0,21,210:7:0 +X 3388 . G <*> 0 . DP=20;I16=14,6,0,0,705,25891,0,0,1200,72000,0,0,291,6303,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,225:10:0 0,9,109:3:0 0,21,202:7:0 +X 3389 . G <*> 0 . DP=18;I16=10,7,0,0,617,22635,0,0,1020,61200,0,0,270,5808,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,190:7:0 0,9,105:3:0 0,21,207:7:0 +X 3390 . A <*> 0 . DP=18;I16=11,7,0,0,631,22681,0,0,1080,64800,0,0,288,6056,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,200:8:0 0,9,105:3:0 0,21,198:7:0 +X 3391 . A <*> 0 . DP=18;I16=11,7,0,0,663,24951,0,0,1080,64800,0,0,287,5965,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,192:8:0 0,9,113:3:0 0,21,224:7:0 +X 3392 . G <*> 0 . DP=18;I16=11,7,0,0,666,25104,0,0,1080,64800,0,0,286,5896,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,211:8:0 0,9,103:3:0 0,21,216:7:0 +X 3393 . C <*> 0 . DP=18;I16=11,7,0,0,686,26472,0,0,1080,64800,0,0,284,5800,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,222:8:0 0,9,106:3:0 0,21,214:7:0 +X 3394 . T <*> 0 . DP=18;I16=11,7,0,0,699,27481,0,0,1080,64800,0,0,282,5728,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,219:8:0 0,9,114:3:0 0,21,222:7:0 +X 3395 . G <*> 0 . DP=17;I16=10,7,0,0,656,25512,0,0,1020,61200,0,0,281,5679,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,205:7:0 0,9,105:3:0 0,21,222:7:0 +X 3396 . A <*> 0 . DP=17;I16=10,7,0,0,644,25446,0,0,1020,61200,0,0,280,5652,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,182:7:0 0,9,119:3:0 0,21,232:7:0 +X 3397 . G <*> 0 . DP=17;I16=10,7,0,0,633,23895,0,0,1020,61200,0,0,279,5647,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,193:7:0 0,9,107:3:0 0,21,218:7:0 +X 3398 . G <*> 0 . DP=16;I16=10,6,0,0,610,23380,0,0,960,57600,0,0,279,5663,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,170:6:0 0,9,110:3:0 0,21,215:7:0 +X 3399 . G <*> 0 . DP=17;I16=10,6,0,0,585,21729,0,0,960,57600,0,0,270,5618,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,15,147:5:0 0,12,122:4:0 0,21,216:7:0 +X 3400 . A <*> 0 . DP=17;I16=10,6,0,0,576,21400,0,0,960,57600,0,0,264,5500,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,15,136:5:0 0,12,131:4:0 0,21,213:7:0 +X 3401 . T <*> 0 . DP=17;I16=11,6,0,0,605,22159,0,0,1020,61200,0,0,280,5784,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,146:6:0 0,12,131:4:0 0,21,216:7:0 +X 3402 . G <*> 0 . DP=17;I16=11,6,0,0,638,24150,0,0,1020,61200,0,0,280,5832,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,172:6:0 0,12,130:4:0 0,21,213:7:0 +X 3403 . A <*> 0 . DP=16;I16=9,6,0,0,579,22815,0,0,900,54000,0,0,276,5874,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,15,139:5:0 0,12,140:4:0 0,18,205:6:0 +X 3404 . G <*> 0 . DP=16;I16=10,6,0,0,564,20652,0,0,960,57600,0,0,281,5935,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,148:6:0 0,12,131:4:0 0,18,186:6:0 +X 3405 . A <*> 0 . DP=16;I16=10,6,0,0,560,20158,0,0,960,57600,0,0,281,5991,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,157:6:0 0,12,124:4:0 0,18,179:6:0 +X 3406 . A <*> 0 . DP=16;I16=10,6,0,0,568,20556,0,0,960,57600,0,0,281,6067,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,150:6:0 0,12,129:4:0 0,18,186:6:0 +X 3407 . C <*> 0 . DP=17;I16=11,6,0,0,591,21225,0,0,1020,61200,0,0,281,6163,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,178:7:0 0,12,106:4:0 0,18,183:6:0 +X 3408 . T <*> 0 . DP=17;I16=11,6,0,0,632,23754,0,0,1020,61200,0,0,282,6280,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,177:7:0 0,12,133:4:0 0,18,189:6:0 +X 3409 . G <*> 0 . DP=16;I16=10,6,0,0,599,22667,0,0,960,57600,0,0,283,6369,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,172:6:0 0,12,119:4:0 0,18,192:6:0 +X 3410 . C <*> 0 . DP=16;I16=10,6,0,0,585,21685,0,0,960,57600,0,0,282,6378,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,174:6:0 0,12,126:4:0 0,18,176:6:0 +X 3411 . T <*> 0 . DP=15;I16=9,6,0,0,578,22492,0,0,900,54000,0,0,282,6404,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,165:6:0 0,9,114:3:0 0,18,196:6:0 +X 3412 . T <*> 0 . DP=15;I16=9,6,0,0,546,20202,0,0,900,54000,0,0,283,6445,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,15,148:5:0 0,12,120:4:0 0,18,189:6:0 +X 3413 . G <*> 0 . DP=15;I16=9,6,0,0,559,21023,0,0,900,54000,0,0,283,6401,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,15,158:5:0 0,12,124:4:0 0,18,184:6:0 +X 3414 . A <*> 0 . DP=15;I16=9,6,0,0,512,17878,0,0,900,54000,0,0,283,6373,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,15,148:5:0 0,12,116:4:0 0,18,166:6:0 +X 3415 . A <*> 0 . DP=16;I16=9,7,0,0,544,19656,0,0,960,57600,0,0,282,6310,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,15,142:5:0 0,12,132:4:0 0,21,179:7:0 +X 3416 . C <*> 0 . DP=16;I16=9,7,0,0,562,20168,0,0,960,57600,0,0,282,6262,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,15,143:5:0 0,12,127:4:0 0,21,191:7:0 +X 3417 . C <*> 0 . DP=16;I16=9,7,0,0,566,20666,0,0,960,57600,0,0,282,6230,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,15,147:5:0 0,12,126:4:0 0,21,192:7:0 +X 3418 . T <*> 0 . DP=17;I16=10,5,0,0,557,21637,0,0,900,54000,0,0,268,5988,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,15,150:5:0 0,15,148:5:0 0,15,176:5:0 +X 3419 . G <*> 0 . DP=17;I16=10,7,0,0,594,21642,0,0,1020,61200,0,0,310,6836,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,161:6:0 0,15,140:5:0 0,18,190:6:0 +X 3420 . G <*> 0 . DP=17;I16=10,7,0,0,596,21580,0,0,1020,61200,0,0,312,6850,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,172:6:0 0,15,132:5:0 0,18,188:6:0 +X 3421 . G <*> 0 . DP=18;I16=10,8,0,0,633,22781,0,0,1049,62041,0,0,314,6880,0,0;QS=3,0;MQSB=0.906029;MQ0F=0 PL:DP:DV 0,21,184:7:0 0,15,138:5:0 0,18,191:6:0 +X 3422 . A <*> 0 . DP=18;I16=9,8,0,0,576,20954,0,0,989,58441,0,0,302,6702,0,0;QS=3,0;MQSB=0.91051;MQ0F=0 PL:DP:DV 0,18,167:6:0 0,15,130:5:0 0,18,188:6:0 +X 3423 . G <*> 0 . DP=18;I16=9,9,0,0,651,24391,0,0,1049,62041,0,0,305,6747,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,21,200:7:0 0,15,149:5:0 0,18,183:6:0 +X 3424 . G <*> 0 . DP=18;I16=8,8,0,0,555,20175,0,0,929,54841,0,0,275,6105,0,0;QS=3,0;MQSB=0.915545;MQ0F=0 PL:DP:DV 0,18,161:6:0 0,15,141:5:0 0,15,169:5:0 +X 3425 . C <*> 0 . DP=18;I16=9,8,0,0,594,21676,0,0,1020,61200,0,0,307,6779,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,168:6:0 0,15,142:5:0 0,18,186:6:0 +X 3426 . A <*> 0 . DP=18;I16=9,8,0,0,633,23967,0,0,1020,61200,0,0,308,6774,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,172:6:0 0,15,151:5:0 0,18,202:6:0 +X 3427 . G <*> 0 . DP=18;I16=9,9,0,0,655,24639,0,0,1049,62041,0,0,315,6823,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,21,209:7:0 0,15,144:5:0 0,18,184:6:0 +X 3428 . A <*> 0 . DP=18;I16=9,7,0,0,573,21235,0,0,960,57600,0,0,305,6793,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,15,158:5:0 0,15,147:5:0 0,18,178:6:0 +X 3429 . C <*> 0 . DP=17;I16=8,9,0,0,516,16610,0,0,989,58441,0,0,320,6930,0,0;QS=3,0;MQSB=0.928603;MQ0F=0 PL:DP:DV 0,21,176:7:0 0,15,125:5:0 0,15,124:5:0 +X 3430 . G <*> 0 . DP=18;I16=9,9,0,0,539,17155,0,0,1049,62041,0,0,323,7011,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,24,181:8:0 0,15,113:5:0 0,15,144:5:0 +X 3431 . T <*> 0 . DP=18;I16=9,9,0,0,651,24101,0,0,1049,62041,0,0,327,7111,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,24,210:8:0 0,15,139:5:0 0,15,166:5:0 +X 3432 . T <*> 0 . DP=18;I16=8,9,0,0,577,20601,0,0,989,58441,0,0,306,6606,0,0;QS=3,0;MQSB=0.928603;MQ0F=0 PL:DP:DV 0,21,162:7:0 0,15,144:5:0 0,15,165:5:0 +X 3433 . G <*> 0 . DP=18;I16=9,9,0,0,623,22589,0,0,1049,62041,0,0,334,7320,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,24,199:8:0 0,15,138:5:0 0,15,164:5:0 +X 3434 . C <*> 0 . DP=18;I16=10,7,0,0,582,20838,0,0,1020,61200,0,0,324,7208,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,208:8:0 0,15,130:5:0 0,12,137:4:0 +X 3435 . A <*> 0 . DP=18;I16=10,8,0,0,595,21619,0,0,1049,62041,0,0,341,7453,0,0;QS=3,0;MQSB=0.906029;MQ0F=0 PL:DP:DV 0,27,185:9:0 0,15,150:5:0 0,12,151:4:0 +X 3436 . G <*> 0 . DP=18;I16=10,8,0,0,617,22277,0,0,1049,62041,0,0,345,7549,0,0;QS=3,0;MQSB=0.906029;MQ0F=0 PL:DP:DV 0,27,218:9:0 0,15,146:5:0 0,12,133:4:0 +X 3437 . T G,<*> 0 . DP=18;I16=10,7,0,1,594,21168,16,256,1020,61200,29,841,333,7409,16,256;QS=2.94286,0.0571429,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.906029;BQB=1;MQ0F=0 PL:DP:DV 0,11,188,24,191,195:9:1 0,15,148,15,148,148:5:0 0,12,132,12,132,132:4:0 +X 3438 . G <*> 0 . DP=18;I16=10,7,0,0,622,23296,0,0,1020,61200,0,0,335,7461,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,215:8:0 0,15,152:5:0 0,12,140:4:0 +X 3439 . A <*> 0 . DP=18;I16=10,8,0,0,619,22965,0,0,1049,62041,0,0,355,7853,0,0;QS=3,0;MQSB=0.906029;MQ0F=0 PL:DP:DV 0,27,215:9:0 0,15,153:5:0 0,12,132:4:0 +X 3440 . G <*> 0 . DP=18;I16=10,7,0,0,610,22660,0,0,1020,61200,0,0,339,7613,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,221:8:0 0,15,143:5:0 0,12,131:4:0 +X 3441 . C <*> 0 . DP=18;I16=10,6,0,0,585,22165,0,0,960,57600,0,0,315,7037,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,226:8:0 0,15,140:5:0 0,9,115:3:0 +X 3442 . T <*> 0 . DP=20;I16=11,9,0,0,670,24716,0,0,1138,66482,0,0,362,8166,0,0;QS=3,0;MQSB=0.997118;MQ0F=0 PL:DP:DV 0,33,248:11:0 0,15,143:5:0 0,12,128:4:0 +X 3443 . G <*> 0 . DP=20;I16=11,9,0,0,708,26092,0,0,1138,66482,0,0,366,8288,0,0;QS=3,0;MQSB=0.997118;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,143:5:0 0,12,137:4:0 +X 3444 . A <*> 0 . DP=20;I16=11,9,0,0,698,25978,0,0,1138,66482,0,0,369,8379,0,0;QS=3,0;MQSB=0.997118;MQ0F=0 PL:DP:DV 0,33,244:11:0 0,15,161:5:0 0,12,131:4:0 +X 3445 . G <*> 0 . DP=20;I16=11,9,0,0,718,26590,0,0,1138,66482,0,0,372,8488,0,0;QS=3,0;MQSB=0.997118;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,153:5:0 0,12,132:4:0 +X 3446 . A <*> 0 . DP=20;I16=10,8,0,0,635,23323,0,0,1049,62041,0,0,325,7365,0,0;QS=3,0;MQSB=0.938795;MQ0F=0 PL:DP:DV 0,27,222:9:0 0,15,154:5:0 0,12,131:4:0 +X 3447 . T <*> 0 . DP=20;I16=11,8,0,0,669,24331,0,0,1109,65641,0,0,352,8084,0,0;QS=3,0;MQSB=0.946915;MQ0F=0 PL:DP:DV 0,30,230:10:0 0,15,150:5:0 0,12,137:4:0 +X 3448 . C <*> 0 . DP=19;I16=10,8,0,0,641,23693,0,0,1049,62041,0,0,355,8193,0,0;QS=3,0;MQSB=0.938795;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,113:4:0 0,12,128:4:0 +X 3449 . A <*> 0 . DP=19;I16=10,8,0,0,565,19185,0,0,1049,62041,0,0,357,8265,0,0;QS=3,0;MQSB=0.938795;MQ0F=0 PL:DP:DV 0,30,217:10:0 0,12,111:4:0 0,12,119:4:0 +X 3450 . C <*> 0 . DP=18;I16=8,8,0,0,520,17846,0,0,898,52082,0,0,334,7674,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,229:10:0 0,6,70:2:0 0,12,106:4:0 +X 3451 . G <*> 0 . DP=18;I16=10,7,0,0,528,17178,0,0,989,58441,0,0,361,8345,0,0;QS=3,0;MQSB=0.943335;MQ0F=0 PL:DP:DV 0,30,226:10:0 0,9,56:3:0 0,12,123:4:0 +X 3452 . C <*> 0 . DP=18;I16=10,8,0,0,657,24597,0,0,1018,59282,0,0,388,9028,0,0;QS=3,0;MQSB=0.99606;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,84:3:0 0,12,128:4:0 +X 3453 . C <*> 0 . DP=18;I16=10,8,0,0,663,24951,0,0,1018,59282,0,0,390,9098,0,0;QS=3,0;MQSB=0.99606;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,90:3:0 0,12,125:4:0 +X 3454 . A <*> 0 . DP=18;I16=10,8,0,0,614,21898,0,0,1018,59282,0,0,392,9180,0,0;QS=3,0;MQSB=0.99606;MQ0F=0 PL:DP:DV 0,33,251:11:0 0,9,90:3:0 0,12,128:4:0 +X 3455 . C <*> 0 . DP=18;I16=10,8,0,0,650,23968,0,0,1018,59282,0,0,394,9274,0,0;QS=3,0;MQSB=0.99606;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,90:3:0 0,12,127:4:0 +X 3456 . T <*> 0 . DP=18;I16=10,8,0,0,607,21961,0,0,1018,59282,0,0,395,9329,0,0;QS=3,0;MQSB=0.99606;MQ0F=0 PL:DP:DV 0,33,243:11:0 0,9,88:3:0 0,12,135:4:0 +X 3457 . G <*> 0 . DP=18;I16=9,7,0,0,549,19861,0,0,898,52082,0,0,346,8144,0,0;QS=3,0;MQSB=0.994413;MQ0F=0 PL:DP:DV 0,33,254:11:0 0,6,63:2:0 0,9,107:3:0 +X 3458 . C <*> 0 . DP=18;I16=10,8,0,0,638,23236,0,0,1018,59282,0,0,397,9469,0,0;QS=3,0;MQSB=0.99606;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,81:3:0 0,12,125:4:0 +X 3459 . A C,<*> 0 . DP=17;I16=9,7,0,1,520,18390,22,484,929,54841,29,841,372,8830,25,625;QS=2.92971,0.0702875,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.998843;BQB=1;MQ0F=0 PL:DP:DV 0,8,201,27,204,213:10:1 0,9,84,9,84,84:3:0 0,12,116,12,116,116:4:0 +X 3460 . C <*> 0 . DP=17;I16=8,7,0,0,554,20952,0,0,869,51241,0,0,345,8103,0,0;QS=3,0;MQSB=0.921243;MQ0F=0 PL:DP:DV 0,27,244:9:0 0,6,65:2:0 0,12,131:4:0 +X 3461 . T <*> 0 . DP=17;I16=9,7,0,0,591,22805,0,0,929,54841,0,0,368,8638,0,0;QS=3,0;MQSB=0.933674;MQ0F=0 PL:DP:DV 0,27,231:9:0 0,9,103:3:0 0,12,133:4:0 +X 3462 . C <*> 0 . DP=18;I16=9,9,0,0,672,25486,0,0,1018,59282,0,0,391,9185,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,90:3:0 0,12,130:4:0 +X 3463 . C <*> 0 . DP=18;I16=8,9,0,0,584,21458,0,0,958,55682,0,0,369,8671,0,0;QS=3,0;MQSB=0.998843;MQ0F=0 PL:DP:DV 0,30,244:10:0 0,9,86:3:0 0,12,132:4:0 +X 3464 . A <*> 0 . DP=18;I16=9,9,0,0,628,23490,0,0,1018,59282,0,0,387,8973,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,244:11:0 0,9,96:3:0 0,12,142:4:0 +X 3465 . G <*> 0 . DP=19;I16=9,9,0,0,642,24008,0,0,1018,59282,0,0,384,8842,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,91:3:0 0,12,135:4:0 +X 3466 . C <*> 0 . DP=20;I16=9,10,0,0,682,25218,0,0,1047,60123,0,0,378,8588,0,0;QS=3,0;MQSB=0.904084;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,101:3:0 0,15,147:5:0 +X 3467 . C <*> 0 . DP=20;I16=10,9,0,0,685,25919,0,0,1047,60123,0,0,397,9139,0,0;QS=3,0;MQSB=0.948064;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,115:4:0 0,15,154:5:0 +X 3468 . T <*> 0 . DP=20;I16=10,9,0,0,672,25426,0,0,1047,60123,0,0,374,8410,0,0;QS=3,0;MQSB=0.948064;MQ0F=0 PL:DP:DV 0,30,246:10:0 0,12,126:4:0 0,15,164:5:0 +X 3469 . G <*> 0 . DP=21;I16=10,11,0,0,788,30064,0,0,1167,67323,0,0,396,8924,0,0;QS=3,0;MQSB=0.914611;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,146:5:0 0,15,163:5:0 +X 3470 . G <*> 0 . DP=22;I16=11,11,0,0,796,29754,0,0,1196,68164,0,0,393,8781,0,0;QS=3,0;MQSB=0.770381;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,131:5:0 0,15,161:5:0 +X 3471 . G <*> 0 . DP=23;I16=12,11,0,0,801,29083,0,0,1256,71764,0,0,391,8657,0,0;QS=3,0;MQSB=0.811552;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,133:5:0 0,15,151:5:0 +X 3472 . C <*> 0 . DP=23;I16=12,11,0,0,757,26535,0,0,1256,71764,0,0,390,8554,0,0;QS=3,0;MQSB=0.811552;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,145:5:0 0,15,136:5:0 +X 3473 . A <*> 0 . DP=23;I16=11,11,0,0,777,28175,0,0,1196,68164,0,0,379,8373,0,0;QS=3,0;MQSB=0.770381;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,148:5:0 0,15,153:5:0 +X 3474 . A <*> 0 . DP=23;I16=12,11,0,0,807,29181,0,0,1256,71764,0,0,388,8414,0,0;QS=3,0;MQSB=0.811552;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,150:5:0 0,15,155:5:0 +X 3475 . C <*> 0 . DP=22;I16=12,10,0,0,737,25849,0,0,1196,68164,0,0,387,8327,0,0;QS=3,0;MQSB=0.838545;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,137:5:0 0,15,143:5:0 +X 3476 . A <*> 0 . DP=22;I16=12,10,0,0,790,29312,0,0,1196,68164,0,0,386,8262,0,0;QS=3,0;MQSB=0.838545;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,149:5:0 0,15,154:5:0 +X 3477 . G <*> 0 . DP=22;I16=11,10,0,0,755,28237,0,0,1136,64564,0,0,363,7735,0,0;QS=3,0;MQSB=0.799507;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,126:4:0 0,15,153:5:0 +X 3478 . A <*> 0 . DP=25;I16=13,11,0,0,857,31637,0,0,1316,75364,0,0,384,8198,0,0;QS=3,0;MQSB=0.845496;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,167:6:0 0,18,190:6:0 +X 3479 . G <*> 0 . DP=25;I16=12,10,0,0,783,28623,0,0,1227,70923,0,0,355,7701,0,0;QS=3,0;MQSB=0.613159;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,152:5:0 0,18,160:6:0 +X 3480 . T <*> 0 . DP=25;I16=13,11,0,0,788,27124,0,0,1316,75364,0,0,393,8531,0,0;QS=3,0;MQSB=0.845496;MQ0F=0 PL:DP:DV 0,33,249:11:0 0,21,182:7:0 0,18,155:6:0 +X 3481 . A <*> 0 . DP=25;I16=12,12,0,0,858,30884,0,0,1347,78123,0,0,397,8685,0,0;QS=3,0;MQSB=0.941765;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,194:7:0 0,15,148:5:0 +X 3482 . A <*> 0 . DP=25;I16=13,12,0,0,927,35013,0,0,1376,78964,0,0,412,8942,0,0;QS=3,0;MQSB=0.822311;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,202:7:0 0,18,182:6:0 +X 3483 . G <*> 0 . DP=25;I16=12,12,0,0,794,27410,0,0,1316,75364,0,0,412,9002,0,0;QS=3,0;MQSB=0.786628;MQ0F=0 PL:DP:DV 0,33,253:11:0 0,21,183:7:0 0,18,158:6:0 +X 3484 . A C,<*> 0 . DP=24;I16=12,9,0,1,710,25220,14,196,1198,70082,60,3600,346,7514,25,625;QS=2.93665,0.0633484,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.804615;BQB=1;MQ0F=0 PL:DP:DV 0,30,227,30,227,227:10:0 0,7,156,18,159,162:7:1 0,15,133,15,133,133:5:0 +X 3485 . C <*> 0 . DP=23;I16=11,11,0,0,766,27656,0,0,1196,68164,0,0,393,8573,0,0;QS=3,0;MQSB=0.770381;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,163:6:0 0,15,120:5:0 +X 3486 . T <*> 0 . DP=24;I16=12,10,0,0,799,30529,0,0,1196,68164,0,0,398,8756,0,0;QS=3,0;MQSB=0.838545;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,198:7:0 0,15,128:5:0 +X 3487 . C <*> 0 . DP=24;I16=10,11,0,0,724,27586,0,0,1167,67323,0,0,393,8905,0,0;QS=3,0;MQSB=0.914611;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,162:6:0 0,12,92:4:0 +X 3488 . T <*> 0 . DP=24;I16=12,10,0,0,742,27454,0,0,1196,68164,0,0,429,9571,0,0;QS=3,0;MQSB=0.838545;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,172:7:0 0,12,98:4:0 +X 3489 . G <*> 0 . DP=25;I16=13,11,0,0,778,28994,0,0,1285,72605,0,0,433,9675,0,0;QS=3,0;MQSB=0.97965;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,177:8:0 0,12,75:4:0 +X 3490 . T C,<*> 0 . DP=27;I16=14,10,1,0,806,28886,25,625,1254,69846,60,3600,427,9659,12,144;QS=2.90775,0.0922509,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.962269;BQB=1;MQ0F=0 PL:DP:DV 0,39,255,39,255,255:13:0 0,2,168,24,171,183:9:1 0,9,85,9,85,85:3:0 +X 3491 . C <*> 0 . DP=28;I16=15,11,0,0,864,31232,0,0,1405,79805,0,0,445,9903,0,0;QS=3,0;MQSB=0.753395;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,197:9:0 0,9,78:3:0 +X 3492 . T <*> 0 . DP=28;I16=15,11,0,0,852,31516,0,0,1405,79805,0,0,452,9986,0,0;QS=3,0;MQSB=0.753395;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,212:9:0 0,9,96:3:0 +X 3493 . C <*> 0 . DP=28;I16=15,12,0,0,891,32181,0,0,1434,80646,0,0,464,10124,0,0;QS=3,0;MQSB=0.908075;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,27,214:9:0 0,9,80:3:0 +X 3493 . CAAAAAAAAAAAAA CAAAAAAAAAAAA,CAAAAAAAAAAAAAA 0 . INDEL;IDV=2;IMF=0.125;DP=28;I16=9,9,0,2,443,11071,47,1129,1049,62041,89,4441,320,7120,30,650;QS=2.81818,0.0909091,0.0909091;VDB=0.504964;SGB=0.346553;MQSB=0.997118;MQ0F=0 PL:DP:DV 0,19,37,19,40,37:11:2 0,18,39,18,39,39:6:0 0,9,23,9,23,23:3:0 +X 3494 . A <*> 0 . DP=30;I16=15,12,0,0,970,37408,0,0,1465,83405,0,0,440,9568,0,0;QS=3,0;MQSB=0.723173;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,220:9:0 0,12,117:4:0 +X 3495 . A <*> 0 . DP=31;I16=15,13,0,0,966,36178,0,0,1525,87005,0,0,472,10270,0,0;QS=3,0;MQSB=0.695496;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,210:9:0 0,15,129:5:0 +X 3496 . A <*> 0 . DP=31;I16=15,13,0,0,974,36928,0,0,1525,87005,0,0,477,10281,0,0;QS=3,0;MQSB=0.695496;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,207:9:0 0,15,138:5:0 +X 3497 . A <*> 0 . DP=32;I16=14,14,0,0,1015,39525,0,0,1525,87005,0,0,460,9834,0,0;QS=3,0;MQSB=0.62781;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,208:8:0 0,18,148:6:0 +X 3498 . A <*> 0 . DP=32;I16=14,14,0,0,982,37264,0,0,1556,89764,0,0,460,9628,0,0;QS=3,0;MQSB=0.813104;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,220:9:0 0,15,115:5:0 +X 3499 . A <*> 0 . DP=32;I16=14,14,0,0,1024,40072,0,0,1525,87005,0,0,489,10267,0,0;QS=3,0;MQSB=0.62781;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,222:8:0 0,18,144:6:0 +X 3500 . A <*> 0 . DP=31;I16=14,14,0,0,995,38097,0,0,1525,87005,0,0,494,10316,0,0;QS=3,0;MQSB=0.62781;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,214:8:0 0,18,150:6:0 +X 3501 . A <*> 0 . DP=31;I16=14,14,0,0,1017,39845,0,0,1525,87005,0,0,499,10399,0,0;QS=3,0;MQSB=0.62781;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,221:8:0 0,18,149:6:0 +X 3502 . A <*> 0 . DP=31;I16=14,14,0,0,1051,41955,0,0,1525,87005,0,0,504,10516,0,0;QS=3,0;MQSB=0.62781;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,223:8:0 0,18,154:6:0 +X 3503 . A <*> 0 . DP=31;I16=14,14,0,0,1038,40832,0,0,1525,87005,0,0,509,10667,0,0;QS=3,0;MQSB=0.62781;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,229:8:0 0,18,155:6:0 +X 3504 . A <*> 0 . DP=31;I16=14,14,0,0,1037,41235,0,0,1525,87005,0,0,512,10750,0,0;QS=3,0;MQSB=0.62781;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,229:8:0 0,18,145:6:0 +X 3505 . A <*> 0 . DP=31;I16=14,14,0,0,1039,40959,0,0,1525,87005,0,0,514,10814,0,0;QS=3,0;MQSB=0.62781;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,233:8:0 0,18,156:6:0 +X 3506 . A <*> 0 . DP=32;I16=11,13,0,0,889,34265,0,0,1378,80882,0,0,427,9079,0,0;QS=3,0;MQSB=0.998323;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,201:6:0 0,18,158:6:0 +X 3507 . T <*> 0 . DP=31;I16=10,17,0,0,995,38431,0,0,1527,88923,0,0,493,10499,0,0;QS=3,0;MQSB=0.997168;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,187:6:0 0,18,153:6:0 +X 3508 . C <*> 0 . DP=31;I16=10,17,0,0,997,40091,0,0,1527,88923,0,0,499,10675,0,0;QS=3,0;MQSB=0.997168;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,160:6:0 0,15,119:5:0 +X 3509 . A <*> 0 . DP=30;I16=11,17,0,0,995,37147,0,0,1556,89764,0,0,529,11459,0,0;QS=3,0;MQSB=0.960952;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,175:6:0 0,15,125:5:0 +X 3510 . C A,<*> 0 . DP=29;I16=9,17,1,0,959,37997,40,1600,1498,88082,29,841,483,10351,25,625;QS=2.95246,0.047541,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.997168;BQB=1;MQ0F=0 PL:DP:DV 0,19,255,45,255,255:16:1 0,18,150,18,150,150:6:0 0,15,119,15,119,119:5:0 +X 3511 . A <*> 0 . DP=32;I16=11,17,0,0,923,33125,0,0,1587,92523,0,0,512,11150,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,169:6:0 0,15,115:5:0 +X 3512 . C <*> 0 . DP=32;I16=10,18,0,0,1058,42208,0,0,1618,95282,0,0,493,10733,0,0;QS=3,0;MQSB=0.891417;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,181:6:0 0,15,131:5:0 +X 3513 . C A,<*> 0 . DP=32;I16=10,18,1,0,1074,42406,13,169,1618,95282,29,841,498,10926,25,625;QS=2.98,0.02,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.995968;BQB=1;MQ0F=0 PL:DP:DV 0,39,255,51,255,255:18:1 0,18,190,18,190,190:6:0 0,15,136,15,136,136:5:0 +X 3514 . A <*> 0 . DP=33;I16=11,19,0,0,1101,42213,0,0,1707,99723,0,0,528,11778,0,0;QS=3,0;MQSB=0.997918;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,199:7:0 0,15,132:5:0 +X 3515 . T <*> 0 . DP=33;I16=12,19,0,0,1130,43380,0,0,1736,100564,0,0,557,12563,0,0;QS=3,0;MQSB=0.960505;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,192:7:0 0,15,126:5:0 +X 3516 . T <*> 0 . DP=34;I16=14,17,0,0,1147,44331,0,0,1767,103323,0,0,536,12078,0,0;QS=3,0;MQSB=0.924242;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,203:7:0 0,15,133:5:0 +X 3517 . T <*> 0 . DP=34;I16=14,18,0,0,1183,46549,0,0,1796,104164,0,0,565,12773,0,0;QS=3,0;MQSB=0.988522;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,21,210:7:0 0,15,153:5:0 +X 3518 . T <*> 0 . DP=34;I16=14,18,0,0,1165,44867,0,0,1796,104164,0,0,568,12826,0,0;QS=3,0;MQSB=0.988522;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,21,203:7:0 0,15,141:5:0 +X 3519 . G <*> 0 . DP=33;I16=13,18,0,0,1158,46678,0,0,1736,100564,0,0,572,12912,0,0;QS=3,0;MQSB=0.980167;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,18,189:6:0 0,15,154:5:0 +X 3520 . G <*> 0 . DP=33;I16=12,18,0,0,1111,42471,0,0,1707,99723,0,0,552,12438,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,183:6:0 0,15,151:5:0 +X 3521 . C <*> 0 . DP=32;I16=11,17,0,0,1077,43755,0,0,1649,98041,0,0,530,11850,0,0;QS=3,0;MQSB=0.967085;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,185:6:0 0,15,143:5:0 +X 3522 . T <*> 0 . DP=32;I16=12,17,0,0,1125,46329,0,0,1678,98882,0,0,552,12274,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,199:6:0 0,15,158:5:0 +X 3523 . T <*> 0 . DP=31;I16=11,16,0,0,996,38204,0,0,1558,91682,0,0,544,12286,0,0;QS=3,0;MQSB=0.992419;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,193:6:0 0,15,145:5:0 +X 3524 . C <*> 0 . DP=31;I16=11,16,0,0,1067,43883,0,0,1589,94441,0,0,538,11960,0,0;QS=3,0;MQSB=0.96384;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,192:6:0 0,15,152:5:0 +X 3525 . A <*> 0 . DP=31;I16=13,16,0,0,1132,46402,0,0,1678,98882,0,0,556,12250,0,0;QS=3,0;MQSB=0.997839;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,200:6:0 0,15,165:5:0 +X 3526 . G <*> 0 . DP=31;I16=12,16,0,0,1090,43912,0,0,1649,98041,0,0,543,12053,0,0;QS=3,0;MQSB=0.96195;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,181:6:0 0,15,147:5:0 +X 3527 . A <*> 0 . DP=31;I16=13,16,0,0,1068,41740,0,0,1678,98882,0,0,560,12334,0,0;QS=3,0;MQSB=0.997839;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,170:6:0 0,15,157:5:0 +X 3528 . T <*> 0 . DP=31;I16=13,16,0,0,1076,41782,0,0,1678,98882,0,0,561,12369,0,0;QS=3,0;MQSB=0.997839;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,193:6:0 0,15,152:5:0 +X 3529 . T <*> 0 . DP=31;I16=12,16,0,0,1016,38674,0,0,1649,98041,0,0,550,12290,0,0;QS=3,0;MQSB=0.96195;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,184:6:0 0,15,154:5:0 +X 3530 . G <*> 0 . DP=30;I16=12,17,0,0,1070,40570,0,0,1709,101641,0,0,578,13032,0,0;QS=3,0;MQSB=0.965321;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,176:6:0 0,18,175:6:0 +X 3531 . C A,<*> 0 . DP=31;I16=13,17,1,0,1080,40304,38,1444,1738,102482,29,841,607,13801,10,100;QS=2.95773,0.0422741,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.924242;BQB=1;MQ0F=0 PL:DP:DV 0,28,255,54,255,255:19:1 0,18,172,18,172,172:6:0 0,18,175,18,175,175:6:0 +X 3532 . A <*> 0 . DP=31;I16=14,17,0,0,1136,42380,0,0,1767,103323,0,0,619,14003,0,0;QS=3,0;MQSB=0.924242;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,180:6:0 0,18,184:6:0 +X 3533 . T <*> 0 . DP=31;I16=13,17,0,0,1074,39206,0,0,1738,102482,0,0,595,13457,0,0;QS=3,0;MQSB=0.996503;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,180:6:0 0,18,176:6:0 +X 3534 . A <*> 0 . DP=30;I16=12,17,0,0,1014,36168,0,0,1678,98882,0,0,597,13561,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,165:6:0 0,18,175:6:0 +X 3535 . T <*> 0 . DP=31;I16=14,17,0,0,1042,36456,0,0,1767,103323,0,0,624,14314,0,0;QS=3,0;MQSB=0.924242;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,162:6:0 0,18,164:6:0 +X 3536 . C <*> 0 . DP=31;I16=13,17,0,0,1102,41182,0,0,1738,102482,0,0,602,13842,0,0;QS=3,0;MQSB=0.996503;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,178:6:0 0,18,180:6:0 +X 3537 . C <*> 0 . DP=32;I16=13,17,0,0,1142,43828,0,0,1769,105241,0,0,598,13854,0,0;QS=3,0;MQSB=0.963674;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,194:7:0 0,18,185:6:0 +X 3538 . T <*> 0 . DP=32;I16=14,17,0,0,1151,43471,0,0,1798,106082,0,0,603,13923,0,0;QS=3,0;MQSB=0.998229;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,211:7:0 0,18,185:6:0 +X 3539 . C <*> 0 . DP=32;I16=12,17,0,0,1077,40959,0,0,1709,101641,0,0,600,13994,0,0;QS=3,0;MQSB=0.965321;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,170:6:0 0,18,173:6:0 +X 3540 . C <*> 0 . DP=31;I16=13,17,0,0,1134,43546,0,0,1769,105241,0,0,603,14055,0,0;QS=3,0;MQSB=0.963674;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,209:7:0 0,18,172:6:0 +X 3541 . T <*> 0 . DP=32;I16=13,18,0,0,1143,42901,0,0,1829,108841,0,0,604,14134,0,0;QS=3,0;MQSB=0.966712;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,224:8:0 0,18,187:6:0 +X 3542 . G <*> 0 . DP=32;I16=13,18,0,0,1152,43714,0,0,1829,108841,0,0,604,14134,0,0;QS=3,0;MQSB=0.966712;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,223:8:0 0,18,172:6:0 +X 3543 . C <*> 0 . DP=31;I16=13,17,0,0,1142,43818,0,0,1769,105241,0,0,605,14153,0,0;QS=3,0;MQSB=0.963674;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,221:8:0 0,18,188:6:0 +X 3544 . A <*> 0 . DP=31;I16=13,17,0,0,1089,40065,0,0,1769,105241,0,0,606,14190,0,0;QS=3,0;MQSB=0.963674;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,221:8:0 0,18,173:6:0 +X 3545 . A <*> 0 . DP=30;I16=13,16,0,0,1118,43688,0,0,1709,101641,0,0,607,14195,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,228:7:0 0,18,196:6:0 +X 3546 . G <*> 0 . DP=30;I16=14,16,0,0,1131,43425,0,0,1738,102482,0,0,630,14698,0,0;QS=3,0;MQSB=0.999136;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,206:7:0 0,18,179:6:0 +X 3547 . G <*> 0 . DP=31;I16=13,17,0,0,1076,39798,0,0,1769,105241,0,0,607,14163,0,0;QS=3,0;MQSB=0.963674;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,189:7:0 0,18,187:6:0 +X 3548 . A <*> 0 . DP=31;I16=13,17,0,0,1071,39059,0,0,1769,105241,0,0,608,14178,0,0;QS=3,0;MQSB=0.963674;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,208:7:0 0,18,179:6:0 +X 3549 . T <*> 0 . DP=30;I16=13,16,0,0,1008,35928,0,0,1678,98882,0,0,605,13989,0,0;QS=3,0;MQSB=0.997839;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,180:6:0 0,15,152:5:0 +X 3550 . A <*> 0 . DP=30;I16=13,16,0,0,1061,39371,0,0,1709,101641,0,0,612,14270,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,194:7:0 0,15,173:5:0 +X 3551 . T <*> 0 . DP=30;I16=13,16,0,0,1026,36844,0,0,1709,101641,0,0,613,14295,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,192:7:0 0,15,162:5:0 +X 3552 . A <*> 0 . DP=30;I16=14,16,0,0,1080,39588,0,0,1738,102482,0,0,631,14627,0,0;QS=3,0;MQSB=0.999136;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,202:7:0 0,15,158:5:0 +X 3553 . T A,<*> 0 . DP=30;I16=13,16,1,0,1047,38333,20,400,1709,101641,29,841,616,14398,16,256;QS=2.96795,0.0320513,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.999136;BQB=1;MQ0F=0 PL:DP:DV 0,34,255,51,255,255:18:1 0,18,178,18,178,178:6:0 0,18,183,18,183,183:6:0 +X 3554 . A <*> 0 . DP=30;I16=14,16,0,0,1063,38413,0,0,1738,102482,0,0,632,14602,0,0;QS=3,0;MQSB=0.999136;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,185:6:0 0,18,179:6:0 +X 3555 . C <*> 0 . DP=30;I16=14,16,0,0,1021,35781,0,0,1738,102482,0,0,632,14574,0,0;QS=3,0;MQSB=0.999136;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,169:6:0 0,18,163:6:0 +X 3556 . G <*> 0 . DP=30;I16=13,16,0,0,1014,36426,0,0,1709,101641,0,0,618,14350,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,168:6:0 0,18,173:6:0 +X 3557 . C <*> 0 . DP=31;I16=14,16,0,0,1001,34919,0,0,1769,105241,0,0,618,14342,0,0;QS=3,0;MQSB=0.958545;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,140:6:0 0,18,165:6:0 +X 3558 . G <*> 0 . DP=31;I16=15,16,0,0,1036,35974,0,0,1798,106082,0,0,630,14476,0,0;QS=3,0;MQSB=0.999805;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,159:6:0 0,18,171:6:0 +X 3559 . T <*> 0 . DP=30;I16=14,16,0,0,1086,40202,0,0,1769,105241,0,0,619,14341,0,0;QS=3,0;MQSB=0.958545;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,171:6:0 0,18,192:6:0 +X 3560 . G <*> 0 . DP=31;I16=14,16,0,0,1151,45035,0,0,1738,102482,0,0,611,14127,0,0;QS=3,0;MQSB=0.999136;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,165:5:0 0,18,194:6:0 +X 3561 . A <*> 0 . DP=31;I16=15,16,0,0,1147,43431,0,0,1798,106082,0,0,626,14366,0,0;QS=3,0;MQSB=0.999805;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,186:6:0 0,18,196:6:0 +X 3562 . A <*> 0 . DP=31;I16=16,15,0,0,1157,43859,0,0,1798,106082,0,0,623,14257,0,0;QS=3,0;MQSB=0.999805;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,192:6:0 0,21,213:7:0 +X 3563 . A <*> 0 . DP=31;I16=16,15,0,0,1162,44010,0,0,1798,106082,0,0,620,14124,0,0;QS=3,0;MQSB=0.999805;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,192:6:0 0,21,216:7:0 +X 3564 . T <*> 0 . DP=31;I16=15,15,0,0,1132,43298,0,0,1769,105241,0,0,610,13932,0,0;QS=3,0;MQSB=0.952765;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,192:6:0 0,21,214:7:0 +X 3565 . T <*> 0 . DP=32;I16=16,16,0,0,1163,42649,0,0,1858,109682,0,0,611,13791,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,189:6:0 0,21,212:7:0 +X 3566 . C <*> 0 . DP=32;I16=16,16,0,0,1162,43586,0,0,1858,109682,0,0,606,13596,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,181:6:0 0,21,209:7:0 +X 3567 . A <*> 0 . DP=32;I16=15,16,0,0,1181,45245,0,0,1829,108841,0,0,597,13375,0,0;QS=3,0;MQSB=0.957006;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,192:6:0 0,21,222:7:0 +X 3568 . A <*> 0 . DP=32;I16=15,16,0,0,1194,46670,0,0,1829,108841,0,0,592,13200,0,0;QS=3,0;MQSB=0.957006;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,204:6:0 0,21,228:7:0 +X 3569 . G <*> 0 . DP=31;I16=15,16,0,0,1164,44544,0,0,1829,108841,0,0,586,13006,0,0;QS=3,0;MQSB=0.957006;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,180:6:0 0,21,204:7:0 +X 3570 . T <*> 0 . DP=30;I16=14,15,0,0,1029,37527,0,0,1709,101641,0,0,572,12730,0,0;QS=3,0;MQSB=0.954405;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,12,136:4:0 0,21,213:7:0 +X 3571 . C <*> 0 . DP=28;I16=13,15,0,0,1066,41192,0,0,1649,98041,0,0,568,12564,0,0;QS=3,0;MQSB=0.956162;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,138:4:0 0,21,215:7:0 +X 3572 . A <*> 0 . DP=29;I16=13,16,0,0,1108,42566,0,0,1709,101641,0,0,564,12426,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,172:5:0 0,21,218:7:0 +X 3573 . A <*> 0 . DP=29;I16=13,16,0,0,1119,43403,0,0,1709,101641,0,0,558,12168,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,174:5:0 0,21,220:7:0 +X 3574 . T <*> 0 . DP=29;I16=13,16,0,0,1104,42220,0,0,1709,101641,0,0,552,11942,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,175:5:0 0,21,218:7:0 +X 3575 . G <*> 0 . DP=29;I16=13,16,0,0,1122,43748,0,0,1709,101641,0,0,546,11748,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,161:5:0 0,21,212:7:0 +X 3576 . A <*> 0 . DP=29;I16=13,16,0,0,1043,38405,0,0,1709,101641,0,0,540,11586,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,170:5:0 0,21,213:7:0 +X 3577 . C <*> 0 . DP=30;I16=13,17,0,0,1123,42529,0,0,1769,105241,0,0,534,11456,0,0;QS=3,0;MQSB=0.963674;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,161:5:0 0,21,211:7:0 +X 3578 . A <*> 0 . DP=30;I16=13,17,0,0,1148,44236,0,0,1769,105241,0,0,529,11359,0,0;QS=3,0;MQSB=0.963674;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,178:5:0 0,21,216:7:0 +X 3579 . A <*> 0 . DP=29;I16=13,16,0,0,1051,38961,0,0,1709,101641,0,0,524,11244,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,172:5:0 0,18,192:6:0 +X 3580 . A <*> 0 . DP=29;I16=13,16,0,0,1104,42344,0,0,1709,101641,0,0,519,11159,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,172:5:0 0,18,201:6:0 +X 3581 . T <*> 0 . DP=29;I16=13,16,0,0,1088,41226,0,0,1709,101641,0,0,513,11055,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,161:5:0 0,18,199:6:0 +X 3582 . C <*> 0 . DP=29;I16=13,16,0,0,1120,43616,0,0,1709,101641,0,0,506,10934,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,172:5:0 0,18,201:6:0 +X 3583 . A <*> 0 . DP=30;I16=14,16,0,0,1130,43606,0,0,1769,105241,0,0,498,10796,0,0;QS=3,0;MQSB=0.958545;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,183:5:0 0,21,213:7:0 +X 3584 . G <*> 0 . DP=29;I16=12,16,0,0,1027,38895,0,0,1649,98041,0,0,487,10665,0,0;QS=3,0;MQSB=0.96195;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,137:4:0 0,21,209:7:0 +X 3585 . A <*> 0 . DP=31;I16=14,17,0,0,1057,37719,0,0,1829,108841,0,0,486,10616,0,0;QS=3,0;MQSB=0.962133;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,168:5:0 0,24,209:8:0 +X 3586 . A <*> 0 . DP=30;I16=14,15,0,0,1053,40043,0,0,1709,101641,0,0,477,10461,0,0;QS=3,0;MQSB=0.954405;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,174:5:0 0,24,213:8:0 +X 3587 . G A,<*> 0 . DP=29;I16=4,7,10,6,426,16884,555,20381,660,39600,960,57600,192,4420,280,5942;QS=1.32665,1.67335,0;VDB=0.902044;SGB=-3.91326;RPB=0.800999;MQB=1;MQSB=1;BQB=0.156944;MQ0F=0 PL:DP:DV 161,0,184,182,205,255:14:7 22,0,118,34,121,148:5:1 212,24,0,212,24,212:8:8 +X 3588 . A <*> 0 . DP=29;I16=14,14,0,0,999,36973,0,0,1680,100800,0,0,470,10254,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,166:5:0 0,24,215:8:0 +X 3589 . A <*> 0 . DP=28;I16=14,13,0,0,967,35935,0,0,1620,97200,0,0,467,10173,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,166:5:0 0,24,206:8:0 +X 3590 . A <*> 0 . DP=27;I16=13,13,0,0,948,35860,0,0,1560,93600,0,0,464,10072,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,146:4:0 0,24,211:8:0 +X 3591 . A <*> 0 . DP=26;I16=13,13,0,0,913,33539,0,0,1560,93600,0,0,459,9901,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,144:4:0 0,24,212:8:0 +X 3592 . A <*> 0 . DP=26;I16=13,13,0,0,893,32087,0,0,1560,93600,0,0,453,9711,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,143:4:0 0,24,199:8:0 +X 3593 . A <*> 0 . DP=26;I16=13,13,0,0,891,31363,0,0,1560,93600,0,0,447,9553,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,137:4:0 0,24,198:8:0 +X 3594 . C <*> 0 . DP=25;I16=12,12,0,0,910,34868,0,0,1440,86400,0,0,426,9170,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,142:4:0 0,24,216:8:0 +X 3595 . A <*> 0 . DP=24;I16=13,11,0,0,918,35274,0,0,1440,86400,0,0,438,9328,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,143:4:0 0,21,199:7:0 +X 3596 . T <*> 0 . DP=24;I16=13,11,0,0,837,30077,0,0,1440,86400,0,0,434,9258,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,138:4:0 0,21,188:7:0 +X 3597 . A <*> 0 . DP=24;I16=13,11,0,0,893,33549,0,0,1440,86400,0,0,430,9216,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,132:4:0 0,21,204:7:0 +X 3598 . T <*> 0 . DP=23;I16=12,10,0,0,778,28226,0,0,1320,79200,0,0,415,9005,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,140:4:0 0,21,162:7:0 +X 3599 . A <*> 0 . DP=23;I16=13,10,0,0,859,32403,0,0,1380,82800,0,0,425,9105,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,142:4:0 0,21,182:7:0 +X 3600 . T <*> 0 . DP=24;I16=14,10,0,0,872,32086,0,0,1435,85825,0,0,422,9036,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,139:4:0 0,21,183:7:0 +X 3601 . A <*> 0 . DP=24;I16=14,10,0,0,862,31424,0,0,1435,85825,0,0,420,8994,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,132:4:0 0,21,186:7:0 +X 3602 . T <*> 0 . DP=25;I16=15,10,0,0,873,31323,0,0,1495,89425,0,0,418,8980,0,0;QS=3,0;MQSB=0.962269;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,161:5:0 0,21,174:7:0 +X 3603 . A <*> 0 . DP=26;I16=15,11,0,0,907,32447,0,0,1555,93025,0,0,416,8944,0,0;QS=3,0;MQSB=0.960078;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,151:5:0 0,24,216:8:0 +X 3604 . C <*> 0 . DP=27;I16=16,11,0,0,905,31199,0,0,1615,96625,0,0,415,8937,0,0;QS=3,0;MQSB=0.96384;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,147:6:0 0,24,201:8:0 +X 3605 . G <*> 0 . DP=27;I16=15,11,0,0,853,28887,0,0,1555,93025,0,0,393,8477,0,0;QS=3,0;MQSB=0.960078;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,171:6:0 0,21,174:7:0 +X 3606 . C <*> 0 . DP=27;I16=15,12,0,0,982,36756,0,0,1615,96625,0,0,415,8967,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,187:6:0 0,27,231:9:0 +X 3607 . A <*> 0 . DP=26;I16=15,11,0,0,927,33859,0,0,1555,93025,0,0,417,9005,0,0;QS=3,0;MQSB=0.960078;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,183:6:0 0,27,232:9:0 +X 3608 . A <*> 0 . DP=27;I16=14,12,0,0,930,34054,0,0,1555,93025,0,0,394,8450,0,0;QS=3,0;MQSB=0.953497;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,176:6:0 0,24,232:8:0 +X 3609 . A <*> 0 . DP=27;I16=15,12,0,0,955,34701,0,0,1615,96625,0,0,421,9127,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,186:6:0 0,27,238:9:0 +X 3610 . C <*> 0 . DP=27;I16=14,12,0,0,915,33071,0,0,1555,93025,0,0,397,8537,0,0;QS=3,0;MQSB=0.953497;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,172:6:0 0,24,221:8:0 +X 3611 . C <*> 0 . DP=25;I16=13,11,0,0,899,33995,0,0,1435,85825,0,0,398,8502,0,0;QS=3,0;MQSB=0.950498;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,173:6:0 0,24,234:8:0 +X 3612 . A <*> 0 . DP=25;I16=14,11,0,0,957,37723,0,0,1495,89425,0,0,424,9118,0,0;QS=3,0;MQSB=0.955682;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,194:6:0 0,27,251:9:0 +X 3613 . G <*> 0 . DP=26;I16=13,12,0,0,902,33110,0,0,1495,89425,0,0,399,8461,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,172:6:0 0,24,223:8:0 +X 3614 . T <*> 0 . DP=26;I16=14,12,0,0,912,33340,0,0,1555,93025,0,0,425,9083,0,0;QS=3,0;MQSB=0.953497;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,156:6:0 0,27,237:9:0 +X 3615 . A <*> 0 . DP=26;I16=15,11,0,0,946,35138,0,0,1555,93025,0,0,427,9109,0,0;QS=3,0;MQSB=0.960078;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,176:6:0 0,27,242:9:0 +X 3616 . T <*> 0 . DP=26;I16=15,11,0,0,965,36541,0,0,1555,93025,0,0,431,9163,0,0;QS=3,0;MQSB=0.960078;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,185:6:0 0,27,238:9:0 +X 3617 . C <*> 0 . DP=25;I16=14,11,0,0,907,33675,0,0,1495,89425,0,0,436,9196,0,0;QS=3,0;MQSB=0.955682;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,176:6:0 0,24,215:8:0 +X 3618 . C <*> 0 . DP=25;I16=14,11,0,0,964,37698,0,0,1495,89425,0,0,441,9259,0,0;QS=3,0;MQSB=0.955682;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,190:6:0 0,24,225:8:0 +X 3619 . T <*> 0 . DP=25;I16=14,11,0,0,961,37553,0,0,1495,89425,0,0,446,9352,0,0;QS=3,0;MQSB=0.955682;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,194:6:0 0,24,238:8:0 +X 3620 . A <*> 0 . DP=25;I16=14,11,0,0,880,31656,0,0,1495,89425,0,0,451,9475,0,0;QS=3,0;MQSB=0.955682;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,178:6:0 0,24,212:8:0 +X 3621 . C <*> 0 . DP=25;I16=14,11,0,0,949,36561,0,0,1495,89425,0,0,456,9628,0,0;QS=3,0;MQSB=0.955682;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,182:6:0 0,24,230:8:0 +X 3622 . T <*> 0 . DP=26;I16=15,11,0,0,983,38067,0,0,1555,93025,0,0,460,9762,0,0;QS=3,0;MQSB=0.960078;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,194:7:0 0,24,242:8:0 +X 3623 . G <*> 0 . DP=27;I16=16,11,0,0,969,35645,0,0,1615,96625,0,0,465,9929,0,0;QS=3,0;MQSB=0.96384;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,195:7:0 0,24,209:8:0 +X 3624 . T <*> 0 . DP=27;I16=15,11,0,0,948,35330,0,0,1555,93025,0,0,448,9596,0,0;QS=3,0;MQSB=0.960078;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,188:6:0 0,24,224:8:0 +X 3625 . G <*> 0 . DP=27;I16=14,12,0,0,983,37483,0,0,1555,93025,0,0,453,9735,0,0;QS=3,0;MQSB=0.953497;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,210:7:0 0,24,219:8:0 +X 3626 . T <*> 0 . DP=28;I16=15,12,0,0,998,37364,0,0,1615,96625,0,0,458,9854,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,214:7:0 0,27,229:9:0 +X 3627 . G <*> 0 . DP=29;I16=15,13,0,0,999,36375,0,0,1675,100225,0,0,464,10004,0,0;QS=3,0;MQSB=0.956162;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,199:7:0 0,27,224:9:0 +X 3628 . T <*> 0 . DP=29;I16=15,13,0,0,1033,38721,0,0,1675,100225,0,0,471,10187,0,0;QS=3,0;MQSB=0.956162;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,206:7:0 0,27,232:9:0 +X 3629 . G <*> 0 . DP=29;I16=15,13,0,0,1058,40226,0,0,1675,100225,0,0,476,10304,0,0;QS=3,0;MQSB=0.956162;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,207:7:0 0,27,235:9:0 +X 3630 . T <*> 0 . DP=30;I16=15,14,0,0,1052,39072,0,0,1735,103825,0,0,480,10404,0,0;QS=3,0;MQSB=0.954405;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,216:7:0 0,27,223:9:0 +X 3631 . C <*> 0 . DP=29;I16=13,14,0,0,884,29476,0,0,1615,96625,0,0,461,9911,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,186:7:0 0,21,179:7:0 +X 3632 . G <*> 0 . DP=29;I16=14,14,0,0,914,31068,0,0,1675,100225,0,0,491,10649,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,183:7:0 0,24,181:8:0 +X 3633 . T <*> 0 . DP=29;I16=14,14,0,0,1022,38214,0,0,1675,100225,0,0,496,10792,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,216:7:0 0,24,222:8:0 +X 3634 . T <*> 0 . DP=29;I16=14,14,0,0,1043,39891,0,0,1675,100225,0,0,500,10914,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,219:7:0 0,24,227:8:0 +X 3635 . T <*> 0 . DP=28;I16=13,14,0,0,1029,39507,0,0,1615,96625,0,0,505,11063,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,219:7:0 0,24,224:8:0 +X 3636 . G <*> 0 . DP=28;I16=13,14,0,0,1001,37681,0,0,1615,96625,0,0,510,11238,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,201:7:0 0,24,217:8:0 +X 3637 . T <*> 0 . DP=27;I16=13,14,0,0,1019,39331,0,0,1615,96625,0,0,515,11439,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,212:7:0 0,24,240:8:0 +X 3638 . T <*> 0 . DP=26;I16=12,14,0,0,967,36467,0,0,1555,93025,0,0,520,11616,0,0;QS=3,0;MQSB=0.937241;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,185:6:0 0,24,222:8:0 +X 3639 . G <*> 0 . DP=27;I16=13,14,0,0,997,37265,0,0,1615,96625,0,0,524,11768,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,183:6:0 0,27,221:9:0 +X 3640 . T <*> 0 . DP=27;I16=13,14,0,0,1001,37533,0,0,1615,96625,0,0,527,11847,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,191:6:0 0,27,229:9:0 +X 3641 . G <*> 0 . DP=27;I16=13,14,0,0,977,36379,0,0,1615,96625,0,0,529,11905,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,178:6:0 0,27,224:9:0 +X 3642 . T <*> 0 . DP=26;I16=12,13,0,0,931,35169,0,0,1495,89425,0,0,506,11314,0,0;QS=3,0;MQSB=0.939413;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,169:5:0 0,24,225:8:0 +X 3643 . T <*> 0 . DP=26;I16=13,13,0,0,968,36820,0,0,1555,93025,0,0,533,11997,0,0;QS=3,0;MQSB=0.945959;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,176:5:0 0,27,230:9:0 +X 3644 . T <*> 0 . DP=26;I16=12,13,0,0,961,37477,0,0,1495,89425,0,0,517,11755,0,0;QS=3,0;MQSB=0.939413;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,175:5:0 0,24,236:8:0 +X 3645 . T <*> 0 . DP=26;I16=13,13,0,0,980,37508,0,0,1555,93025,0,0,537,12185,0,0;QS=3,0;MQSB=0.945959;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,175:5:0 0,27,239:9:0 +X 3646 . C <*> 0 . DP=26;I16=12,13,0,0,766,25026,0,0,1495,89425,0,0,514,11690,0,0;QS=3,0;MQSB=0.939413;MQ0F=0 PL:DP:DV 0,33,234:11:0 0,15,136:5:0 0,27,188:9:0 +X 3647 . G <*> 0 . DP=26;I16=12,12,0,0,820,29600,0,0,1435,85825,0,0,492,11218,0,0;QS=3,0;MQSB=0.941765;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,151:5:0 0,21,173:7:0 +X 3648 . A <*> 0 . DP=26;I16=13,12,0,0,924,34680,0,0,1495,89425,0,0,519,11919,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,174:5:0 0,24,225:8:0 +X 3649 . C <*> 0 . DP=26;I16=14,12,0,0,955,36105,0,0,1555,93025,0,0,545,12593,0,0;QS=3,0;MQSB=0.953497;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,173:5:0 0,27,226:9:0 +X 3650 . A <*> 0 . DP=27;I16=15,12,0,0,1033,40511,0,0,1615,96625,0,0,546,12664,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,196:6:0 0,27,246:9:0 +X 3651 . G <*> 0 . DP=27;I16=15,12,0,0,1035,40351,0,0,1615,96625,0,0,547,12707,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,194:6:0 0,27,233:9:0 +X 3652 . C <*> 0 . DP=29;I16=15,13,0,0,1010,38264,0,0,1675,100225,0,0,521,12047,0,0;QS=3,0;MQSB=0.956162;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,198:6:0 0,27,225:9:0 +X 3653 . T <*> 0 . DP=29;I16=16,13,0,0,1109,42919,0,0,1735,103825,0,0,546,12610,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,202:6:0 0,27,239:9:0 +X 3654 . G <*> 0 . DP=28;I16=14,12,0,0,981,37447,0,0,1555,93025,0,0,514,11882,0,0;QS=3,0;MQSB=0.953497;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,184:6:0 0,18,180:6:0 +X 3655 . T <*> 0 . DP=28;I16=16,12,0,0,999,37029,0,0,1675,100225,0,0,541,12505,0,0;QS=3,0;MQSB=0.96195;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,190:6:0 0,21,179:7:0 +X 3656 . C <*> 0 . DP=28;I16=15,12,0,0,963,35883,0,0,1615,96625,0,0,518,11848,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,164:5:0 0,21,191:7:0 +X 3657 . C <*> 0 . DP=28;I16=15,12,0,0,923,32223,0,0,1615,96625,0,0,520,11836,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,154:5:0 0,21,192:7:0 +X 3658 . G <*> 0 . DP=28;I16=15,12,0,0,876,29960,0,0,1615,96625,0,0,539,12405,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,142:5:0 0,21,163:7:0 +X 3659 . T <*> 0 . DP=28;I16=16,12,0,0,996,36682,0,0,1675,100225,0,0,548,12448,0,0;QS=3,0;MQSB=0.96195;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,163:6:0 0,21,186:7:0 +X 3660 . G <*> 0 . DP=28;I16=15,12,0,0,997,37571,0,0,1615,96625,0,0,526,11920,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,172:6:0 0,18,171:6:0 +X 3661 . T <*> 0 . DP=28;I16=16,12,0,0,1013,37837,0,0,1675,100225,0,0,549,12423,0,0;QS=3,0;MQSB=0.96195;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,180:6:0 0,21,188:7:0 +X 3662 . T <*> 0 . DP=28;I16=15,12,0,0,987,36627,0,0,1615,96625,0,0,528,11980,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,182:6:0 0,18,184:6:0 +X 3663 . A <*> 0 . DP=29;I16=16,12,0,0,997,36233,0,0,1675,100225,0,0,527,11959,0,0;QS=3,0;MQSB=0.96195;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,170:6:0 0,18,180:6:0 +X 3664 . T <*> 0 . DP=29;I16=17,12,0,0,1044,38402,0,0,1735,103825,0,0,550,12490,0,0;QS=3,0;MQSB=0.965321;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,183:6:0 0,21,196:7:0 +X 3665 . A <*> 0 . DP=27;I16=16,11,0,0,1017,38535,0,0,1615,96625,0,0,552,12510,0,0;QS=3,0;MQSB=0.96384;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,182:6:0 0,21,208:7:0 +X 3666 . A <*> 0 . DP=27;I16=16,11,0,0,1036,40292,0,0,1615,96625,0,0,554,12550,0,0;QS=3,0;MQSB=0.96384;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,193:6:0 0,21,208:7:0 +X 3667 . T <*> 0 . DP=27;I16=15,11,0,0,955,35895,0,0,1555,93025,0,0,540,12354,0,0;QS=3,0;MQSB=0.960078;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,189:6:0 0,18,189:6:0 +X 3668 . A <*> 0 . DP=27;I16=16,11,0,0,981,36297,0,0,1615,96625,0,0,557,12641,0,0;QS=3,0;MQSB=0.96384;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,182:6:0 0,21,209:7:0 +X 3669 . A <*> 0 . DP=27;I16=16,11,0,0,1030,39666,0,0,1615,96625,0,0,558,12694,0,0;QS=3,0;MQSB=0.96384;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,194:6:0 0,21,209:7:0 +X 3670 . T <*> 0 . DP=28;I16=17,11,0,0,1057,40245,0,0,1675,100225,0,0,559,12769,0,0;QS=3,0;MQSB=0.967085;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,181:6:0 0,24,220:8:0 +X 3671 . T <*> 0 . DP=28;I16=17,11,0,0,1059,40427,0,0,1675,100225,0,0,561,12867,0,0;QS=3,0;MQSB=0.967085;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,193:6:0 0,24,223:8:0 +X 3672 . C <*> 0 . DP=28;I16=16,11,0,0,988,37264,0,0,1615,96625,0,0,550,12820,0,0;QS=3,0;MQSB=0.96384;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,169:6:0 0,21,205:7:0 +X 3673 . C <*> 0 . DP=27;I16=16,10,0,0,1016,40148,0,0,1555,93025,0,0,528,12314,0,0;QS=3,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,154:5:0 0,24,219:8:0 +X 3674 . T <*> 0 . DP=27;I16=17,10,0,0,1035,40645,0,0,1615,96625,0,0,556,13028,0,0;QS=3,0;MQSB=0.968979;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,155:5:0 0,24,228:8:0 +X 3675 . C <*> 0 . DP=27;I16=17,10,0,0,1049,41413,0,0,1615,96625,0,0,558,13090,0,0;QS=3,0;MQSB=0.968979;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,149:5:0 0,24,222:8:0 +X 3676 . T <*> 0 . DP=27;I16=17,10,0,0,1040,40640,0,0,1615,96625,0,0,559,13125,0,0;QS=3,0;MQSB=0.968979;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,159:5:0 0,24,231:8:0 +X 3677 . A <*> 0 . DP=27;I16=16,10,0,0,922,34182,0,0,1555,93025,0,0,537,12557,0,0;QS=3,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,136:5:0 0,24,217:8:0 +X 3678 . G <*> 0 . DP=27;I16=17,10,0,0,1009,38307,0,0,1615,96625,0,0,563,13159,0,0;QS=3,0;MQSB=0.968979;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,149:5:0 0,24,216:8:0 +X 3679 . T <*> 0 . DP=27;I16=17,10,0,0,1018,39274,0,0,1615,96625,0,0,563,13105,0,0;QS=3,0;MQSB=0.968979;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,156:5:0 0,24,227:8:0 +X 3680 . T <*> 0 . DP=27;I16=17,10,0,0,988,36872,0,0,1615,96625,0,0,562,13022,0,0;QS=3,0;MQSB=0.968979;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,157:5:0 0,24,202:8:0 +X 3681 . C <*> 0 . DP=27;I16=17,10,0,0,1012,39154,0,0,1615,96625,0,0,560,12910,0,0;QS=3,0;MQSB=0.968979;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,157:5:0 0,24,217:8:0 +X 3682 . A <*> 0 . DP=27;I16=17,10,0,0,1009,38221,0,0,1615,96625,0,0,557,12769,0,0;QS=3,0;MQSB=0.968979;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,156:5:0 0,24,220:8:0 +X 3683 . A <*> 0 . DP=27;I16=17,9,0,0,966,36748,0,0,1555,93025,0,0,546,12552,0,0;QS=3,0;MQSB=0.971017;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,153:5:0 0,24,225:8:0 +X 3684 . A <*> 0 . DP=26;I16=16,10,0,0,974,37440,0,0,1555,93025,0,0,550,12456,0,0;QS=3,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,155:5:0 0,21,215:7:0 +X 3685 . T <*> 0 . DP=26;I16=16,10,0,0,954,36330,0,0,1555,93025,0,0,547,12333,0,0;QS=3,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,148:5:0 0,21,207:7:0 +X 3686 . T <*> 0 . DP=26;I16=16,10,0,0,979,37645,0,0,1555,93025,0,0,544,12232,0,0;QS=3,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,162:5:0 0,21,216:7:0 +X 3687 . T <*> 0 . DP=27;I16=16,11,0,0,1028,39276,0,0,1592,94394,0,0,541,12153,0,0;QS=3,0;MQSB=0.989102;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,159:5:0 0,24,229:8:0 +X 3688 . A <*> 0 . DP=28;I16=17,10,0,0,1007,37883,0,0,1569,92163,0,0,526,11904,0,0;QS=3,0;MQSB=0.99874;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,148:5:0 0,24,232:8:0 +X 3689 . T <*> 0 . DP=28;I16=17,11,0,0,1042,39780,0,0,1629,95763,0,0,535,11919,0,0;QS=3,0;MQSB=0.995584;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,162:5:0 0,24,233:8:0 +X 3690 . T <*> 0 . DP=28;I16=17,11,0,0,1051,39981,0,0,1629,95763,0,0,532,11816,0,0;QS=3,0;MQSB=0.995584;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,160:5:0 0,24,225:8:0 +X 3691 . C <*> 0 . DP=28;I16=16,11,0,0,1037,40549,0,0,1569,92163,0,0,520,11592,0,0;QS=3,0;MQSB=0.992419;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,155:5:0 0,21,214:7:0 +X 3692 . A <*> 0 . DP=29;I16=18,11,0,0,1028,37574,0,0,1689,99363,0,0,522,11496,0,0;QS=3,0;MQSB=0.99773;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,156:5:0 0,24,209:8:0 +X 3693 . T <*> 0 . DP=28;I16=18,10,0,0,1067,40901,0,0,1629,95763,0,0,519,11381,0,0;QS=3,0;MQSB=0.999713;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,160:5:0 0,24,230:8:0 +X 3694 . T <*> 0 . DP=28;I16=18,10,0,0,1043,39659,0,0,1629,95763,0,0,516,11296,0,0;QS=3,0;MQSB=0.999713;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,159:5:0 0,24,234:8:0 +X 3695 . T <*> 0 . DP=28;I16=18,10,0,0,1046,39662,0,0,1629,95763,0,0,513,11241,0,0;QS=3,0;MQSB=0.999713;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,156:5:0 0,24,233:8:0 +X 3696 . T <*> 0 . DP=28;I16=18,10,0,0,1075,41567,0,0,1629,95763,0,0,509,11165,0,0;QS=3,0;MQSB=0.999713;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,162:5:0 0,24,235:8:0 +X 3697 . T <*> 0 . DP=28;I16=18,10,0,0,1031,38399,0,0,1629,95763,0,0,505,11117,0,0;QS=3,0;MQSB=0.999713;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,155:5:0 0,24,229:8:0 +X 3698 . A <*> 0 . DP=28;I16=18,9,0,0,983,36457,0,0,1569,92163,0,0,477,10515,0,0;QS=3,0;MQSB=0.999669;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,144:5:0 0,24,229:8:0 +X 3699 . A <*> 0 . DP=27;I16=17,10,0,0,1011,38455,0,0,1569,92163,0,0,493,10861,0,0;QS=3,0;MQSB=0.99874;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,150:5:0 0,21,226:7:0 +X 3700 . C <*> 0 . DP=28;I16=16,11,0,0,970,35910,0,0,1574,92738,0,0,473,10525,0,0;QS=3,0;MQSB=0.992419;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,168:6:0 0,24,212:8:0 +X 3701 . T <*> 0 . DP=28;I16=17,11,0,0,1071,41669,0,0,1634,96338,0,0,484,10618,0,0;QS=3,0;MQSB=0.990092;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,196:6:0 0,24,233:8:0 +X 3702 . T <*> 0 . DP=28;I16=17,10,0,0,1019,38653,0,0,1597,94969,0,0,462,10144,0,0;QS=3,0;MQSB=0.968979;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,184:6:0 0,21,207:7:0 +X 3703 . C <*> 0 . DP=28;I16=17,11,0,0,1059,40561,0,0,1634,96338,0,0,470,10154,0,0;QS=3,0;MQSB=0.990092;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,183:6:0 0,24,232:8:0 +X 3704 . A <*> 0 . DP=28;I16=17,10,0,0,1015,38483,0,0,1574,92738,0,0,439,9347,0,0;QS=3,0;MQSB=0.984677;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,182:6:0 0,21,211:7:0 +X 3705 . T <*> 0 . DP=27;I16=17,10,0,0,992,37112,0,0,1574,92738,0,0,459,9773,0,0;QS=3,0;MQSB=0.984677;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,180:6:0 0,21,209:7:0 +X 3706 . A <*> 0 . DP=27;I16=17,10,0,0,1040,40262,0,0,1574,92738,0,0,454,9608,0,0;QS=3,0;MQSB=0.984677;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,186:6:0 0,21,204:7:0 +X 3707 . G <*> 0 . DP=26;I16=17,9,0,0,974,37394,0,0,1514,89138,0,0,450,9476,0,0;QS=3,0;MQSB=0.977029;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,173:6:0 0,18,168:6:0 +X 3708 . T <*> 0 . DP=26;I16=18,7,0,0,911,33609,0,0,1454,85538,0,0,426,8934,0,0;QS=3,0;MQSB=0.914166;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,182:6:0 0,15,139:5:0 +X 3709 . A <*> 0 . DP=26;I16=18,8,0,0,905,32473,0,0,1491,86907,0,0,445,9305,0,0;QS=3,0;MQSB=0.998458;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,168:6:0 0,18,162:6:0 +X 3710 . C <*> 0 . DP=26;I16=18,8,0,0,924,33504,0,0,1491,86907,0,0,443,9267,0,0;QS=3,0;MQSB=0.998458;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,165:6:0 0,18,159:6:0 +X 3711 . C <*> 0 . DP=26;I16=18,8,0,0,953,35965,0,0,1491,86907,0,0,441,9261,0,0;QS=3,0;MQSB=0.998458;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,164:6:0 0,18,173:6:0 +X 3712 . A <*> 0 . DP=26;I16=18,8,0,0,893,31917,0,0,1491,86907,0,0,439,9287,0,0;QS=3,0;MQSB=0.998458;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,144:6:0 0,18,165:6:0 +X 3713 . C <*> 0 . DP=26;I16=19,7,0,0,908,32834,0,0,1491,86907,0,0,437,9293,0,0;QS=3,0;MQSB=0.989612;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,163:6:0 0,18,164:6:0 +X 3714 . A <*> 0 . DP=27;I16=19,6,0,0,920,34366,0,0,1408,81076,0,0,409,8651,0,0;QS=3,0;MQSB=0.999494;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,177:6:0 0,18,174:6:0 +X 3715 . T <*> 0 . DP=28;I16=21,6,0,0,982,36286,0,0,1505,86045,0,0,408,8616,0,0;QS=3,0;MQSB=0.996181;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,180:6:0 0,18,164:6:0 +X 3716 . T <*> 0 . DP=26;I16=19,7,0,0,927,33833,0,0,1445,82445,0,0,434,9236,0,0;QS=3,0;MQSB=0.966731;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,165:5:0 0,18,164:6:0 +X 3717 . C <*> 0 . DP=26;I16=19,7,0,0,979,37527,0,0,1445,82445,0,0,435,9261,0,0;QS=3,0;MQSB=0.966731;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,165:5:0 0,18,168:6:0 +X 3718 . T <*> 0 . DP=26;I16=19,7,0,0,994,39040,0,0,1445,82445,0,0,435,9265,0,0;QS=3,0;MQSB=0.966731;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,169:5:0 0,18,165:6:0 +X 3719 . A <*> 0 . DP=26;I16=19,6,0,0,889,32163,0,0,1408,81076,0,0,410,8672,0,0;QS=3,0;MQSB=0.747144;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,148:5:0 0,15,142:5:0 +X 3720 . C <*> 0 . DP=26;I16=19,7,0,0,934,34326,0,0,1445,82445,0,0,435,9357,0,0;QS=3,0;MQSB=0.966731;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,148:5:0 0,18,158:6:0 +X 3721 . A <*> 0 . DP=27;I16=20,5,0,0,910,33944,0,0,1405,80725,0,0,385,8195,0,0;QS=3,0;MQSB=0.697274;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,153:5:0 0,15,145:5:0 +X 3722 . C <*> 0 . DP=27;I16=20,7,0,0,964,35276,0,0,1502,85694,0,0,436,9562,0,0;QS=3,0;MQSB=0.927743;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,151:5:0 0,18,165:6:0 +X 3723 . A <*> 0 . DP=25;I16=18,6,0,0,888,33516,0,0,1345,77125,0,0,414,9082,0,0;QS=3,0;MQSB=0.606531;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,134:4:0 0,15,145:5:0 +X 3724 . C <*> 0 . DP=25;I16=18,7,0,0,944,35956,0,0,1382,78494,0,0,442,9878,0,0;QS=3,0;MQSB=0.889393;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,137:4:0 0,18,169:6:0 +X 3725 . T <*> 0 . DP=25;I16=18,7,0,0,973,38263,0,0,1382,78494,0,0,445,10075,0,0;QS=3,0;MQSB=0.889393;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,138:4:0 0,18,190:6:0 +X 3726 . G <*> 0 . DP=24;I16=18,6,0,0,865,32339,0,0,1322,74894,0,0,446,10146,0,0;QS=3,0;MQSB=0.934987;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,93:3:0 0,18,166:6:0 +X 3727 . C <*> 0 . DP=22;I16=17,5,0,0,762,27812,0,0,1202,67694,0,0,447,10139,0,0;QS=3,0;MQSB=0.963102;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,82:3:0 0,15,143:5:0 +X 3728 . C <*> 0 . DP=22;I16=17,5,0,0,792,29850,0,0,1202,67694,0,0,448,10154,0,0;QS=3,0;MQSB=0.963102;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,89:3:0 0,15,160:5:0 +X 3729 . C <*> 0 . DP=22;I16=17,5,0,0,838,32312,0,0,1202,67694,0,0,449,10191,0,0;QS=3,0;MQSB=0.963102;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,93:3:0 0,15,164:5:0 +X 3730 . A <*> 0 . DP=21;I16=17,4,0,0,749,27561,0,0,1142,64094,0,0,448,10100,0,0;QS=3,0;MQSB=0.995997;MQ0F=0 PL:DP:DV 0,39,241:13:0 0,9,98:3:0 0,15,159:5:0 +X 3731 . T <*> 0 . DP=22;I16=18,4,0,0,787,29489,0,0,1152,64194,0,0,447,10031,0,0;QS=3,0;MQSB=0.967917;MQ0F=0 PL:DP:DV 0,42,253:14:0 0,9,101:3:0 0,15,139:5:0 +X 3732 . G <*> 0 . DP=22;I16=18,4,0,0,811,30695,0,0,1152,64194,0,0,447,9985,0,0;QS=3,0;MQSB=0.967917;MQ0F=0 PL:DP:DV 0,42,252:14:0 0,9,101:3:0 0,15,149:5:0 +X 3733 . T <*> 0 . DP=23;I16=19,4,0,0,820,29616,0,0,1212,67794,0,0,447,9963,0,0;QS=3,0;MQSB=0.979651;MQ0F=0 PL:DP:DV 0,45,248:15:0 0,9,101:3:0 0,15,152:5:0 +X 3734 . C <*> 0 . DP=24;I16=20,4,0,0,863,32277,0,0,1272,71394,0,0,447,9915,0,0;QS=3,0;MQSB=0.988072;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,86:3:0 0,15,152:5:0 +X 3735 . C <*> 0 . DP=24;I16=20,4,0,0,826,30112,0,0,1272,71394,0,0,448,9892,0,0;QS=3,0;MQSB=0.988072;MQ0F=0 PL:DP:DV 0,48,254:16:0 0,9,83:3:0 0,15,152:5:0 +X 3736 . C <*> 0 . DP=25;I16=20,3,0,0,839,31471,0,0,1262,71294,0,0,419,9245,0,0;QS=3,0;MQSB=0.963194;MQ0F=0 PL:DP:DV 0,42,235:14:0 0,9,99:3:0 0,18,156:6:0 +X 3737 . C <*> 0 . DP=25;I16=21,4,0,0,894,33402,0,0,1332,74994,0,0,451,9925,0,0;QS=3,0;MQSB=0.993838;MQ0F=0 PL:DP:DV 0,48,251:16:0 0,9,95:3:0 0,18,175:6:0 +X 3738 . T <*> 0 . DP=25;I16=21,4,0,0,926,35484,0,0,1332,74994,0,0,452,9934,0,0;QS=3,0;MQSB=0.993838;MQ0F=0 PL:DP:DV 0,48,253:16:0 0,9,101:3:0 0,18,189:6:0 +X 3739 . C <*> 0 . DP=25;I16=21,4,0,0,958,37390,0,0,1332,74994,0,0,452,9922,0,0;QS=3,0;MQSB=0.993838;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,105:3:0 0,18,181:6:0 +X 3740 . A <*> 0 . DP=24;I16=20,4,0,0,848,31126,0,0,1272,71394,0,0,452,9886,0,0;QS=3,0;MQSB=0.988072;MQ0F=0 PL:DP:DV 0,48,247:16:0 0,9,109:3:0 0,15,163:5:0 +X 3741 . A <*> 0 . DP=24;I16=19,4,0,0,814,30176,0,0,1212,67794,0,0,442,9742,0,0;QS=3,0;MQSB=0.979651;MQ0F=0 PL:DP:DV 0,48,238:16:0 0,6,82:2:0 0,15,172:5:0 +X 3742 . G <*> 0 . DP=24;I16=20,4,0,0,893,34371,0,0,1272,71394,0,0,450,9782,0,0;QS=3,0;MQSB=0.988072;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,101:3:0 0,15,162:5:0 +X 3743 . C <*> 0 . DP=24;I16=19,4,0,0,839,31673,0,0,1262,71294,0,0,437,9619,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,254:15:0 0,9,103:3:0 0,15,158:5:0 +X 3744 . T <*> 0 . DP=24;I16=20,4,0,0,918,36126,0,0,1272,71394,0,0,448,9766,0,0;QS=3,0;MQSB=0.988072;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,118:3:0 0,15,164:5:0 +X 3745 . T <*> 0 . DP=24;I16=19,4,0,0,808,29490,0,0,1212,67794,0,0,422,9166,0,0;QS=3,0;MQSB=0.979651;MQ0F=0 PL:DP:DV 0,45,233:15:0 0,9,108:3:0 0,15,158:5:0 +X 3746 . C <*> 0 . DP=24;I16=20,4,0,0,886,33564,0,0,1272,71394,0,0,445,9789,0,0;QS=3,0;MQSB=0.988072;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,101:3:0 0,15,165:5:0 +X 3747 . C <*> 0 . DP=24;I16=19,4,0,0,833,31071,0,0,1262,71294,0,0,426,9504,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,249:15:0 0,9,103:3:0 0,15,162:5:0 +X 3748 . C <*> 0 . DP=24;I16=19,4,0,0,845,31753,0,0,1262,71294,0,0,422,9464,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,106:3:0 0,15,161:5:0 +X 3749 . C <*> 0 . DP=24;I16=19,4,0,0,844,31888,0,0,1262,71294,0,0,417,9395,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,250:15:0 0,9,111:3:0 0,15,154:5:0 +X 3750 . T <*> 0 . DP=25;I16=21,4,0,0,876,32880,0,0,1309,72763,0,0,431,9709,0,0;QS=3,0;MQSB=0.966906;MQ0F=0 PL:DP:DV 0,51,251:17:0 0,9,112:3:0 0,15,146:5:0 +X 3751 . G <*> 0 . DP=24;I16=19,4,0,0,836,31374,0,0,1239,69063,0,0,408,9274,0,0;QS=3,0;MQSB=0.986928;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,82:2:0 0,15,162:5:0 +X 3752 . G <*> 0 . DP=22;I16=19,2,0,0,728,26270,0,0,1069,58363,0,0,404,9134,0,0;QS=3,0;MQSB=0.868421;MQ0F=0 PL:DP:DV 0,42,182:14:0 0,6,74:2:0 0,15,159:5:0 +X 3753 . C <*> 0 . DP=22;I16=19,3,0,0,761,28017,0,0,1129,61963,0,0,426,9674,0,0;QS=3,0;MQSB=0.995434;MQ0F=0 PL:DP:DV 0,45,213:15:0 0,6,61:2:0 0,15,163:5:0 +X 3754 . T <*> 0 . DP=23;I16=19,3,0,0,767,28751,0,0,1129,61963,0,0,425,9707,0,0;QS=3,0;MQSB=0.995434;MQ0F=0 PL:DP:DV 0,45,218:15:0 0,6,69:2:0 0,15,157:5:0 +X 3755 . C <*> 0 . DP=21;I16=16,4,0,0,749,28747,0,0,1028,55504,0,0,404,9188,0,0;QS=3,0;MQSB=0.777932;MQ0F=0 PL:DP:DV 0,36,219:12:0 0,9,93:3:0 0,15,161:5:0 +X 3756 . C <*> 0 . DP=22;I16=17,4,0,0,782,29994,0,0,1038,55604,0,0,430,9840,0,0;QS=3,0;MQSB=0.885747;MQ0F=0 PL:DP:DV 0,39,229:13:0 0,9,93:3:0 0,15,159:5:0 +X 3757 . T <*> 0 . DP=23;I16=17,6,0,0,828,30942,0,0,1158,62804,0,0,456,10510,0,0;QS=3,0;MQSB=0.9945;MQ0F=0 PL:DP:DV 0,39,210:13:0 0,15,143:5:0 0,15,169:5:0 +X 3758 . G <*> 0 . DP=23;I16=17,6,0,0,832,30792,0,0,1158,62804,0,0,458,10574,0,0;QS=3,0;MQSB=0.9945;MQ0F=0 PL:DP:DV 0,39,220:13:0 0,15,135:5:0 0,15,147:5:0 +X 3759 . C <*> 0 . DP=23;I16=17,4,0,0,756,28338,0,0,1061,57835,0,0,409,9357,0,0;QS=3,0;MQSB=0.964547;MQ0F=0 PL:DP:DV 0,39,220:13:0 0,12,112:4:0 0,12,127:4:0 +X 3760 . A <*> 0 . DP=24;I16=17,7,0,0,792,27956,0,0,1218,66404,0,0,459,10607,0,0;QS=3,0;MQSB=0.95083;MQ0F=0 PL:DP:DV 0,39,203:13:0 0,15,127:5:0 0,18,180:6:0 +X 3761 . A <*> 0 . DP=24;I16=17,7,0,0,871,32185,0,0,1218,66404,0,0,460,10624,0,0;QS=3,0;MQSB=0.95083;MQ0F=0 PL:DP:DV 0,39,215:13:0 0,15,136:5:0 0,18,188:6:0 +X 3762 . C <*> 0 . DP=25;I16=17,7,0,0,831,29665,0,0,1241,68635,0,0,435,9983,0,0;QS=3,0;MQSB=0.69242;MQ0F=0 PL:DP:DV 0,39,209:13:0 0,18,149:6:0 0,15,159:5:0 +X 3763 . C <*> 0 . DP=24;I16=16,8,0,0,837,30619,0,0,1218,66404,0,0,460,10510,0,0;QS=3,0;MQSB=0.844324;MQ0F=0 PL:DP:DV 0,36,213:12:0 0,18,149:6:0 0,18,186:6:0 +X 3764 . A <*> 0 . DP=25;I16=17,7,0,0,856,31506,0,0,1241,68635,0,0,437,9903,0,0;QS=3,0;MQSB=0.69242;MQ0F=0 PL:DP:DV 0,39,212:13:0 0,18,139:6:0 0,15,167:5:0 +X 3765 . C <*> 0 . DP=25;I16=17,7,0,0,845,31099,0,0,1218,66404,0,0,436,9750,0,0;QS=3,0;MQSB=0.95083;MQ0F=0 PL:DP:DV 0,39,200:13:0 0,15,129:5:0 0,18,189:6:0 +X 3766 . A <*> 0 . DP=26;I16=17,9,0,0,953,35331,0,0,1338,73604,0,0,462,10340,0,0;QS=3,0;MQSB=0.811273;MQ0F=0 PL:DP:DV 0,42,248:14:0 0,18,158:6:0 0,18,191:6:0 +X 3767 . A <*> 0 . DP=26;I16=17,9,0,0,924,33656,0,0,1338,73604,0,0,464,10328,0,0;QS=3,0;MQSB=0.811273;MQ0F=0 PL:DP:DV 0,42,246:14:0 0,18,148:6:0 0,18,191:6:0 +X 3768 . A <*> 0 . DP=26;I16=17,9,0,0,922,33842,0,0,1338,73604,0,0,466,10340,0,0;QS=3,0;MQSB=0.811273;MQ0F=0 PL:DP:DV 0,42,237:14:0 0,18,146:6:0 0,18,195:6:0 +X 3769 . T <*> 0 . DP=26;I16=17,8,0,0,891,32735,0,0,1278,70004,0,0,461,10327,0,0;QS=3,0;MQSB=0.884621;MQ0F=0 PL:DP:DV 0,42,246:14:0 0,15,144:5:0 0,18,191:6:0 +X 3770 . C <*> 0 . DP=26;I16=17,9,0,0,923,34049,0,0,1338,73604,0,0,470,10436,0,0;QS=3,0;MQSB=0.811273;MQ0F=0 PL:DP:DV 0,42,252:14:0 0,18,142:6:0 0,18,180:6:0 +X 3771 . T <*> 0 . DP=25;I16=16,8,0,0,852,31694,0,0,1218,66404,0,0,464,10438,0,0;QS=3,0;MQSB=0.844324;MQ0F=0 PL:DP:DV 0,42,253:14:0 0,15,140:5:0 0,15,157:5:0 +X 3772 . A <*> 0 . DP=26;I16=16,10,0,0,836,28434,0,0,1338,73604,0,0,476,10624,0,0;QS=3,0;MQSB=0.685145;MQ0F=0 PL:DP:DV 0,42,236:14:0 0,18,122:6:0 0,18,160:6:0 +X 3773 . C <*> 0 . DP=26;I16=16,10,0,0,893,31801,0,0,1338,73604,0,0,480,10752,0,0;QS=3,0;MQSB=0.685145;MQ0F=0 PL:DP:DV 0,42,253:14:0 0,18,140:6:0 0,18,171:6:0 +X 3774 . T <*> 0 . DP=25;I16=15,10,0,0,895,33455,0,0,1278,70004,0,0,485,10903,0,0;QS=3,0;MQSB=0.624282;MQ0F=0 PL:DP:DV 0,42,253:14:0 0,18,129:6:0 0,15,178:5:0 +X 3775 . C <*> 0 . DP=25;I16=15,9,0,0,855,31825,0,0,1241,68635,0,0,477,10883,0,0;QS=3,0;MQSB=0.439649;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,147:6:0 0,12,143:4:0 +X 3776 . T <*> 0 . DP=24;I16=15,7,0,0,838,32738,0,0,1152,64194,0,0,457,10375,0,0;QS=3,0;MQSB=0.225079;MQ0F=0 PL:DP:DV 0,39,229:13:0 0,15,149:5:0 0,12,152:4:0 +X 3777 . C <*> 0 . DP=24;I16=15,9,0,0,864,32180,0,0,1218,66404,0,0,492,10998,0,0;QS=3,0;MQSB=0.705785;MQ0F=0 PL:DP:DV 0,39,220:13:0 0,18,160:6:0 0,15,168:5:0 +X 3778 . T <*> 0 . DP=24;I16=14,9,0,0,859,32957,0,0,1208,66304,0,0,468,10372,0,0;QS=3,0;MQSB=0.836049;MQ0F=0 PL:DP:DV 0,36,227:12:0 0,18,157:6:0 0,15,167:5:0 +X 3779 . G <*> 0 . DP=24;I16=15,9,0,0,844,31206,0,0,1218,66404,0,0,493,10971,0,0;QS=3,0;MQSB=0.705785;MQ0F=0 PL:DP:DV 0,39,220:13:0 0,18,152:6:0 0,15,167:5:0 +X 3780 . C <*> 0 . DP=25;I16=14,10,0,0,829,29949,0,0,1268,69904,0,0,467,10295,0,0;QS=3,0;MQSB=0.765017;MQ0F=0 PL:DP:DV 0,39,235:13:0 0,18,144:6:0 0,15,169:5:0 +X 3781 . C <*> 0 . DP=26;I16=16,10,0,0,939,34725,0,0,1315,71373,0,0,492,10896,0,0;QS=3,0;MQSB=0.541994;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,139:6:0 0,15,175:5:0 +X 3782 . T <*> 0 . DP=26;I16=16,10,0,0,989,38031,0,0,1315,71373,0,0,493,10901,0,0;QS=3,0;MQSB=0.541994;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,169:6:0 0,15,176:5:0 +X 3783 . C <*> 0 . DP=26;I16=16,10,0,0,941,34801,0,0,1315,71373,0,0,492,10836,0,0;QS=3,0;MQSB=0.541994;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,155:6:0 0,15,162:5:0 +X 3784 . T <*> 0 . DP=27;I16=16,11,0,0,1001,38035,0,0,1375,74973,0,0,491,10801,0,0;QS=3,0;MQSB=0.467219;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,155:6:0 0,15,178:5:0 +X 3785 . G <*> 0 . DP=28;I16=15,10,0,0,922,36426,0,0,1305,71273,0,0,450,9916,0,0;QS=3,0;MQSB=0.674458;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,125:5:0 0,15,179:5:0 +X 3786 . T <*> 0 . DP=28;I16=16,11,0,0,935,35697,0,0,1375,74973,0,0,490,10774,0,0;QS=3,0;MQSB=0.467219;MQ0F=0 PL:DP:DV 0,48,250:16:0 0,18,145:6:0 0,15,186:5:0 +X 3787 . G <*> 0 . DP=28;I16=16,11,0,0,963,37951,0,0,1375,74973,0,0,489,10781,0,0;QS=3,0;MQSB=0.467219;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,143:6:0 0,15,177:5:0 +X 3788 . G <*> 0 . DP=26;I16=14,9,0,0,849,33683,0,0,1184,65386,0,0,459,10075,0,0;QS=3,0;MQSB=0.525788;MQ0F=0 PL:DP:DV 0,39,239:13:0 0,18,144:6:0 0,12,161:4:0 +X 3789 . G <*> 0 . DP=26;I16=13,10,0,0,807,31019,0,0,1231,68535,0,0,438,9474,0,0;QS=3,0;MQSB=0.445672;MQ0F=0 PL:DP:DV 0,39,251:13:0 0,18,133:6:0 0,12,161:4:0 +X 3790 . T <*> 0 . DP=26;I16=13,10,0,0,829,32293,0,0,1231,68535,0,0,435,9359,0,0;QS=3,0;MQSB=0.445672;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,150:6:0 0,12,159:4:0 +X 3791 . T <*> 0 . DP=26;I16=15,10,0,0,887,34725,0,0,1301,72235,0,0,478,10336,0,0;QS=3,0;MQSB=0.382304;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,136:6:0 0,12,159:4:0 +X 3792 . G A,<*> 0 . DP=26;I16=14,8,1,0,809,32805,38,1444,1175,66425,37,1369,417,8991,22,484;QS=2.92629,0.0737052,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.195278;BQB=1;MQ0F=0 PL:DP:DV 0,8,238,42,241,255:15:1 0,12,109,12,109,109:4:0 0,12,157,12,157,157:4:0 +X 3793 . A <*> 0 . DP=26;I16=15,8,0,0,833,33775,0,0,1212,67794,0,0,435,9363,0,0;QS=3,0;MQSB=0.195278;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,93:4:0 0,12,159:4:0 +X 3794 . C <*> 0 . DP=26;I16=15,9,0,0,845,33023,0,0,1241,68635,0,0,438,9324,0,0;QS=3,0;MQSB=0.439649;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,120:5:0 0,12,157:4:0 +X 3795 . C <*> 0 . DP=26;I16=14,9,0,0,865,35649,0,0,1231,68535,0,0,408,8622,0,0;QS=3,0;MQSB=0.563599;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,132:5:0 0,12,161:4:0 +X 3796 . T <*> 0 . DP=27;I16=15,11,0,0,964,38998,0,0,1361,75835,0,0,453,9821,0,0;QS=3,0;MQSB=0.334895;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,149:7:0 0,12,164:4:0 +X 3797 . A <*> 0 . DP=27;I16=15,10,0,0,848,32392,0,0,1301,72235,0,0,424,9172,0,0;QS=3,0;MQSB=0.382304;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,124:6:0 0,12,159:4:0 +X 3798 . T <*> 0 . DP=27;I16=14,11,0,0,921,37161,0,0,1301,72235,0,0,430,9554,0,0;QS=3,0;MQSB=0.283586;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,21,148:7:0 0,12,165:4:0 +X 3799 . T <*> 0 . DP=27;I16=15,11,0,0,913,35929,0,0,1361,75835,0,0,439,9729,0,0;QS=3,0;MQSB=0.334895;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,150:7:0 0,12,161:4:0 +X 3800 . C <*> 0 . DP=26;I16=13,10,0,0,866,36182,0,0,1181,65035,0,0,406,9092,0,0;QS=3,0;MQSB=0.272532;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,104:5:0 0,12,161:4:0 +X 3801 . T <*> 0 . DP=23;I16=12,10,0,0,804,33600,0,0,1121,61435,0,0,430,9750,0,0;QS=3,0;MQSB=0.217267;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,99:5:0 0,9,133:3:0 +X 3802 . G <*> 0 . DP=22;I16=10,9,0,0,730,30516,0,0,994,54486,0,0,380,8550,0,0;QS=3,0;MQSB=0.472367;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,106:4:0 0,9,130:3:0 +X 3803 . G <*> 0 . DP=22;I16=11,9,0,0,703,27393,0,0,1051,57735,0,0,405,9241,0,0;QS=3,0;MQSB=0.372419;MQ0F=0 PL:DP:DV 0,39,249:13:0 0,12,92:4:0 0,9,129:3:0 +X 3804 . A <*> 0 . DP=22;I16=11,9,0,0,740,30360,0,0,1051,57735,0,0,404,9274,0,0;QS=3,0;MQSB=0.372419;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,98:4:0 0,9,132:3:0 +X 3805 . C <*> 0 . DP=22;I16=12,9,0,0,737,29243,0,0,1061,57835,0,0,428,9950,0,0;QS=3,0;MQSB=0.262932;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,81:4:0 0,9,130:3:0 +X 3806 . A <*> 0 . DP=22;I16=12,9,0,0,798,32550,0,0,1061,57835,0,0,426,9968,0,0;QS=3,0;MQSB=0.262932;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,105:4:0 0,9,128:3:0 +X 3807 . C <*> 0 . DP=22;I16=10,9,0,0,664,25304,0,0,994,54486,0,0,377,8885,0,0;QS=3,0;MQSB=0.472367;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,83:4:0 0,9,115:3:0 +X 3808 . G <*> 0 . DP=21;I16=9,9,0,0,653,25297,0,0,957,53117,0,0,375,8873,0,0;QS=3,0;MQSB=0.597145;MQ0F=0 PL:DP:DV 0,33,233:11:0 0,12,109:4:0 0,9,132:3:0 +X 3809 . T <*> 0 . DP=22;I16=11,10,0,0,779,32151,0,0,1084,60066,0,0,416,9810,0,0;QS=3,0;MQSB=0.285029;MQ0F=0 PL:DP:DV 0,39,249:13:0 0,12,115:4:0 0,12,161:4:0 +X 3810 . C <*> 0 . DP=23;I16=9,11,0,0,811,34815,0,0,1077,60317,0,0,369,8739,0,0;QS=3,0;MQSB=0.499893;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,112:4:0 0,12,153:4:0 +X 3811 . A C,<*> 0 . DP=23;I16=9,11,2,0,777,32631,39,785,1077,60317,67,3349,367,8669,42,914;QS=2.94104,0.0589569,0;VDB=0.18;SGB=0.346553;RPB=0.425;MQB=0.25;MQSB=0.246128;BQB=0.025;MQ0F=0 PL:DP:DV 0,15,248,36,254,255:14:2 0,12,116,12,116,116:4:0 0,12,158,12,158,158:4:0 +X 3812 . T <*> 0 . DP=23;I16=10,11,0,0,802,32860,0,0,1084,60066,0,0,405,9447,0,0;QS=3,0;MQSB=0.187115;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,114:4:0 0,12,160:4:0 +X 3813 . A <*> 0 . DP=22;I16=10,11,0,0,815,35077,0,0,1084,60066,0,0,402,9330,0,0;QS=3,0;MQSB=0.187115;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,119:4:0 0,12,170:4:0 +X 3814 . G <*> 0 . DP=21;I16=8,11,0,0,775,33731,0,0,1037,58597,0,0,375,8605,0,0;QS=3,0;MQSB=0.41781;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,113:4:0 0,12,163:4:0 +X 3815 . A <*> 0 . DP=20;I16=8,11,0,0,708,29130,0,0,1010,57328,0,0,397,9049,0,0;QS=3,0;MQSB=0.373354;MQ0F=0 PL:DP:DV 0,33,239:11:0 0,12,110:4:0 0,12,162:4:0 +X 3816 . A <*> 0 . DP=20;I16=8,11,0,0,729,31027,0,0,1010,57328,0,0,395,8933,0,0;QS=3,0;MQSB=0.373354;MQ0F=0 PL:DP:DV 0,33,248:11:0 0,12,104:4:0 0,12,160:4:0 +X 3817 . A <*> 0 . DP=20;I16=8,11,0,0,752,31580,0,0,1010,57328,0,0,393,8833,0,0;QS=3,0;MQSB=0.373354;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,110:4:0 0,12,161:4:0 +X 3818 . T <*> 0 . DP=20;I16=8,11,0,0,728,30466,0,0,1010,57328,0,0,391,8749,0,0;QS=3,0;MQSB=0.373354;MQ0F=0 PL:DP:DV 0,33,252:11:0 0,12,115:4:0 0,12,160:4:0 +X 3819 . A <*> 0 . DP=21;I16=9,11,0,0,790,34094,0,0,1039,58169,0,0,389,8681,0,0;QS=3,0;MQSB=0.247381;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,121:4:0 0,12,167:4:0 +X 3820 . G <*> 0 . DP=21;I16=9,11,0,0,788,33636,0,0,1039,58169,0,0,388,8630,0,0;QS=3,0;MQSB=0.247381;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,112:4:0 0,12,157:4:0 +X 3821 . A <*> 0 . DP=22;I16=10,11,0,0,832,35864,0,0,1099,61769,0,0,387,8597,0,0;QS=3,0;MQSB=0.317882;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,115:4:0 0,12,168:4:0 +X 3822 . G <*> 0 . DP=22;I16=10,11,0,0,810,33228,0,0,1099,61769,0,0,386,8532,0,0;QS=3,0;MQSB=0.317882;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,103:4:0 0,12,157:4:0 +X 3823 . T <*> 0 . DP=22;I16=9,11,0,0,753,30705,0,0,1042,58520,0,0,380,8460,0,0;QS=3,0;MQSB=0.434285;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,102:4:0 0,12,163:4:0 +X 3824 . C <*> 0 . DP=22;I16=10,11,0,0,802,32368,0,0,1099,61769,0,0,384,8456,0,0;QS=3,0;MQSB=0.317882;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,105:4:0 0,12,159:4:0 +X 3825 . C <*> 0 . DP=23;I16=10,11,0,0,813,33955,0,0,1079,59889,0,0,379,8387,0,0;QS=3,0;MQSB=0.317882;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,130:5:0 0,12,157:4:0 +X 3826 . T <*> 0 . DP=23;I16=11,11,0,0,827,34611,0,0,1136,63138,0,0,381,8357,0,0;QS=3,0;MQSB=0.232836;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,133:5:0 0,12,155:4:0 +X 3827 . G <*> 0 . DP=23;I16=11,10,0,0,820,34130,0,0,1076,59538,0,0,355,7715,0,0;QS=3,0;MQSB=0.269397;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,121:4:0 0,12,162:4:0 +X 3828 . C <*> 0 . DP=23;I16=11,10,0,0,805,33147,0,0,1076,59538,0,0,354,7720,0,0;QS=3,0;MQSB=0.269397;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,114:4:0 0,12,157:4:0 +X 3829 . A <*> 0 . DP=22;I16=9,11,0,0,763,31295,0,0,1069,59789,0,0,369,8241,0,0;QS=3,0;MQSB=0.477679;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,132:5:0 0,12,158:4:0 +X 3830 . A <*> 0 . DP=23;I16=11,11,0,0,825,32693,0,0,1136,63138,0,0,377,8321,0,0;QS=3,0;MQSB=0.232836;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,143:5:0 0,12,150:4:0 +X 3831 . C A,<*> 0 . DP=23;I16=10,11,1,0,802,32198,14,196,1126,63038,10,100,370,8294,7,49;QS=2.97758,0.0224215,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.232836;BQB=1;MQ0F=0 PL:DP:DV 0,27,255,36,255,255:13:1 0,15,134,15,134,134:5:0 0,12,149,12,149,149:4:0 +X 3832 . A <*> 0 . DP=24;I16=12,11,0,0,836,32436,0,0,1196,66738,0,0,377,8389,0,0;QS=3,0;MQSB=0.291845;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,136:5:0 0,12,139:4:0 +X 3833 . C <*> 0 . DP=23;I16=10,11,0,0,690,24938,0,0,1076,59538,0,0,377,8409,0,0;QS=3,0;MQSB=0.175325;MQ0F=0 PL:DP:DV 0,36,249:12:0 0,15,113:5:0 0,12,131:4:0 +X 3834 . G <*> 0 . DP=22;I16=9,10,0,0,684,26250,0,0,1037,58597,0,0,357,8079,0,0;QS=3,0;MQSB=0.124514;MQ0F=0 PL:DP:DV 0,33,242:11:0 0,12,122:4:0 0,12,156:4:0 +X 3835 . T <*> 0 . DP=22;I16=10,11,0,0,773,30373,0,0,1076,59538,0,0,381,8475,0,0;QS=3,0;MQSB=0.175325;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,140:5:0 0,12,153:4:0 +X 3836 . G C,<*> 0 . DP=24;I16=10,12,1,0,833,33183,14,196,1132,61648,10,100,378,8412,2,4;QS=2.97647,0.0235294,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.251407;BQB=1;MQ0F=0 PL:DP:DV 0,27,255,36,255,255:13:1 0,15,149,15,149,149:5:0 0,15,188,15,188,188:5:0 +X 3837 . G <*> 0 . DP=24;I16=8,14,0,0,759,26931,0,0,1135,61999,0,0,399,8955,0,0;QS=3,0;MQSB=0.291667;MQ0F=0 PL:DP:DV 0,33,245:11:0 0,18,149:6:0 0,15,157:5:0 +X 3838 . C <*> 0 . DP=24;I16=10,14,0,0,817,28975,0,0,1202,65348,0,0,409,8945,0,0;QS=3,0;MQSB=0.122456;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,143:6:0 0,15,148:5:0 +X 3839 . C <*> 0 . DP=23;I16=9,13,0,0,688,22248,0,0,1132,61648,0,0,386,8238,0,0;QS=3,0;MQSB=0.248197;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,123:6:0 0,12,112:4:0 +X 3840 . G <*> 0 . DP=23;I16=9,14,0,0,793,27941,0,0,1192,65248,0,0,413,8809,0,0;QS=3,0;MQSB=0.211072;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,160:6:0 0,15,146:5:0 +X 3841 . T <*> 0 . DP=23;I16=9,14,0,0,867,33103,0,0,1192,65248,0,0,414,8734,0,0;QS=3,0;MQSB=0.211072;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,167:6:0 0,15,162:5:0 +X 3842 . C <*> 0 . DP=23;I16=9,14,0,0,890,34728,0,0,1192,65248,0,0,415,8689,0,0;QS=3,0;MQSB=0.211072;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,167:6:0 0,15,159:5:0 +X 3843 . T <*> 0 . DP=24;I16=9,14,0,0,896,35122,0,0,1192,65248,0,0,416,8674,0,0;QS=3,0;MQSB=0.211072;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,164:6:0 0,15,159:5:0 +X 3844 . G <*> 0 . DP=26;I16=10,16,0,0,959,35715,0,0,1372,76048,0,0,442,9314,0,0;QS=3,0;MQSB=0.220358;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,177:7:0 0,18,172:6:0 +X 3845 . T <*> 0 . DP=26;I16=10,16,0,0,970,36442,0,0,1372,76048,0,0,444,9310,0,0;QS=3,0;MQSB=0.220358;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,186:7:0 0,18,166:6:0 +X 3846 . G <*> 0 . DP=27;I16=10,17,0,0,993,37297,0,0,1432,79648,0,0,446,9338,0,0;QS=3,0;MQSB=0.195223;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,175:7:0 0,21,172:7:0 +X 3847 . T <*> 0 . DP=27;I16=10,16,0,0,952,35268,0,0,1372,76048,0,0,423,8723,0,0;QS=3,0;MQSB=0.220358;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,170:6:0 0,21,189:7:0 +X 3848 . C <*> 0 . DP=27;I16=10,17,0,0,1025,39533,0,0,1432,79648,0,0,449,9341,0,0;QS=3,0;MQSB=0.195223;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,177:7:0 0,21,188:7:0 +X 3849 . T <*> 0 . DP=27;I16=9,17,0,0,987,37685,0,0,1395,78279,0,0,450,9368,0,0;QS=3,0;MQSB=0.282527;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,179:7:0 0,21,190:7:0 +X 3850 . G <*> 0 . DP=26;I16=9,17,0,0,957,35751,0,0,1395,78279,0,0,452,9428,0,0;QS=3,0;MQSB=0.282527;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,179:7:0 0,21,182:7:0 +X 3851 . G <*> 0 . DP=26;I16=9,17,0,0,965,36475,0,0,1395,78279,0,0,453,9469,0,0;QS=3,0;MQSB=0.282527;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,177:7:0 0,21,183:7:0 +X 3852 . C <*> 0 . DP=26;I16=9,16,0,0,921,34525,0,0,1335,74679,0,0,444,9440,0,0;QS=3,0;MQSB=0.310905;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,163:6:0 0,21,179:7:0 +X 3853 . T <*> 0 . DP=28;I16=10,18,0,0,1050,40222,0,0,1484,82720,0,0,455,9641,0,0;QS=3,0;MQSB=0.515783;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,21,185:7:0 0,21,192:7:0 +X 3854 . T <*> 0 . DP=28;I16=10,17,0,0,955,34605,0,0,1455,81879,0,0,451,9709,0,0;QS=3,0;MQSB=0.359211;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,171:6:0 0,18,178:6:0 +X 3855 . C <*> 0 . DP=29;I16=10,18,0,0,992,36040,0,0,1515,85479,0,0,438,9264,0,0;QS=3,0;MQSB=0.331344;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,139:5:0 0,21,175:7:0 +X 3856 . T <*> 0 . DP=30;I16=10,18,0,0,1033,38725,0,0,1546,88238,0,0,464,9982,0,0;QS=3,0;MQSB=0.190183;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,163:6:0 0,21,185:7:0 +X 3857 . C <*> 0 . DP=30;I16=10,19,0,0,1077,40979,0,0,1575,89079,0,0,447,9505,0,0;QS=3,0;MQSB=0.306875;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,154:5:0 0,24,194:8:0 +X 3858 . T <*> 0 . DP=31;I16=10,21,0,0,1141,42567,0,0,1695,96279,0,0,477,10255,0,0;QS=3,0;MQSB=0.266219;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,171:6:0 0,24,208:8:0 +X 3859 . C <*> 0 . DP=32;I16=10,21,0,0,950,30078,0,0,1695,96279,0,0,484,10416,0,0;QS=3,0;MQSB=0.266219;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,136:6:0 0,24,156:8:0 +X 3860 . G <*> 0 . DP=32;I16=10,22,0,0,1070,37794,0,0,1755,99879,0,0,516,11240,0,0;QS=3,0;MQSB=0.249261;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,154:6:0 0,27,209:9:0 +X 3861 . C <*> 0 . DP=33;I16=11,20,0,0,1133,42547,0,0,1672,94048,0,0,517,11391,0,0;QS=3,0;MQSB=0.19205;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,162:6:0 0,24,199:8:0 +X 3862 . T <*> 0 . DP=34;I16=11,22,0,0,1241,47443,0,0,1792,101248,0,0,526,11518,0,0;QS=3,0;MQSB=0.161533;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,185:7:0 0,27,221:9:0 +X 3863 . T <*> 0 . DP=34;I16=12,22,0,0,1200,43542,0,0,1852,104848,0,0,541,11685,0,0;QS=3,0;MQSB=0.210327;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,199:7:0 0,27,213:9:0 +X 3864 . A <*> 0 . DP=33;I16=11,22,0,0,1238,47448,0,0,1792,101248,0,0,550,11790,0,0;QS=3,0;MQSB=0.161533;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,210:7:0 0,27,230:9:0 +X 3865 . G <*> 0 . DP=34;I16=11,23,0,0,1251,47113,0,0,1852,104848,0,0,559,11933,0,0;QS=3,0;MQSB=0.149071;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,200:7:0 0,27,212:9:0 +X 3866 . C <*> 0 . DP=33;I16=11,21,0,0,1165,43545,0,0,1732,97648,0,0,545,11489,0,0;QS=3,0;MQSB=0.175751;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,189:7:0 0,24,197:8:0 +X 3867 . A <*> 0 . DP=33;I16=11,22,0,0,1152,41510,0,0,1792,101248,0,0,580,12284,0,0;QS=3,0;MQSB=0.161533;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,188:7:0 0,27,195:9:0 +X 3868 . T <*> 0 . DP=33;I16=11,22,0,0,1255,48141,0,0,1792,101248,0,0,590,12494,0,0;QS=3,0;MQSB=0.161533;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,202:7:0 0,27,221:9:0 +X 3869 . C <*> 0 . DP=33;I16=11,21,0,0,1169,43987,0,0,1732,97648,0,0,589,12623,0,0;QS=3,0;MQSB=0.175751;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,164:6:0 0,27,211:9:0 +X 3870 . T <*> 0 . DP=34;I16=11,23,0,0,1262,47808,0,0,1852,104848,0,0,608,12932,0,0;QS=3,0;MQSB=0.149071;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,215:8:0 0,27,211:9:0 +X 3871 . T <*> 0 . DP=36;I16=11,25,0,0,1341,50655,0,0,1972,112048,0,0,617,13157,0,0;QS=3,0;MQSB=0.128391;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,24,221:8:0 0,27,223:9:0 +X 3872 . G <*> 0 . DP=36;I16=11,25,0,0,1287,47095,0,0,1972,112048,0,0,626,13322,0,0;QS=3,0;MQSB=0.128391;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,24,211:8:0 0,27,200:9:0 +X 3873 . T <*> 0 . DP=35;I16=10,24,0,0,1242,46680,0,0,1852,104848,0,0,626,13428,0,0;QS=3,0;MQSB=0.0982034;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,194:7:0 0,24,212:8:0 +X 3874 . T <*> 0 . DP=36;I16=12,24,0,0,1290,47660,0,0,1972,112048,0,0,646,13774,0,0;QS=3,0;MQSB=0.182088;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,24,228:8:0 0,24,204:8:0 +X 3875 . T <*> 0 . DP=37;I16=13,24,0,0,1324,48418,0,0,2029,115297,0,0,657,14061,0,0;QS=3,0;MQSB=0.117872;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,24,231:8:0 0,24,197:8:0 +X 3876 . C <*> 0 . DP=37;I16=13,22,0,0,1248,45354,0,0,1909,108097,0,0,623,13325,0,0;QS=3,0;MQSB=0.140806;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,21,196:7:0 0,24,180:8:0 +X 3877 . C <*> 0 . DP=37;I16=13,24,0,0,1363,51201,0,0,2029,115297,0,0,681,14765,0,0;QS=3,0;MQSB=0.117872;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,24,217:8:0 0,24,196:8:0 +X 3878 . A <*> 0 . DP=37;I16=13,23,0,0,1309,48045,0,0,1969,111697,0,0,670,14654,0,0;QS=3,0;MQSB=0.128568;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,24,218:8:0 0,24,188:8:0 +X 3879 . A <*> 0 . DP=38;I16=14,24,0,0,1453,56567,0,0,2066,116666,0,0,703,15543,0,0;QS=3,0;MQSB=0.076112;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,24,226:8:0 0,24,206:8:0 +X 3880 . G <*> 0 . DP=37;I16=14,22,0,0,1311,48735,0,0,1946,109466,0,0,689,15267,0,0;QS=3,0;MQSB=0.094094;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,24,209:8:0 0,24,183:8:0 +X 3881 . G <*> 0 . DP=37;I16=14,21,0,0,1200,42778,0,0,1886,105866,0,0,690,15578,0,0;QS=3,0;MQSB=0.105399;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,18,178:6:0 0,24,174:8:0 +X 3882 . T <*> 0 . DP=37;I16=14,21,0,0,1192,42352,0,0,1886,105866,0,0,684,15348,0,0;QS=3,0;MQSB=0.105399;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,21,189:7:0 0,21,178:7:0 +X 3883 . C <*> 0 . DP=38;I16=15,22,0,0,1295,46659,0,0,2006,113066,0,0,717,16279,0,0;QS=3,0;MQSB=0.124405;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,24,205:8:0 0,24,171:8:0 +X 3884 . C <*> 0 . DP=39;I16=16,23,0,0,1363,49387,0,0,2103,118035,0,0,749,17141,0,0;QS=3,0;MQSB=0.0760633;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,24,202:8:0 0,27,212:9:0 +X 3885 . T <*> 0 . DP=40;I16=16,24,0,0,1445,53663,0,0,2163,121635,0,0,754,17262,0,0;QS=3,0;MQSB=0.0679472;MQ0F=0 PL:DP:DV 0,69,255:23:0 0,24,219:8:0 0,27,214:9:0 +X 3886 . C <*> 0 . DP=39;I16=16,23,0,0,1370,49762,0,0,2103,118035,0,0,761,17421,0,0;QS=3,0;MQSB=0.0760633;MQ0F=0 PL:DP:DV 0,69,255:23:0 0,24,199:8:0 0,24,191:8:0 +X 3887 . C <*> 0 . DP=39;I16=16,23,0,0,1364,49222,0,0,2103,118035,0,0,767,17567,0,0;QS=3,0;MQSB=0.0760633;MQ0F=0 PL:DP:DV 0,69,255:23:0 0,24,194:8:0 0,24,201:8:0 +X 3888 . C <*> 0 . DP=39;I16=15,23,0,0,1387,51885,0,0,2043,114435,0,0,747,17073,0,0;QS=3,0;MQSB=0.0555905;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,24,195:8:0 0,24,208:8:0 +X 3889 . A <*> 0 . DP=38;I16=15,23,0,0,1364,49918,0,0,2066,116666,0,0,777,17811,0,0;QS=3,0;MQSB=0.112471;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,24,202:8:0 0,24,218:8:0 +X 3890 . C <*> 0 . DP=38;I16=14,23,0,0,1362,51064,0,0,2006,113066,0,0,757,17329,0,0;QS=3,0;MQSB=0.0844255;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,24,203:8:0 0,24,216:8:0 +X 3891 . A <*> 0 . DP=39;I16=15,24,0,0,1466,56312,0,0,2126,120266,0,0,786,18076,0,0;QS=3,0;MQSB=0.102114;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,24,203:8:0 0,27,239:9:0 +X 3892 . G <*> 0 . DP=38;I16=15,23,0,0,1340,48838,0,0,2066,116666,0,0,792,18226,0,0;QS=3,0;MQSB=0.112471;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,24,186:8:0 0,27,208:9:0 +X 3893 . T <*> 0 . DP=39;I16=15,24,0,0,1348,48170,0,0,2126,120266,0,0,798,18404,0,0;QS=3,0;MQSB=0.102114;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,24,196:8:0 0,27,212:9:0 +X 3894 . G <*> 0 . DP=39;I16=15,23,0,0,1364,49900,0,0,2066,116666,0,0,779,17937,0,0;QS=3,0;MQSB=0.112471;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,24,202:8:0 0,27,208:9:0 +X 3895 . T <*> 0 . DP=39;I16=15,24,0,0,1375,49773,0,0,2126,120266,0,0,810,18752,0,0;QS=3,0;MQSB=0.102114;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,24,202:8:0 0,27,225:9:0 +X 3896 . A <*> 0 . DP=40;I16=15,24,0,0,1468,57326,0,0,2126,120266,0,0,815,18923,0,0;QS=3,0;MQSB=0.102114;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,24,224:8:0 0,27,233:9:0 +X 3897 . G <*> 0 . DP=40;I16=15,24,0,0,1468,56812,0,0,2126,120266,0,0,819,19021,0,0;QS=3,0;MQSB=0.102114;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,21,199:7:0 0,30,234:10:0 +X 3898 . C <*> 0 . DP=40;I16=15,23,0,0,1487,59351,0,0,2066,116666,0,0,813,19023,0,0;QS=3,0;MQSB=0.112471;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,18,186:6:0 0,30,238:10:0 +X 3899 . A <*> 0 . DP=40;I16=15,24,0,0,1449,55055,0,0,2126,120266,0,0,829,19293,0,0;QS=3,0;MQSB=0.102114;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,21,191:7:0 0,30,231:10:0 +X 3900 . T <*> 0 . DP=40;I16=15,24,0,0,1458,55516,0,0,2126,120266,0,0,833,19417,0,0;QS=3,0;MQSB=0.102114;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,21,197:7:0 0,30,240:10:0 +X 3901 . G <*> 0 . DP=40;I16=14,22,0,0,1303,48245,0,0,1969,111697,0,0,761,17639,0,0;QS=3,0;MQSB=0.180757;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,18,154:6:0 0,27,218:9:0 +X 3902 . C <*> 0 . DP=40;I16=15,24,0,0,1436,55412,0,0,2126,120266,0,0,837,19537,0,0;QS=3,0;MQSB=0.102114;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,21,166:7:0 0,30,217:10:0 +X 3903 . A <*> 0 . DP=42;I16=15,24,0,0,1299,45567,0,0,2089,117417,0,0,814,19008,0,0;QS=3,0;MQSB=0.0901152;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,24,175:8:0 0,30,204:10:0 +X 3904 . C <*> 0 . DP=42;I16=15,24,0,0,1439,54545,0,0,2086,117066,0,0,815,19113,0,0;QS=3,0;MQSB=0.0426917;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,24,191:8:0 0,30,244:10:0 +X 3905 . C <*> 0 . DP=42;I16=15,25,0,0,1572,63314,0,0,2146,120666,0,0,822,19192,0,0;QS=3,0;MQSB=0.0381122;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,24,212:8:0 0,33,255:11:0 +X 3906 . T <*> 0 . DP=42;I16=16,25,0,0,1593,63039,0,0,2206,124266,0,0,846,19758,0,0;QS=3,0;MQSB=0.0536599;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,24,210:8:0 0,33,253:11:0 +X 3907 . G <*> 0 . DP=42;I16=16,25,0,0,1558,60192,0,0,2206,124266,0,0,846,19776,0,0;QS=3,0;MQSB=0.0536599;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,24,203:8:0 0,33,249:11:0 +X 3908 . C <*> 0 . DP=42;I16=16,25,0,0,1514,58968,0,0,2206,124266,0,0,845,19777,0,0;QS=3,0;MQSB=0.0536599;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,24,193:8:0 0,33,244:11:0 +X 3909 . T <*> 0 . DP=43;I16=16,25,0,0,1491,55895,0,0,2201,123691,0,0,835,19697,0,0;QS=3,0;MQSB=0.0757469;MQ0F=0 PL:DP:DV 0,69,255:23:0 0,24,202:8:0 0,30,237:10:0 +X 3910 . A <*> 0 . DP=40;I16=16,23,0,0,1432,53926,0,0,2081,116491,0,0,844,19724,0,0;QS=3,0;MQSB=0.0949554;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,21,193:7:0 0,30,224:10:0 +X 3911 . C <*> 0 . DP=40;I16=16,23,0,0,1440,55290,0,0,2081,116491,0,0,843,19613,0,0;QS=3,0;MQSB=0.0949554;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,21,184:7:0 0,30,214:10:0 +X 3912 . A C,<*> 0 . DP=41;I16=17,22,0,1,1358,49508,16,256,2081,116491,60,3600,830,19358,11,121;QS=2.95181,0.0481928,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.125266;BQB=1;MQ0F=0 PL:DP:DV 0,69,255,69,255,255:23:0 0,21,166,21,166,166:7:0 0,14,202,27,205,208:10:1 +X 3913 . C <*> 0 . DP=40;I16=16,23,0,0,1494,59096,0,0,2081,116491,0,0,824,19100,0,0;QS=3,0;MQSB=0.0949554;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,21,183:7:0 0,30,234:10:0 +X 3914 . T <*> 0 . DP=42;I16=16,24,0,0,1512,59342,0,0,2141,120091,0,0,823,19007,0,0;QS=3,0;MQSB=0.0846181;MQ0F=0 PL:DP:DV 0,69,255:23:0 0,21,192:7:0 0,30,228:10:0 +X 3915 . C <*> 0 . DP=42;I16=16,24,0,0,1537,60953,0,0,2141,120091,0,0,799,18321,0,0;QS=3,0;MQSB=0.0846181;MQ0F=0 PL:DP:DV 0,72,255:24:0 0,18,176:6:0 0,30,229:10:0 +X 3916 . C <*> 0 . DP=42;I16=16,25,0,0,1618,66342,0,0,2201,123691,0,0,825,18919,0,0;QS=3,0;MQSB=0.0757469;MQ0F=0 PL:DP:DV 0,72,255:24:0 0,21,190:7:0 0,30,251:10:0 +X 3917 . T <*> 0 . DP=43;I16=16,25,0,0,1601,65219,0,0,2201,123691,0,0,825,18875,0,0;QS=3,0;MQSB=0.0757469;MQ0F=0 PL:DP:DV 0,72,255:24:0 0,21,191:7:0 0,30,254:10:0 +X 3918 . T <*> 0 . DP=43;I16=16,25,0,0,1541,60711,0,0,2201,123691,0,0,801,18239,0,0;QS=3,0;MQSB=0.0757469;MQ0F=0 PL:DP:DV 0,75,255:25:0 0,18,179:6:0 0,30,254:10:0 +X 3919 . C <*> 0 . DP=42;I16=15,26,0,0,1621,66337,0,0,2232,126450,0,0,826,18786,0,0;QS=3,0;MQSB=0.110793;MQ0F=0 PL:DP:DV 0,72,255:24:0 0,21,200:7:0 0,30,242:10:0 +X 3920 . T <*> 0 . DP=42;I16=15,26,0,0,1605,64327,0,0,2232,126450,0,0,825,18691,0,0;QS=3,0;MQSB=0.110793;MQ0F=0 PL:DP:DV 0,72,255:24:0 0,21,207:7:0 0,30,251:10:0 +X 3921 . T <*> 0 . DP=42;I16=15,26,0,0,1519,58507,0,0,2232,126450,0,0,824,18630,0,0;QS=3,0;MQSB=0.110793;MQ0F=0 PL:DP:DV 0,72,255:24:0 0,21,201:7:0 0,30,242:10:0 +X 3922 . A <*> 0 . DP=42;I16=14,26,0,0,1539,61289,0,0,2195,125081,0,0,819,18545,0,0;QS=3,0;MQSB=0.168991;MQ0F=0 PL:DP:DV 0,72,255:24:0 0,18,179:6:0 0,30,244:10:0 +X 3923 . G <*> 0 . DP=41;I16=14,25,0,0,1515,60945,0,0,2135,121481,0,0,792,17834,0,0;QS=3,0;MQSB=0.182501;MQ0F=0 PL:DP:DV 0,69,255:23:0 0,18,172:6:0 0,30,240:10:0 +X 3924 . G <*> 0 . DP=41;I16=13,26,0,0,1524,61106,0,0,2135,121481,0,0,808,18356,0,0;QS=3,0;MQSB=0.128469;MQ0F=0 PL:DP:DV 0,69,255:23:0 0,18,158:6:0 0,30,247:10:0 +X 3925 . G <*> 0 . DP=41;I16=14,25,0,0,1425,55687,0,0,2135,121481,0,0,788,17758,0,0;QS=3,0;MQSB=0.182501;MQ0F=0 PL:DP:DV 0,72,255:24:0 0,15,134:5:0 0,30,245:10:0 +X 3926 . C <*> 0 . DP=41;I16=14,26,0,0,1512,59674,0,0,2195,125081,0,0,811,18393,0,0;QS=3,0;MQSB=0.168991;MQ0F=0 PL:DP:DV 0,72,255:24:0 0,18,152:6:0 0,30,237:10:0 +X 3927 . T <*> 0 . DP=41;I16=14,26,0,0,1512,59566,0,0,2195,125081,0,0,808,18384,0,0;QS=3,0;MQSB=0.168991;MQ0F=0 PL:DP:DV 0,72,255:24:0 0,18,160:6:0 0,30,237:10:0 +X 3928 . G <*> 0 . DP=41;I16=14,25,0,0,1479,58495,0,0,2135,121481,0,0,779,17731,0,0;QS=3,0;MQSB=0.182501;MQ0F=0 PL:DP:DV 0,72,255:24:0 0,18,149:6:0 0,27,233:9:0 +X 3929 . A <*> 0 . DP=41;I16=13,26,0,0,1452,56436,0,0,2135,121481,0,0,796,18256,0,0;QS=3,0;MQSB=0.128469;MQ0F=0 PL:DP:DV 0,69,255:23:0 0,18,161:6:0 0,30,220:10:0 +X 3930 . T <*> 0 . DP=40;I16=13,25,0,0,1387,52929,0,0,2078,118232,0,0,767,17521,0,0;QS=3,0;MQSB=0.25797;MQ0F=0 PL:DP:DV 0,69,255:23:0 0,15,149:5:0 0,30,224:10:0 +X 3931 . A <*> 0 . DP=40;I16=13,25,0,0,1387,52877,0,0,2078,118232,0,0,761,17439,0,0;QS=3,0;MQSB=0.25797;MQ0F=0 PL:DP:DV 0,69,255:23:0 0,18,166:6:0 0,27,222:9:0 +X 3932 . T <*> 0 . DP=39;I16=12,26,0,0,1394,53644,0,0,2078,118232,0,0,780,17964,0,0;QS=3,0;MQSB=0.190372;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,18,161:6:0 0,30,231:10:0 +X 3933 . T <*> 0 . DP=38;I16=12,24,0,0,1389,54743,0,0,1958,111032,0,0,752,17366,0,0;QS=3,0;MQSB=0.218161;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,18,166:6:0 0,24,220:8:0 +X 3934 . C <*> 0 . DP=38;I16=12,25,0,0,1395,54915,0,0,2018,114632,0,0,768,17758,0,0;QS=3,0;MQSB=0.203497;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,18,152:6:0 0,27,209:9:0 +X 3935 . C <*> 0 . DP=38;I16=12,24,0,0,1239,44621,0,0,1958,111032,0,0,737,17075,0,0;QS=3,0;MQSB=0.218161;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,15,134:5:0 0,27,170:9:0 +X 3936 . A G,<*> 0 . DP=37;I16=5,6,6,17,424,16384,801,30271,609,34563,1314,77018,225,5325,511,11851;QS=0.87994,2.12006,0;VDB=0.0574114;SGB=-4.60123;RPB=0.741697;MQB=0.812605;MQSB=0.143788;BQB=0.883831;MQ0F=0 PL:DP:DV 233,0,206,255,239,255:20:11 77,0,58,83,70,141:6:4 196,24,0,196,24,196:8:8 +X 3937 . C <*> 0 . DP=36;I16=11,24,0,0,1155,39875,0,0,1952,112422,0,0,745,17291,0,0;QS=3,0;MQSB=0.219636;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,18,143:6:0 0,24,156:8:0 +X 3938 . G <*> 0 . DP=35;I16=11,23,0,0,1155,41761,0,0,1892,108822,0,0,737,17079,0,0;QS=3,0;MQSB=0.231054;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,15,119:5:0 0,24,176:8:0 +X 3939 . C <*> 0 . DP=35;I16=11,22,0,0,1273,50651,0,0,1832,105222,0,0,703,16221,0,0;QS=3,0;MQSB=0.243713;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,15,135:5:0 0,21,174:7:0 +X 3940 . A <*> 0 . DP=35;I16=11,22,0,0,1148,42754,0,0,1832,105222,0,0,691,15867,0,0;QS=3,0;MQSB=0.243713;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,15,117:5:0 0,21,163:7:0 +X 3941 . C <*> 0 . DP=35;I16=11,22,0,0,1216,47488,0,0,1832,105222,0,0,688,15892,0,0;QS=3,0;MQSB=0.243713;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,15,133:5:0 0,21,181:7:0 +X 3942 . C <*> 0 . DP=35;I16=11,23,0,0,1336,54166,0,0,1892,108822,0,0,690,15772,0,0;QS=3,0;MQSB=0.231054;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,15,140:5:0 0,24,195:8:0 +X 3943 . T <*> 0 . DP=35;I16=11,23,0,0,1296,51618,0,0,1892,108822,0,0,676,15406,0,0;QS=3,0;MQSB=0.231054;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,15,142:5:0 0,24,195:8:0 +X 3944 . G <*> 0 . DP=34;I16=10,22,0,0,1199,46445,0,0,1803,104381,0,0,654,14954,0,0;QS=3,0;MQSB=0.1117;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,149:5:0 0,24,195:8:0 +X 3945 . C <*> 0 . DP=33;I16=10,22,0,0,1256,51226,0,0,1772,101622,0,0,649,14657,0,0;QS=3,0;MQSB=0.187579;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,15,142:5:0 0,21,177:7:0 +X 3946 . T <*> 0 . DP=33;I16=10,21,0,0,1170,45884,0,0,1712,98022,0,0,609,13599,0,0;QS=3,0;MQSB=0.199344;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,15,144:5:0 0,18,158:6:0 +X 3947 . A <*> 0 . DP=32;I16=10,21,0,0,1094,41048,0,0,1712,98022,0,0,620,13820,0,0;QS=3,0;MQSB=0.199344;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,15,128:5:0 0,18,149:6:0 +X 3948 . C <*> 0 . DP=32;I16=10,20,0,0,1134,45104,0,0,1652,94422,0,0,596,13344,0,0;QS=3,0;MQSB=0.212591;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,12,105:4:0 0,18,155:6:0 +X 3949 . A C,<*> 0 . DP=32;I16=10,17,0,1,1027,39909,24,576,1472,83622,60,3600,541,12211,25,625;QS=2.85093,0.149068,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.244621;BQB=1;MQ0F=0 PL:DP:DV 0,60,255,60,255,255:20:0 0,9,89,9,89,89:3:0 9,0,107,21,110,124:5:1 +X 3950 . C <*> 0 . DP=33;I16=11,21,0,0,1191,46247,0,0,1772,101622,0,0,576,12680,0,0;QS=3,0;MQSB=0.257801;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,15,118:5:0 0,18,168:6:0 +X 3951 . T <*> 0 . DP=34;I16=12,19,0,0,1148,44272,0,0,1712,98022,0,0,530,11670,0,0;QS=3,0;MQSB=0.354733;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,15,146:5:0 0,15,152:5:0 +X 3952 . C <*> 0 . DP=35;I16=13,20,0,0,1176,43762,0,0,1832,105222,0,0,545,12025,0,0;QS=3,0;MQSB=0.394875;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,18,158:6:0 0,15,143:5:0 +X 3953 . C <*> 0 . DP=34;I16=13,20,0,0,1246,48436,0,0,1863,107981,0,0,538,11772,0,0;QS=3,0;MQSB=0.252983;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,18,163:6:0 0,18,168:6:0 +X 3954 . T <*> 0 . DP=33;I16=13,19,0,0,1195,45815,0,0,1803,104381,0,0,526,11438,0,0;QS=3,0;MQSB=0.264585;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,18,171:6:0 0,18,167:6:0 +X 3955 . T <*> 0 . DP=32;I16=13,18,0,0,1180,46092,0,0,1743,100781,0,0,515,11139,0,0;QS=3,0;MQSB=0.277468;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,173:6:0 0,18,174:6:0 +X 3956 . C <*> 0 . DP=32;I16=13,18,0,0,1181,47021,0,0,1743,100781,0,0,504,10874,0,0;QS=3,0;MQSB=0.277468;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,167:6:0 0,18,167:6:0 +X 3957 . T <*> 0 . DP=31;I16=13,17,0,0,1153,46051,0,0,1683,97181,0,0,494,10642,0,0;QS=3,0;MQSB=0.291833;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,161:6:0 0,15,162:5:0 +X 3958 . T <*> 0 . DP=31;I16=13,16,0,0,1070,40600,0,0,1623,93581,0,0,483,10393,0,0;QS=3,0;MQSB=0.307929;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,139:5:0 0,15,157:5:0 +X 3959 . A <*> 0 . DP=30;I16=14,15,0,0,1062,39758,0,0,1623,93581,0,0,474,10176,0,0;QS=3,0;MQSB=0.377103;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,12,118:4:0 0,15,154:5:0 +X 3960 . T <*> 0 . DP=30;I16=14,15,0,0,995,36027,0,0,1623,93581,0,0,464,9892,0,0;QS=3,0;MQSB=0.377103;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,12,105:4:0 0,15,142:5:0 +X 3961 . G <*> 0 . DP=29;I16=12,16,0,0,1067,40899,0,0,1586,92212,0,0,457,9739,0,0;QS=3,0;MQSB=0.455864;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,12,114:4:0 0,12,122:4:0 +X 3962 . G <*> 0 . DP=29;I16=13,16,0,0,1025,37125,0,0,1623,93581,0,0,471,10053,0,0;QS=3,0;MQSB=0.307929;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,12,108:4:0 0,15,144:5:0 +X 3963 . C <*> 0 . DP=28;I16=13,15,0,0,1040,39100,0,0,1563,89981,0,0,463,9871,0,0;QS=3,0;MQSB=0.326055;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,12,111:4:0 0,12,126:4:0 +X 3964 . T <*> 0 . DP=27;I16=12,15,0,0,1036,39928,0,0,1503,86381,0,0,456,9720,0,0;QS=3,0;MQSB=0.273507;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,9,94:3:0 0,12,133:4:0 +X 3965 . G <*> 0 . DP=26;I16=12,14,0,0,993,38165,0,0,1443,82781,0,0,450,9598,0,0;QS=3,0;MQSB=0.29215;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,9,92:3:0 0,12,134:4:0 +X 3966 . A <*> 0 . DP=26;I16=12,13,0,0,930,34834,0,0,1406,81412,0,0,432,9310,0,0;QS=3,0;MQSB=0.520812;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,9,90:3:0 0,12,140:4:0 +X 3967 . T <*> 0 . DP=26;I16=12,13,0,0,900,32830,0,0,1406,81412,0,0,421,9001,0,0;QS=3,0;MQSB=0.520812;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,9,90:3:0 0,9,100:3:0 +X 3968 . A <*> 0 . DP=25;I16=12,13,0,0,885,31773,0,0,1406,81412,0,0,415,8853,0,0;QS=3,0;MQSB=0.520812;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,9,90:3:0 0,9,99:3:0 +X 3969 . T <*> 0 . DP=24;I16=11,13,0,0,886,32972,0,0,1369,80043,0,0,410,8736,0,0;QS=3,0;MQSB=0.702671;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,9,85:3:0 0,9,108:3:0 +X 3970 . T <*> 0 . DP=24;I16=11,13,0,0,861,31313,0,0,1369,80043,0,0,405,8649,0,0;QS=3,0;MQSB=0.702671;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,9,83:3:0 0,9,104:3:0 +X 3971 . C <*> 0 . DP=22;I16=11,11,0,0,815,30625,0,0,1249,72843,0,0,402,8590,0,0;QS=3,0;MQSB=0.751921;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,57:2:0 0,9,103:3:0 +X 3972 . C <*> 0 . DP=22;I16=11,11,0,0,812,30486,0,0,1249,72843,0,0,399,8557,0,0;QS=3,0;MQSB=0.751921;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,55:2:0 0,9,96:3:0 +X 3973 . A <*> 0 . DP=22;I16=11,11,0,0,795,28873,0,0,1249,72843,0,0,395,8501,0,0;QS=3,0;MQSB=0.751921;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,52:2:0 0,9,97:3:0 +X 3974 . C <*> 0 . DP=22;I16=11,11,0,0,729,24447,0,0,1249,72843,0,0,392,8472,0,0;QS=3,0;MQSB=0.751921;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,55:2:0 0,9,78:3:0 +X 3975 . G <*> 0 . DP=22;I16=11,11,0,0,717,24525,0,0,1249,72843,0,0,390,8470,0,0;QS=3,0;MQSB=0.751921;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,46:2:0 0,9,96:3:0 +X 3976 . C <*> 0 . DP=22;I16=11,11,0,0,816,30652,0,0,1249,72843,0,0,387,8445,0,0;QS=3,0;MQSB=0.751921;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,55:2:0 0,9,97:3:0 +X 3977 . A <*> 0 . DP=23;I16=11,11,0,0,740,25384,0,0,1249,72843,0,0,382,8346,0,0;QS=3,0;MQSB=0.751921;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,48:2:0 0,9,90:3:0 +X 3978 . C <*> 0 . DP=23;I16=11,12,0,0,769,26631,0,0,1309,76443,0,0,377,8223,0,0;QS=3,0;MQSB=0.726094;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,47:2:0 0,9,103:3:0 +X 3979 . C <*> 0 . DP=21;I16=9,11,0,0,744,28160,0,0,1152,67874,0,0,361,7905,0,0;QS=3,0;MQSB=0.885207;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,51:2:0 0,9,104:3:0 +X 3980 . T <*> 0 . DP=21;I16=10,11,0,0,756,27872,0,0,1212,71474,0,0,367,7855,0,0;QS=3,0;MQSB=0.914611;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,51:2:0 0,9,98:3:0 +X 3981 . G <*> 0 . DP=21;I16=10,11,0,0,785,29641,0,0,1212,71474,0,0,362,7710,0,0;QS=3,0;MQSB=0.914611;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,50:2:0 0,9,93:3:0 +X 3982 . C <*> 0 . DP=21;I16=10,11,0,0,779,29495,0,0,1212,71474,0,0,357,7591,0,0;QS=3,0;MQSB=0.914611;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,55:2:0 0,9,97:3:0 +X 3983 . T <*> 0 . DP=20;I16=9,11,0,0,720,26274,0,0,1155,68225,0,0,353,7497,0,0;QS=3,0;MQSB=0.993528;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,57:2:0 0,9,93:3:0 +X 3984 . A <*> 0 . DP=21;I16=10,11,0,0,739,26279,0,0,1192,69594,0,0,348,7378,0,0;QS=3,0;MQSB=0.885602;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,53:2:0 0,9,80:3:0 +X 3985 . C <*> 0 . DP=20;I16=10,10,0,0,728,26998,0,0,1132,65994,0,0,344,7234,0,0;QS=3,0;MQSB=0.902256;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,55:2:0 0,9,91:3:0 +X 3986 . A <*> 0 . DP=20;I16=10,10,0,0,685,23815,0,0,1132,65994,0,0,340,7114,0,0;QS=3,0;MQSB=0.902256;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,56:2:0 0,9,84:3:0 +X 3987 . C <*> 0 . DP=20;I16=10,10,0,0,736,28118,0,0,1132,65994,0,0,336,7018,0,0;QS=3,0;MQSB=0.902256;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,55:2:0 0,9,94:3:0 +X 3988 . T <*> 0 . DP=21;I16=10,10,0,0,741,27797,0,0,1132,65994,0,0,332,6946,0,0;QS=3,0;MQSB=0.902256;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,58:2:0 0,9,91:3:0 +X 3989 . C <*> 0 . DP=21;I16=10,11,0,0,729,26185,0,0,1192,69594,0,0,327,6801,0,0;QS=3,0;MQSB=0.885602;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,55:2:0 0,9,88:3:0 +X 3990 . C <*> 0 . DP=21;I16=10,11,0,0,766,28674,0,0,1192,69594,0,0,322,6686,0,0;QS=3,0;MQSB=0.885602;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,55:2:0 0,9,95:3:0 +X 3991 . T <*> 0 . DP=20;I16=9,11,0,0,729,27311,0,0,1132,65994,0,0,318,6600,0,0;QS=3,0;MQSB=0.850154;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,55:2:0 0,9,89:3:0 +X 3992 . T <*> 0 . DP=19;I16=9,10,0,0,667,24173,0,0,1072,62394,0,0,313,6441,0,0;QS=3,0;MQSB=0.868634;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,56:2:0 0,6,72:2:0 +X 3993 . C <*> 0 . DP=18;I16=9,9,0,0,701,27529,0,0,1012,58794,0,0,309,6307,0,0;QS=3,0;MQSB=0.888755;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,59:2:0 0,6,70:2:0 +X 3994 . T <*> 0 . DP=19;I16=10,9,0,0,718,27520,0,0,1049,60163,0,0,305,6197,0,0;QS=3,0;MQSB=0.716531;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,58:2:0 0,6,72:2:0 +X 3995 . T <*> 0 . DP=19;I16=9,9,0,0,641,23025,0,0,989,56563,0,0,277,5487,0,0;QS=3,0;MQSB=0.650623;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,53:2:0 0,6,69:2:0 +X 3996 . A <*> 0 . DP=19;I16=9,9,0,0,665,24815,0,0,989,56563,0,0,274,5428,0,0;QS=3,0;MQSB=0.650623;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,54:2:0 0,6,73:2:0 +X 3997 . G C,<*> 0 . DP=19;I16=10,8,0,1,645,23703,21,441,989,56563,60,3600,287,5843,6,36;QS=2.96023,0.0397727,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.716531;BQB=1;MQ0F=0 PL:DP:DV 0,24,255,42,255,255:15:1 0,6,57,6,57,57:2:0 0,6,60,6,60,60:2:0 +X 3998 . G <*> 0 . DP=18;I16=9,8,0,0,626,23710,0,0,929,52963,0,0,265,5203,0,0;QS=3,0;MQSB=0.687289;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,58:2:0 0,3,36:1:0 +X 3999 . G A,<*> 0 . DP=18;I16=9,7,0,1,596,22974,37,1369,869,49363,60,3600,263,5387,4,16;QS=2.92871,0.0712909,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.687289;BQB=1;MQ0F=0 PL:DP:DV 0,5,255,39,255,255:14:1 0,6,56,6,56,56:2:0 0,3,38,3,38,38:1:0 +X 4000 . C <*> 0 . DP=18;I16=10,8,0,0,669,25389,0,0,989,56563,0,0,283,5753,0,0;QS=3,0;MQSB=0.751866;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,55:2:0 0,3,36:1:0 +X 4001 . T <*> 0 . DP=18;I16=10,8,0,0,680,26006,0,0,989,56563,0,0,279,5727,0,0;QS=3,0;MQSB=0.751866;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,56:2:0 0,3,33:1:0 +X 4002 . G <*> 0 . DP=17;I16=10,7,0,0,621,23281,0,0,929,52963,0,0,276,5724,0,0;QS=2,0;MQSB=0.79189;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,44:2:0 0,0,0:0:0 +X 4003 . A <*> 0 . DP=17;I16=10,7,0,0,597,21507,0,0,929,52963,0,0,272,5692,0,0;QS=2,0;MQSB=0.79189;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,55:2:0 0,0,0:0:0 +X 4004 . T <*> 0 . DP=15;I16=9,6,0,0,527,19031,0,0,849,48963,0,0,270,5678,0,0;QS=2,0;MQSB=0.957526;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,3,40:1:0 0,0,0:0:0 +X 4005 . A <*> 0 . DP=15;I16=8,5,0,0,479,17731,0,0,729,41763,0,0,237,5195,0,0;QS=2,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,35:1:0 0,0,0:0:0 +X 4006 . T <*> 0 . DP=15;I16=9,6,0,0,554,20776,0,0,849,48963,0,0,266,5698,0,0;QS=2,0;MQSB=0.957526;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,3,40:1:0 0,0,0:0:0 +X 4007 . T G,<*> 0 . DP=15;I16=9,5,0,1,490,17810,15,225,789,45363,60,3600,245,5371,19,361;QS=1.96746,0.032538,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.957526;BQB=1;MQ0F=0 PL:DP:DV 0,26,255,39,255,255:14:1 0,3,41,3,41,41:1:0 0,0,0,0,0,0:0:0 +X 4008 . C <*> 0 . DP=15;I16=9,6,0,0,488,16890,0,0,849,48963,0,0,262,5782,0,0;QS=2,0;MQSB=0.957526;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,3,30:1:0 0,0,0:0:0 +X 4009 . C <*> 0 . DP=14;I16=9,5,0,0,524,20150,0,0,794,45938,0,0,261,5847,0,0;QS=2,0;MQSB=0.800737;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,3,40:1:0 0,0,0:0:0 +X 4010 . A <*> 0 . DP=14;I16=9,5,0,0,523,19731,0,0,794,45938,0,0,259,5875,0,0;QS=2,0;MQSB=0.800737;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,3,41:1:0 0,0,0:0:0 +X 4011 . C <*> 0 . DP=14;I16=9,5,0,0,489,17613,0,0,794,45938,0,0,257,5915,0,0;QS=2,0;MQSB=0.800737;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,3,41:1:0 0,0,0:0:0 +X 4012 . A <*> 0 . DP=14;I16=7,5,0,0,365,11867,0,0,674,38738,0,0,223,5293,0,0;QS=2,0;MQSB=0.6821;MQ0F=0 PL:DP:DV 0,33,231:11:0 0,3,30:1:0 0,0,0:0:0 +X 4013 . C <*> 0 . DP=14;I16=8,5,0,0,451,15885,0,0,734,42338,0,0,247,5995,0,0;QS=2,0;MQSB=0.765017;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,37:1:0 0,0,0:0:0 +X 4014 . A <*> 0 . DP=12;I16=8,2,0,0,358,13372,0,0,554,31538,0,0,222,5404,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,213:9:0 0,3,34:1:0 0,0,0:0:0 +X 4015 . C <*> 0 . DP=12;I16=8,2,0,0,350,12812,0,0,554,31538,0,0,222,5442,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,222:9:0 0,3,21:1:0 0,0,0:0:0 +X 4016 . C <*> 0 . DP=12;I16=8,3,0,0,350,11956,0,0,614,35138,0,0,247,6109,0,0;QS=2,0;MQSB=0.829029;MQ0F=0 PL:DP:DV 0,30,215:10:0 0,3,32:1:0 0,0,0:0:0 +X 4017 . C <*> 0 . DP=11;I16=5,2,0,0,227,7765,0,0,374,20738,0,0,173,4279,0,0;QS=2,0;MQSB=0.6;MQ0F=0 PL:DP:DV 0,18,161:6:0 0,3,20:1:0 0,0,0:0:0 +X 4018 . G <*> 0 . DP=11;I16=8,2,0,0,284,8442,0,0,554,31538,0,0,249,6201,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,183:9:0 0,3,17:1:0 0,0,0:0:0 +X 4019 . C <*> 0 . DP=11;I16=9,2,0,0,383,14427,0,0,614,35138,0,0,250,6250,0,0;QS=2,0;MQSB=0.777778;MQ0F=0 PL:DP:DV 0,30,228:10:0 0,3,33:1:0 0,0,0:0:0 +X 4020 . T <*> 0 . DP=10;I16=8,2,0,0,362,13668,0,0,554,31538,0,0,250,6250,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,213:9:0 0,3,38:1:0 0,0,0:0:0 +X 4021 . A <*> 0 . DP=10;I16=8,1,0,0,304,10512,0,0,494,27938,0,0,225,5625,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,177:8:0 0,3,33:1:0 0,0,0:0:0 +X 4022 . C <*> 0 . DP=10;I16=7,2,0,0,310,11582,0,0,494,27938,0,0,225,5625,0,0;QS=2,0;MQSB=0.714286;MQ0F=0 PL:DP:DV 0,24,202:8:0 0,3,36:1:0 0,0,0:0:0 +X 4023 . A <*> 0 . DP=10;I16=8,2,0,0,354,13116,0,0,554,31538,0,0,250,6250,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,209:9:0 0,3,40:1:0 0,0,0:0:0 +X 4024 . C <*> 0 . DP=10;I16=8,2,0,0,361,13669,0,0,554,31538,0,0,250,6250,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,214:9:0 0,3,39:1:0 0,0,0:0:0 +X 4025 . T <*> 0 . DP=10;I16=8,1,0,0,360,14488,0,0,494,27938,0,0,224,5576,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,199:8:0 0,3,42:1:0 0,0,0:0:0 +X 4026 . C <*> 0 . DP=10;I16=8,2,0,0,329,11655,0,0,554,31538,0,0,248,6154,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,192:9:0 0,3,39:1:0 0,0,0:0:0 +X 4027 . C <*> 0 . DP=10;I16=8,2,0,0,380,14888,0,0,554,31538,0,0,246,6060,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,231:9:0 0,3,38:1:0 0,0,0:0:0 +X 4028 . T <*> 0 . DP=10;I16=8,2,0,0,333,12157,0,0,554,31538,0,0,244,5970,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,202:9:0 0,3,41:1:0 0,0,0:0:0 +X 4029 . T <*> 0 . DP=10;I16=8,2,0,0,377,14333,0,0,554,31538,0,0,242,5884,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,225:9:0 0,3,38:1:0 0,0,0:0:0 +X 4030 . C <*> 0 . DP=10;I16=8,2,0,0,348,12558,0,0,554,31538,0,0,240,5802,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,211:9:0 0,3,30:1:0 0,0,0:0:0 +X 4031 . T <*> 0 . DP=10;I16=8,2,0,0,388,15302,0,0,554,31538,0,0,238,5724,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,229:9:0 0,3,39:1:0 0,0,0:0:0 +X 4032 . T <*> 0 . DP=10;I16=8,2,0,0,341,11901,0,0,554,31538,0,0,236,5650,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,204:9:0 0,3,39:1:0 0,0,0:0:0 +X 4033 . A <*> 0 . DP=10;I16=7,2,0,0,299,10717,0,0,494,27938,0,0,218,5324,0,0;QS=2,0;MQSB=0.714286;MQ0F=0 PL:DP:DV 0,24,193:8:0 0,3,38:1:0 0,0,0:0:0 +X 4034 . G <*> 0 . DP=10;I16=8,2,0,0,347,12527,0,0,554,31538,0,0,231,5465,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,211:9:0 0,3,39:1:0 0,0,0:0:0 +X 4035 . G T,<*> 0 . DP=10;I16=7,2,1,0,316,11900,13,169,494,27938,60,3600,202,4682,25,625;QS=1.9547,0.0452962,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.75;BQB=1;MQ0F=0 PL:DP:DV 0,13,195,24,198,200:9:1 0,3,31,3,31,31:1:0 0,0,0,0,0,0:0:0 +X 4036 . G <*> 0 . DP=10;I16=8,1,0,0,269,8839,0,0,494,27938,0,0,198,4532,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,156:8:0 0,3,34:1:0 0,0,0:0:0 +X 4037 . C <*> 0 . DP=10;I16=8,2,0,0,342,12466,0,0,554,31538,0,0,219,5015,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,210:9:0 0,3,30:1:0 0,0,0:0:0 +X 4038 . T <*> 0 . DP=10;I16=8,2,0,0,335,12149,0,0,554,31538,0,0,215,4881,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,203:9:0 0,3,29:1:0 0,0,0:0:0 +X 4039 . G <*> 0 . DP=10;I16=8,1,0,0,302,10798,0,0,494,27938,0,0,186,4130,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,180:8:0 0,3,31:1:0 0,0,0:0:0 +X 4040 . A <*> 0 . DP=10;I16=8,2,0,0,380,14602,0,0,554,31538,0,0,207,4637,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,223:9:0 0,3,41:1:0 0,0,0:0:0 +X 4041 . T <*> 0 . DP=10;I16=8,2,0,0,367,13633,0,0,554,31538,0,0,202,4478,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,216:9:0 0,3,40:1:0 0,0,0:0:0 +X 4042 . A <*> 0 . DP=10;I16=8,2,0,0,337,11657,0,0,554,31538,0,0,197,4329,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,205:9:0 0,3,34:1:0 0,0,0:0:0 +X 4043 . T <*> 0 . DP=10;I16=8,2,0,0,314,10428,0,0,554,31538,0,0,192,4190,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,190:9:0 0,3,35:1:0 0,0,0:0:0 +X 4044 . T <*> 0 . DP=10;I16=8,2,0,0,333,11579,0,0,554,31538,0,0,187,4061,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,199:9:0 0,3,37:1:0 0,0,0:0:0 +X 4045 . C <*> 0 . DP=10;I16=7,2,0,0,291,10099,0,0,494,27938,0,0,176,3906,0,0;QS=1,0;MQSB=0.714286;MQ0F=0 PL:DP:DV 0,27,204:9:0 0,0,0:0:0 0,0,0:0:0 +X 4046 . C <*> 0 . DP=10;I16=8,2,0,0,356,13032,0,0,554,31538,0,0,177,3833,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,212:9:0 0,3,35:1:0 0,0,0:0:0 +X 4047 . A <*> 0 . DP=10;I16=8,2,0,0,347,12557,0,0,554,31538,0,0,172,3734,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,204:9:0 0,3,40:1:0 0,0,0:0:0 +X 4048 . C <*> 0 . DP=10;I16=8,2,0,0,342,12124,0,0,554,31538,0,0,167,3645,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,202:9:0 0,3,37:1:0 0,0,0:0:0 +X 4049 . G <*> 0 . DP=10;I16=7,2,0,0,260,7786,0,0,494,27938,0,0,146,3310,0,0;QS=2,0;MQSB=0.714286;MQ0F=0 PL:DP:DV 0,24,173:8:0 0,3,24:1:0 0,0,0:0:0 +X 4050 . C <*> 0 . DP=9;I16=6,2,0,0,291,10813,0,0,434,24338,0,0,157,3495,0,0;QS=1,0;MQSB=0.666667;MQ0F=0 PL:DP:DV 0,24,204:8:0 0,0,0:0:0 0,0,0:0:0 +X 4051 . A <*> 0 . DP=8;I16=5,2,0,0,259,9679,0,0,374,20738,0,0,146,3370,0,0;QS=1,0;MQSB=0.6;MQ0F=0 PL:DP:DV 0,21,192:7:0 0,0,0:0:0 0,0,0:0:0 +X 4052 . C <*> 0 . DP=8;I16=5,2,0,0,247,9025,0,0,374,20738,0,0,143,3281,0,0;QS=1,0;MQSB=0.6;MQ0F=0 PL:DP:DV 0,21,190:7:0 0,0,0:0:0 0,0,0:0:0 +X 4053 . C <*> 0 . DP=8;I16=6,2,0,0,254,9000,0,0,434,24338,0,0,146,3234,0,0;QS=1,0;MQSB=0.666667;MQ0F=0 PL:DP:DV 0,24,184:8:0 0,0,0:0:0 0,0,0:0:0 +X 4054 . C <*> 0 . DP=8;I16=3,2,0,0,160,5344,0,0,254,13538,0,0,122,2984,0,0;QS=1,0;MQSB=0.333333;MQ0F=0 PL:DP:DV 0,15,134:5:0 0,0,0:0:0 0,0,0:0:0 +X 4055 . G <*> 0 . DP=8;I16=6,2,0,0,230,6982,0,0,434,24338,0,0,138,3066,0,0;QS=1,0;MQSB=0.666667;MQ0F=0 PL:DP:DV 0,24,169:8:0 0,0,0:0:0 0,0,0:0:0 +X 4056 . C <*> 0 . DP=8;I16=6,2,0,0,275,10153,0,0,434,24338,0,0,134,2994,0,0;QS=1,0;MQSB=0.666667;MQ0F=0 PL:DP:DV 0,24,197:8:0 0,0,0:0:0 0,0,0:0:0 +X 4057 . T <*> 0 . DP=8;I16=5,2,0,0,243,8603,0,0,374,20738,0,0,127,2877,0,0;QS=1,0;MQSB=0.6;MQ0F=0 PL:DP:DV 0,21,182:7:0 0,0,0:0:0 0,0,0:0:0 +X 4058 . A <*> 0 . DP=7;I16=4,2,0,0,214,7742,0,0,314,17138,0,0,116,2728,0,0;QS=1,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,18,171:6:0 0,0,0:0:0 0,0,0:0:0 +X 4059 . C <*> 0 . DP=6;I16=4,2,0,0,204,7164,0,0,314,17138,0,0,119,2635,0,0;QS=1,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,18,168:6:0 0,0,0:0:0 0,0,0:0:0 +X 4060 . A <*> 0 . DP=6;I16=4,2,0,0,227,8683,0,0,314,17138,0,0,115,2501,0,0;QS=1,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,18,177:6:0 0,0,0:0:0 0,0,0:0:0 +X 4061 . C <*> 0 . DP=6;I16=4,2,0,0,193,6681,0,0,314,17138,0,0,111,2375,0,0;QS=1,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,18,157:6:0 0,0,0:0:0 0,0,0:0:0 +X 4062 . T <*> 0 . DP=6;I16=4,1,0,0,195,7621,0,0,254,13538,0,0,82,1632,0,0;QS=1,0;MQSB=1;MQ0F=0 PL:DP:DV 0,15,151:5:0 0,0,0:0:0 0,0,0:0:0 +X 4063 . C <*> 0 . DP=6;I16=4,2,0,0,216,7984,0,0,314,17138,0,0,102,2098,0,0;QS=1,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,18,170:6:0 0,0,0:0:0 0,0,0:0:0 +X 4064 . C <*> 0 . DP=6;I16=4,2,0,0,227,8747,0,0,314,17138,0,0,97,1949,0,0;QS=1,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,18,177:6:0 0,0,0:0:0 0,0,0:0:0 +X 4065 . T <*> 0 . DP=6;I16=4,2,0,0,202,6880,0,0,314,17138,0,0,92,1810,0,0;QS=1,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,18,161:6:0 0,0,0:0:0 0,0,0:0:0 +X 4066 . T <*> 0 . DP=5;I16=3,2,0,0,180,6554,0,0,254,13538,0,0,88,1680,0,0;QS=1,0;MQSB=0.333333;MQ0F=0 PL:DP:DV 0,15,153:5:0 0,0,0:0:0 0,0,0:0:0 +X 4067 . C <*> 0 . DP=5;I16=3,2,0,0,181,6637,0,0,254,13538,0,0,84,1558,0,0;QS=1,0;MQSB=0.333333;MQ0F=0 PL:DP:DV 0,15,153:5:0 0,0,0:0:0 0,0,0:0:0 +X 4068 . T <*> 0 . DP=5;I16=3,2,0,0,198,7868,0,0,254,13538,0,0,80,1444,0,0;QS=1,0;MQSB=0.333333;MQ0F=0 PL:DP:DV 0,15,164:5:0 0,0,0:0:0 0,0,0:0:0 +X 4069 . T <*> 0 . DP=5;I16=3,2,0,0,177,6325,0,0,254,13538,0,0,76,1338,0,0;QS=1,0;MQSB=0.333333;MQ0F=0 PL:DP:DV 0,15,154:5:0 0,0,0:0:0 0,0,0:0:0 +X 4070 . A <*> 0 . DP=5;I16=3,2,0,0,161,5263,0,0,254,13538,0,0,72,1240,0,0;QS=1,0;MQSB=0.333333;MQ0F=0 PL:DP:DV 0,15,140:5:0 0,0,0:0:0 0,0,0:0:0 +X 4071 . G <*> 0 . DP=5;I16=3,2,0,0,166,5658,0,0,254,13538,0,0,68,1150,0,0;QS=1,0;MQSB=0.333333;MQ0F=0 PL:DP:DV 0,15,142:5:0 0,0,0:0:0 0,0,0:0:0 +X 4072 . G <*> 0 . DP=5;I16=2,2,0,0,138,4974,0,0,194,9938,0,0,55,987,0,0;QS=1,0;MQSB=0;MQ0F=0 PL:DP:DV 0,12,122:4:0 0,0,0:0:0 0,0,0:0:0 +X 4073 . G <*> 0 . DP=5;I16=3,2,0,0,156,5082,0,0,254,13538,0,0,60,994,0,0;QS=1,0;MQSB=0.333333;MQ0F=0 PL:DP:DV 0,15,136:5:0 0,0,0:0:0 0,0,0:0:0 +X 4074 . C <*> 0 . DP=5;I16=3,2,0,0,160,5602,0,0,254,13538,0,0,56,928,0,0;QS=1,0;MQSB=0.333333;MQ0F=0 PL:DP:DV 0,15,142:5:0 0,0,0:0:0 0,0,0:0:0 +X 4075 . T <*> 0 . DP=5;I16=3,2,0,0,187,7069,0,0,254,13538,0,0,52,870,0,0;QS=1,0;MQSB=0.333333;MQ0F=0 PL:DP:DV 0,15,155:5:0 0,0,0:0:0 0,0,0:0:0 +X 4076 . G <*> 0 . DP=5;I16=3,2,0,0,174,6298,0,0,254,13538,0,0,48,820,0,0;QS=1,0;MQSB=0.333333;MQ0F=0 PL:DP:DV 0,15,149:5:0 0,0,0:0:0 0,0,0:0:0 +X 4077 . A <*> 0 . DP=4;I16=3,1,0,0,138,4810,0,0,194,9938,0,0,44,728,0,0;QS=1,0;MQSB=1;MQ0F=0 PL:DP:DV 0,12,121:4:0 0,0,0:0:0 0,0,0:0:0 +X 4078 . T <*> 0 . DP=4;I16=3,1,0,0,143,5173,0,0,194,9938,0,0,40,644,0,0;QS=1,0;MQSB=1;MQ0F=0 PL:DP:DV 0,12,124:4:0 0,0,0:0:0 0,0,0:0:0 +X 4079 . A <*> 0 . DP=4;I16=3,1,0,0,121,3847,0,0,194,9938,0,0,36,568,0,0;QS=1,0;MQSB=1;MQ0F=0 PL:DP:DV 0,12,107:4:0 0,0,0:0:0 0,0,0:0:0 +X 4080 . T <*> 0 . DP=4;I16=3,0,0,0,106,3778,0,0,134,6338,0,0,25,451,0,0;QS=1,0;MQ0F=0 PL:DP:DV 0,9,87:3:0 0,0,0:0:0 0,0,0:0:0 +X 4081 . T <*> 0 . DP=4;I16=3,1,0,0,106,2934,0,0,194,9938,0,0,28,440,0,0;QS=1,0;MQSB=1;MQ0F=0 PL:DP:DV 0,12,94:4:0 0,0,0:0:0 0,0,0:0:0 +X 4082 . C <*> 0 . DP=3;I16=2,1,0,0,110,4042,0,0,134,6338,0,0,25,387,0,0;QS=1,0;MQSB=1;MQ0F=0 PL:DP:DV 0,9,103:3:0 0,0,0:0:0 0,0,0:0:0 +X 4083 . C <*> 0 . DP=3;I16=2,1,0,0,104,3648,0,0,134,6338,0,0,22,340,0,0;QS=1,0;MQSB=1;MQ0F=0 PL:DP:DV 0,9,98:3:0 0,0,0:0:0 0,0,0:0:0 +X 4084 . A <*> 0 . DP=2;I16=1,1,0,0,78,3050,0,0,97,4969,0,0,20,298,0,0;QS=1,0;MQSB=1;MQ0F=0 PL:DP:DV 0,6,74:2:0 0,0,0:0:0 0,0,0:0:0 +X 4085 . C <*> 0 . DP=2;I16=1,1,0,0,62,1940,0,0,97,4969,0,0,18,260,0,0;QS=1,0;MQSB=1;MQ0F=0 PL:DP:DV 0,6,62:2:0 0,0,0:0:0 0,0,0:0:0 +X 4086 . G <*> 0 . DP=2;I16=1,1,0,0,56,1640,0,0,97,4969,0,0,16,226,0,0;QS=1,0;MQSB=1;MQ0F=0 PL:DP:DV 0,6,56:2:0 0,0,0:0:0 0,0,0:0:0 +X 4087 . C <*> 0 . DP=2;I16=1,1,0,0,69,2405,0,0,97,4969,0,0,14,196,0,0;QS=1,0;MQSB=1;MQ0F=0 PL:DP:DV 0,6,68:2:0 0,0,0:0:0 0,0,0:0:0 +X 4088 . A <*> 0 . DP=1;I16=1,0,0,0,39,1521,0,0,37,1369,0,0,13,169,0,0;QS=1,0;MQ0F=0 PL:DP:DV 0,3,37:1:0 0,0,0:0:0 0,0,0:0:0 +X 4089 . C <*> 0 . DP=1;I16=1,0,0,0,36,1296,0,0,37,1369,0,0,12,144,0,0;QS=1,0;MQ0F=0 PL:DP:DV 0,3,36:1:0 0,0,0:0:0 0,0,0:0:0 +X 4090 . C <*> 0 . DP=1;I16=1,0,0,0,33,1089,0,0,37,1369,0,0,11,121,0,0;QS=1,0;MQ0F=0 PL:DP:DV 0,3,33:1:0 0,0,0:0:0 0,0,0:0:0 +X 4091 . T <*> 0 . DP=1;I16=1,0,0,0,36,1296,0,0,37,1369,0,0,10,100,0,0;QS=1,0;MQ0F=0 PL:DP:DV 0,3,36:1:0 0,0,0:0:0 0,0,0:0:0 +X 4092 . G <*> 0 . DP=1;I16=1,0,0,0,37,1369,0,0,37,1369,0,0,9,81,0,0;QS=1,0;MQ0F=0 PL:DP:DV 0,3,37:1:0 0,0,0:0:0 0,0,0:0:0 +X 4093 . C <*> 0 . DP=1;I16=1,0,0,0,35,1225,0,0,37,1369,0,0,8,64,0,0;QS=1,0;MQ0F=0 PL:DP:DV 0,3,35:1:0 0,0,0:0:0 0,0,0:0:0 +X 4094 . T <*> 0 . DP=1;I16=1,0,0,0,40,1600,0,0,37,1369,0,0,7,49,0,0;QS=1,0;MQ0F=0 PL:DP:DV 0,3,37:1:0 0,0,0:0:0 0,0,0:0:0 +X 4095 . A <*> 0 . DP=1;I16=1,0,0,0,35,1225,0,0,37,1369,0,0,6,36,0,0;QS=1,0;MQ0F=0 PL:DP:DV 0,3,35:1:0 0,0,0:0:0 0,0,0:0:0 +X 4096 . C <*> 0 . DP=1;I16=1,0,0,0,32,1024,0,0,37,1369,0,0,5,25,0,0;QS=1,0;MQ0F=0 PL:DP:DV 0,3,32:1:0 0,0,0:0:0 0,0,0:0:0 +X 4097 . A <*> 0 . DP=1;I16=1,0,0,0,35,1225,0,0,37,1369,0,0,4,16,0,0;QS=1,0;MQ0F=0 PL:DP:DV 0,3,35:1:0 0,0,0:0:0 0,0,0:0:0 +X 4098 . C <*> 0 . DP=1;I16=1,0,0,0,31,961,0,0,37,1369,0,0,3,9,0,0;QS=1,0;MQ0F=0 PL:DP:DV 0,3,31:1:0 0,0,0:0:0 0,0,0:0:0 +X 4099 . T <*> 0 . DP=1;I16=1,0,0,0,32,1024,0,0,37,1369,0,0,2,4,0,0;QS=1,0;MQ0F=0 PL:DP:DV 0,3,32:1:0 0,0,0:0:0 0,0,0:0:0 +X 4100 . C <*> 0 . DP=1;I16=1,0,0,0,27,729,0,0,37,1369,0,0,1,1,0,0;QS=1,0;MQ0F=0 PL:DP:DV 0,3,27:1:0 0,0,0:0:0 0,0,0:0:0 +X 4101 . C <*> 0 . DP=1;I16=1,0,0,0,26,676,0,0,37,1369,0,0,0,0,0,0;QS=1,0;MQ0F=0 PL:DP:DV 0,3,26:1:0 0,0,0:0:0 0,0,0:0:0 diff --git a/test/mpileup.ped b/test/mpileup.ped new file mode 100644 index 000000000..c4226c6e5 --- /dev/null +++ b/test/mpileup.ped @@ -0,0 +1,3 @@ +HG00100 HG00100 0 0 2 0 +HG00101 HG00101 0 0 1 0 +HG00102 HG00102 0 0 2 0 diff --git a/test/mpileup.ploidy b/test/mpileup.ploidy new file mode 100644 index 000000000..4a372abb8 --- /dev/null +++ b/test/mpileup.ploidy @@ -0,0 +1,4 @@ +X 1 1000 M 1 +X 3104 5000 M 1 +#* * * M 2 +#* * * F 2 diff --git a/test/mpileup.samples b/test/mpileup.samples new file mode 100644 index 000000000..be818ea59 --- /dev/null +++ b/test/mpileup.samples @@ -0,0 +1,3 @@ +HG00100 F +HG00101 M +HG00102 F diff --git a/test/test.pl b/test/test.pl index cd9fbe462..8dca4e63d 100755 --- a/test/test.pl +++ b/test/test.pl @@ -127,6 +127,8 @@ test_vcf_view($opts,in=>'view.minmaxac',out=>'view.minmaxac.1.out',args=>q[-H -q0.3:major],reg=>''); test_vcf_call($opts,in=>'mpileup',out=>'mpileup.1.out',args=>'-mv'); test_vcf_call($opts,in=>'mpileup',out=>'mpileup.2.out',args=>'-mvg0'); +test_vcf_call($opts,in=>'mpileup.X',out=>'mpileup.X.out',args=>'-mv --ploidy-file {PATH}/mpileup.ploidy -S {PATH}/mpileup.samples'); +test_vcf_call($opts,in=>'mpileup.X',out=>'mpileup.X.out',args=>'-mv --ploidy-file {PATH}/mpileup.ploidy -S {PATH}/mpileup.ped'); test_vcf_call_cAls($opts,in=>'mpileup',out=>'mpileup.cAls.out',tab=>'mpileup'); test_vcf_filter($opts,in=>'filter.1',out=>'filter.1.out',args=>'-mx -g2 -G2'); test_vcf_filter($opts,in=>'filter.2',out=>'filter.2.out',args=>q[-e'QUAL==59.2 || (INDEL=0 & (FMT/GQ=25 | FMT/DP=10))' -sModified -S.]); @@ -524,6 +526,7 @@ sub test_vcf_view sub test_vcf_call { my ($opts,%args) = @_; + $args{args} =~ s/{PATH}/$$opts{path}/g; test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools call $args{args} $$opts{path}/$args{in}.vcf | grep -v ^##bcftools_"); test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools call -Ob $args{args} $$opts{path}/$args{in}.vcf | $$opts{bin}/bcftools view | grep -v ^##bcftools_"); } diff --git a/vcfcall.c b/vcfcall.c index 7eb56b33e..b6d201f52 100644 --- a/vcfcall.c +++ b/vcfcall.c @@ -526,6 +526,26 @@ static int parse_format_flag(const char *str) return flag; } +static void set_ploidy(args_t *args, bcf1_t *rec) +{ + ploidy_query(args->ploidy,(char*)bcf_seqname(args->aux.hdr,rec),rec->pos,args->sex2ploidy,NULL,NULL); + + int i; + for (i=0; insex; i++) + if ( args->sex2ploidy[i]!=args->sex2ploidy_prev[i] ) break; + + if ( i==args->nsex ) return; // ploidy same as previously + + for (i=0; insamples; i++) + { + if ( args->sample2sex[i]<0 ) + args->aux.ploidy[i] = -1*args->sample2sex[i]; + else + args->aux.ploidy[i] = args->sex2ploidy[args->sample2sex[i]]; + } + + int *tmp = args->sex2ploidy; args->sex2ploidy = args->sex2ploidy_prev; args->sex2ploidy_prev = tmp; +} ploidy_t *init_ploidy(char *alias) { @@ -788,6 +808,7 @@ int main_vcfcall(int argc, char *argv[]) if ( (args.flag & CF_ACGT_ONLY) && (bcf_rec->d.allele[0][0]=='N' || bcf_rec->d.allele[0][0]=='n') ) continue; // REF[0] is 'N' bcf_unpack(bcf_rec, BCF_UN_ALL); + if ( args.nsex ) set_ploidy(&args, bcf_rec); // Various output modes: QCall output (todo) if ( args.flag & CF_QCALL ) From b1bf66a7287bfa67ca22cfb20633c53f3bf6a25e Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Tue, 1 Sep 2015 16:25:03 +0100 Subject: [PATCH 059/211] Fix parsing of the default ploidy lines, both tab or spaces will work now --- ploidy.c | 23 ++++++++++++++++------- 1 file changed, 16 insertions(+), 7 deletions(-) diff --git a/ploidy.c b/ploidy.c index 8449d66a4..160bc3eae 100644 --- a/ploidy.c +++ b/ploidy.c @@ -54,16 +54,27 @@ regidx_t *ploidy_regions(ploidy_t *ploidy) int ploidy_parse(const char *line, char **chr_beg, char **chr_end, reg_t *reg, void *payload, void *usr) { + int i, ret; ploidy_t *ploidy = (ploidy_t*) usr; void *sex2id = ploidy->sex2id; - // Fill CHR,FROM,TO - int i, ret = regidx_parse_tab(line,chr_beg,chr_end,reg,NULL,NULL); - if ( ret!=0 ) return ret; + // Check for special case of default ploidy "* * * " + int default_ploidy_def = 0; - // Skip the fields already parsed by regidx_parse_tab char *ss = (char*) line; while ( *ss && isspace(*ss) ) ss++; + if ( ss[0]=='*' && (!ss[1] || isspace(ss[1])) ) + default_ploidy_def = 1; // definition of default ploidy, chr="*" + else + { + // Fill CHR,FROM,TO + ret = regidx_parse_tab(line,chr_beg,chr_end,reg,NULL,NULL); + if ( ret!=0 ) return ret; + } + + // Skip the fields already parsed by regidx_parse_tab + ss = (char*) line; + while ( *ss && isspace(*ss) ) ss++; for (i=0; i<3; i++) { while ( *ss && !isspace(*ss) ) ss++; @@ -99,9 +110,7 @@ int ploidy_parse(const char *line, char **chr_beg, char **chr_end, reg_t *reg, v if ( sp->ploidy > ploidy->max ) ploidy->max = sp->ploidy; // Special case, chr="*" stands for a default value - ss = (char*) line; - while ( *ss && isspace(*ss) ) ss++; - if ( ss[0]=='*' && (!ss[1] || isspace(ss[1])) ) + if ( default_ploidy_def ) { ploidy->sex2dflt[ploidy->nsex-1] = sp->ploidy; return -1; From 9a06670bfe512824f9b1e026eab5927ea6b344b2 Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Tue, 1 Sep 2015 16:29:18 +0100 Subject: [PATCH 060/211] default ploidy now ready from file after b1bf66a7287bfa67ca22cfb20633c53f3bf6a25e --- test/mpileup.ploidy | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/test/mpileup.ploidy b/test/mpileup.ploidy index 4a372abb8..b9eba8a34 100644 --- a/test/mpileup.ploidy +++ b/test/mpileup.ploidy @@ -1,4 +1,4 @@ X 1 1000 M 1 X 3104 5000 M 1 -#* * * M 2 -#* * * F 2 +* * * M 2 +* * * F 2 From 354b980fe11568aeeab42ee77efd5ca05a1dc5cf Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Wed, 2 Sep 2015 11:11:23 +0100 Subject: [PATCH 061/211] docs: clarify `--include-type` and `--exclude-types` addresses the documentation comment raised in #310, but not the comment about bold vs italic for elements that are not metasyntactic, which will require more extensive update to the man page docs to be consistent across the board. --- doc/bcftools.txt | 17 ++++++++++++----- 1 file changed, 12 insertions(+), 5 deletions(-) diff --git a/doc/bcftools.txt b/doc/bcftools.txt index 0c64c4265..9cfeb6ffe 100644 --- a/doc/bcftools.txt +++ b/doc/bcftools.txt @@ -1599,14 +1599,14 @@ Convert between VCF and BCF. Former *bcftools subset*. *-P, --exclude-phased*:: exclude sites where all samples are phased -*-q, --min-af* 'FLOAT'[':nref'|':alt1'|':minor'|:'major'|:'nonmajor']:: +*-q, --min-af* 'FLOAT'[':nref'|':alt1'|':minor'|':major'|':nonmajor']:: minimum allele frequency (INFO/AC / INFO/AN) of sites to be printed. Specifying the type of allele is optional and can be set to non-reference ('nref', the default), 1st alternate ('alt1'), the least frequent ('minor'), the most frequent ('major') or sum of all but the most frequent ('nonmajor') alleles. -*-Q, --max-af* 'FLOAT'[':nref'|':alt1'|':minor'|:'major'|:'nonmajor']:: +*-Q, --max-af* 'FLOAT'[':nref'|':alt1'|':minor'|':major'|':nonmajor']:: maximum allele frequency (INFO/AC / INFO/AN) of sites to be printed. Specifying the type of allele is optional and can be set to non-reference ('nref', the default), 1st alternate ('alt1'), the least @@ -1620,14 +1620,21 @@ Convert between VCF and BCF. Former *bcftools subset*. exclude sites without a called genotype *-v, --types* 'snps'|'indels'|'mnps'|'other':: - comma-separated list of variant types to select + comma-separated list of variant types to select. Site is selected if + any of the ALT alleles is of the type requested. Types are determined + by comparing the REF and ALT alleles in the VCF record not INFO tags + like INFO/INDEL or INFO/VT. Use *--include* to select based on INFO + tags. *-V, --exclude-types* 'snps'|'indels'|'mnps'|'other':: - comma-separated list of variant types to exclude + comma-separated list of variant types to exclude. Site is excluded if + any of the ALT alleles is of the type requested. Types are determined + by comparing the REF and ALT alleles in the VCF record not INFO tags + like INFO/INDEL or INFO/VT. Use *--exclude* to exclude based on INFO tags. *-x, --private*:: print sites where only the subset samples carry an non-reference allele. - Requires --samples or --samples-file. + Requires *--samples* or *--samples-file*. *-X, --exclude-private*:: exclude sites where only the subset samples carry an non-reference allele From 26778fa1f097a5463251ec17aca077ee0bc5df69 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Wed, 2 Sep 2015 11:49:53 +0100 Subject: [PATCH 062/211] fix FORMAT float filtering, resolves #312 hattip @mfoll for the test case --- filter.c | 1 + test/filter.10.out | 11 +++++++++++ test/filter.4.vcf | 10 ++++++++++ test/test.pl | 2 ++ 4 files changed, 24 insertions(+) create mode 100644 test/filter.10.out create mode 100644 test/filter.4.vcf diff --git a/filter.c b/filter.c index ccc844568..9ae263b44 100644 --- a/filter.c +++ b/filter.c @@ -500,6 +500,7 @@ static void filters_set_format_float(filter_t *flt, bcf1_t *line, token_t *tok) tok->nsamples = tok->nvalues = nsmpl; } } + tok->nsamples = tok->nvalues; } static void filters_set_format_string(filter_t *flt, bcf1_t *line, token_t *tok) { diff --git a/test/filter.10.out b/test/filter.10.out new file mode 100644 index 000000000..05743909c --- /dev/null +++ b/test/filter.10.out @@ -0,0 +1,11 @@ +##fileformat=VCFv4.1 +##FILTER= +##contig= +##INFO= +##INFO= +##FORMAT= +##FORMAT= +##FORMAT= +#CHROM POS ID REF ALT QUAL FILTER INFO FORMAT sample1 sample2 +chr1 1 . A T 100 PASS TEST1=10;TEST2=10 GT:TEST3:TEST4 0/1:10:10 ./.:30:30 +chr1 2 . A T 100 PASS TEST1=50;TEST2=50 GT:TEST3:TEST4 0/1:20:20 ./.:40:40 diff --git a/test/filter.4.vcf b/test/filter.4.vcf new file mode 100644 index 000000000..78ce13a5c --- /dev/null +++ b/test/filter.4.vcf @@ -0,0 +1,10 @@ +##fileformat=VCFv4.1 +##contig= +##INFO= +##INFO= +##FORMAT= +##FORMAT= +##FORMAT= +#CHROM POS ID REF ALT QUAL FILTER INFO FORMAT sample1 sample2 +chr1 1 . A T 100 . TEST1=10;TEST2=10 GT:TEST3:TEST4 0/1:10:10 0/1:30:30 +chr1 2 . A T 100 . TEST1=50;TEST2=50 GT:TEST3:TEST4 0/1:20:20 0/1:40:40 diff --git a/test/test.pl b/test/test.pl index 08ab49bba..e56347d95 100755 --- a/test/test.pl +++ b/test/test.pl @@ -144,6 +144,8 @@ test_vcf_filter($opts,in=>'filter.2',out=>'filter.8.out',args=>q[-i'FMT/GT="0/0" && AC[*]=2'],fmt=>'%POS\\t%AC[\\t%GT]\\n'); test_vcf_filter($opts,in=>'filter.2',out=>'filter.8.out',args=>q[-i'AC[*]=2 && FMT/GT="0/0"'],fmt=>'%POS\\t%AC[\\t%GT]\\n'); test_vcf_filter($opts,in=>'filter.2',out=>'filter.9.out',args=>q[-i'ALT="."'],fmt=>'%POS\\t%AC[\\t%GT]\\n'); +test_vcf_filter($opts,in=>'filter.4',out=>'filter.10.out',args=>q[-S . -i 'FORMAT/TEST3<25']); +test_vcf_filter($opts,in=>'filter.4',out=>'filter.10.out',args=>q[-S . -i 'FORMAT/TEST4<25']); test_vcf_regions($opts,in=>'regions'); test_vcf_annotate($opts,in=>'annotate',tab=>'annotate',out=>'annotate.out',args=>'-c CHROM,POS,REF,ALT,ID,QUAL,INFO/T_INT,INFO/T_FLOAT,INDEL'); test_vcf_annotate($opts,in=>'annotate',tab=>'annotate2',out=>'annotate2.out',args=>'-c CHROM,FROM,TO,T_STR'); From 0dbe41e541b5a7796a84bc19bb52e742571266af Mon Sep 17 00:00:00 2001 From: John Marshall Date: Wed, 2 Sep 2015 14:37:58 +0100 Subject: [PATCH 063/211] Avoid using C99 NAN macro CentOS 5.11's compiler doesn't believe in it, even though it accepts isnan() and other C99 library functions. Hat tip @mfoll. --- vcfstats.c | 12 +++--------- 1 file changed, 3 insertions(+), 9 deletions(-) diff --git a/vcfstats.c b/vcfstats.c index 578be7bce..1032bf87b 100644 --- a/vcfstats.c +++ b/vcfstats.c @@ -1341,7 +1341,7 @@ static void print_stats(args_t *args) uint64_t mm = stats[i].mm[T2S(GT_HOM_RR)] + stats[i].mm[T2S(GT_HET_RA)] + stats[i].mm[T2S(GT_HOM_AA)]; // Calculate r by formula 19.2 - Biostatistical Analysis 4th edition - Jerrold H. Zar smpl_r_t *smpl_r = smpl_r_array + i; - double r = NAN; + double r = 0.0; if (smpl_r->n) { double sum_crossprod = smpl_r->xy-(smpl_r->x*smpl_r->y)/smpl_r->n;//per 17.3 machine formula double x2_xx = smpl_r->x2-(smpl_r->x*smpl_r->x)/smpl_r->n; @@ -1351,14 +1351,8 @@ static void print_stats(args_t *args) printf("GC%cS\t2\t%s\t%.3f", x==0 ? 's' : 'i', args->files->samples[i], m+mm ? mm*100.0/(m+mm) : 0); printf("\t%"PRId64"\t%"PRId64"\t%"PRId64"", stats[i].m[T2S(GT_HOM_RR)],stats[i].m[T2S(GT_HET_RA)],stats[i].m[T2S(GT_HOM_AA)]); printf("\t%"PRId64"\t%"PRId64"\t%"PRId64"", stats[i].mm[T2S(GT_HOM_RR)],stats[i].mm[T2S(GT_HET_RA)],stats[i].mm[T2S(GT_HOM_AA)]); - if (isnan(r)) - { - printf("\t"NA_STRING"\n"); - } - else - { - printf("\t%f\n", r*r); - } + if (smpl_r->n && !isnan(r)) printf("\t%f\n", r*r); + else printf("\t"NA_STRING"\n"); } } } From 8e82f7d537f784382f0a6261d6450d37acff2527 Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Wed, 2 Sep 2015 15:21:45 +0100 Subject: [PATCH 064/211] update docs... after fcd451b53be8c5121f2aed587ac6b6e406218a8d and 354b980fe11568aeeab42ee77efd5ca05a1dc5cf --- doc/bcftools.1 | 83 +++++++++++++++++++++++++++++++++++++++++------ doc/bcftools.html | 68 +++++++++++++++++++++++++++++++------- doc/bcftools.txt | 2 +- 3 files changed, 131 insertions(+), 22 deletions(-) diff --git a/doc/bcftools.1 b/doc/bcftools.1 index ac2f16c68..3194bad86 100644 --- a/doc/bcftools.1 +++ b/doc/bcftools.1 @@ -2,12 +2,12 @@ .\" Title: bcftools .\" Author: [see the "AUTHORS" section] .\" Generator: DocBook XSL Stylesheets v1.76.1 -.\" Date: 2015-08-05 16:03 BST +.\" Date: 2015-09-02 15:10 BST .\" Manual: \ \& .\" Source: \ \& .\" Language: English .\" -.TH "BCFTOOLS" "1" "2015\-08\-05 16:03 BST" "\ \&" "\ \&" +.TH "BCFTOOLS" "1" "2015\-09\-02 15:10 BST" "\ \&" "\ \&" .\" ----------------------------------------------------------------- .\" * Define some portability stuff .\" ----------------------------------------------------------------- @@ -41,7 +41,7 @@ Most commands accept VCF, bgzipped VCF and BCF with filetype detected automatica BCFtools is designed to work on a stream\&. It regards an input file "\-" as the standard input (stdin) and outputs to the standard output (stdout)\&. Several commands can thus be combined with Unix pipes\&. .SS "VERSION" .sp -This manual page was last updated \fB2015\-08\-05 16:03 BST\fR and refers to bcftools git version \fB1\&.2\-106\-gef11927+\fR\&. +This manual page was last updated \fB2015\-09\-02 15:10 BST\fR and refers to bcftools git version \fB1\&.2\-119\-g0dbe41e+\fR\&. .SS "BCF1" .sp The BCF1 format output by versions of samtools <= 0\&.1\&.19 is \fBnot\fR compatible with this version of bcftools\&. To read BCF1 files one can use the view command from old versions of bcftools packaged with samtools versions <= 0\&.1\&.19 to convert to VCF, which can then be read by this version of bcftools\&. @@ -411,10 +411,35 @@ Comma\-separated list of samples to include or exclude if prefixed with "^"\&. .RS 4 File of sample names to include or exclude if prefixed with "^"\&. One sample per line\&. The command \fBbcftools call\fR -accepts an optional second column indicating ploidy (0, 1 or 2) and can parse also PED files\&. With +accepts an optional second column indicating ploidy (0, 1 or 2) or sex (as defined by +\fB\-\-ploidy\fR, for example "F" or "M"), and can parse also PED files\&. If the second column is not present, the sex "F" is assumed\&. With \fBbcftools call\fR\fB \-C\fR -\fItrio\fR, PED file is expected\&. +\fItrio\fR, PED file is expected\&. File formats examples: .RE +.sp +.if n \{\ +.RS 4 +.\} +.nf + sample1 1 + sample2 2 + sample3 2 + + or + + sample1 M + sample2 F + sample3 F + + or a \&.ped file (here is shown a minimum working example, the first column is + ignored and the last indicates sex: 1=male, 2=female) + + ignored daughterA fatherA motherA 2 + ignored sonB fatherB motherB 1 +.fi +.if n \{\ +.RE +.\} .PP \fB\-t, \-\-targets\fR [^]\fIchr\fR|\fIchr:pos\fR|\fIchr:from\-to\fR|\fIchr:from\-\fR[,\&...] .RS 4 @@ -655,6 +680,37 @@ see \fBCommon Options\fR .RE .PP +\fB\-\-ploidy\fR \fIASSEMBLY\fR[\fI?\fR] +.RS 4 +predefined ploidy, use +\fIlist\fR +(or any other unused word) to print a list of all predefined assemblies\&. Append a question mark to print the actual definition\&. See also +\fB\-\-ploidy\-file\fR\&. +.RE +.PP +\fB\-\-ploidy\-file\fR \fIFILE\fR +.RS 4 +ploidy definition given as a space/tab\-delimited list of CHROM, FROM, TO, SEX, PLOIDY\&. The SEX codes are arbitrary and correspond to the ones used by +\fB\-\-samples\-file\fR\&. The default ploidy can be given using the starred records (see below), unlisted regions have ploidy 2\&. The default ploidy definition is +.RE +.sp +.if n \{\ +.RS 4 +.\} +.nf + X 1 60000 M 1 + X 2699521 154931043 M 1 + Y 1 59373566 M 1 + Y 1 59373566 F 0 + MT 1 16569 M 1 + MT 1 16569 F 1 + * * * M 2 + * * * F 2 +.fi +.if n \{\ +.RE +.\} +.PP \fB\-r, \-\-regions\fR \fIchr\fR|\fIchr:pos\fR|\fIchr:from\-to\fR|\fIchr:from\-\fR[,\&...] .RS 4 see @@ -2806,12 +2862,12 @@ print sites where all samples are phased\&. Haploid genotypes are considered pha exclude sites where all samples are phased .RE .PP -\fB\-q, \-\-min\-af\fR \fIFLOAT\fR[\fI:nref\fR|\fI:alt1\fR|\fI:minor\fR|:\*(Aqmajor\*(Aq|:\*(Aqnonmajor\*(Aq] +\fB\-q, \-\-min\-af\fR \fIFLOAT\fR[\fI:nref\fR|\fI:alt1\fR|\fI:minor\fR|\fI:major\fR|\fI:nonmajor\fR] .RS 4 minimum allele frequency (INFO/AC / INFO/AN) of sites to be printed\&. Specifying the type of allele is optional and can be set to non\-reference (\fInref\fR, the default), 1st alternate (\fIalt1\fR), the least frequent (\fIminor\fR), the most frequent (\fImajor\fR) or sum of all but the most frequent (\fInonmajor\fR) alleles\&. .RE .PP -\fB\-Q, \-\-max\-af\fR \fIFLOAT\fR[\fI:nref\fR|\fI:alt1\fR|\fI:minor\fR|:\*(Aqmajor\*(Aq|:\*(Aqnonmajor\*(Aq] +\fB\-Q, \-\-max\-af\fR \fIFLOAT\fR[\fI:nref\fR|\fI:alt1\fR|\fI:minor\fR|\fI:major\fR|\fI:nonmajor\fR] .RS 4 maximum allele frequency (INFO/AC / INFO/AN) of sites to be printed\&. Specifying the type of allele is optional and can be set to non\-reference (\fInref\fR, the default), 1st alternate (\fIalt1\fR), the least frequent (\fIminor\fR), the most frequent (\fImajor\fR) or sum of all but the most frequent (\fInonmajor\fR) alleles\&. .RE @@ -2828,17 +2884,24 @@ exclude sites without a called genotype .PP \fB\-v, \-\-types\fR \fIsnps\fR|\fIindels\fR|\fImnps\fR|\fIother\fR .RS 4 -comma\-separated list of variant types to select +comma\-separated list of variant types to select\&. Site is selected if any of the ALT alleles is of the type requested\&. Types are determined by comparing the REF and ALT alleles in the VCF record not INFO tags like INFO/INDEL or INFO/VT\&. Use +\fB\-\-include\fR +to select based on INFO tags\&. .RE .PP \fB\-V, \-\-exclude\-types\fR \fIsnps\fR|\fIindels\fR|\fImnps\fR|\fIother\fR .RS 4 -comma\-separated list of variant types to exclude +comma\-separated list of variant types to exclude\&. Site is excluded if any of the ALT alleles is of the type requested\&. Types are determined by comparing the REF and ALT alleles in the VCF record not INFO tags like INFO/INDEL or INFO/VT\&. Use +\fB\-\-exclude\fR +to exclude based on INFO tags\&. .RE .PP \fB\-x, \-\-private\fR .RS 4 -print sites where only the subset samples carry an non\-reference allele\&. Requires \-\-samples or \-\-samples\-file\&. +print sites where only the subset samples carry an non\-reference allele\&. Requires +\fB\-\-samples\fR +or +\fB\-\-samples\-file\fR\&. .RE .PP \fB\-X, \-\-exclude\-private\fR diff --git a/doc/bcftools.html b/doc/bcftools.html index 630794e1b..a32fa9ddf 100644 --- a/doc/bcftools.html +++ b/doc/bcftools.html @@ -1,13 +1,13 @@ -bcftools

    Name

    bcftools — utilities for variant calling and manipulating VCFs and BCFs.

    Synopsis

    bcftools [--version|--version-only] [--help] [COMMAND] [OPTIONS]

    DESCRIPTION

    BCFtools is a set of utilities that manipulate variant calls in the Variant +bcftools

    Name

    bcftools — utilities for variant calling and manipulating VCFs and BCFs.

    Synopsis

    bcftools [--version|--version-only] [--help] [COMMAND] [OPTIONS]

    DESCRIPTION

    BCFtools is a set of utilities that manipulate variant calls in the Variant Call Format (VCF) and its binary counterpart BCF. All commands work transparently with both VCFs and BCFs, both uncompressed and BGZF-compressed.

    Most commands accept VCF, bgzipped VCF and BCF with filetype detected automatically even when streaming from a pipe. Indexed VCF and BCF will work in all situations. Un-indexed VCF and BCF and streams will work in most, but not all situations.

    BCFtools is designed to work on a stream. It regards an input file "-" as the standard input (stdin) and outputs to the standard output (stdout). Several -commands can thus be combined with Unix pipes.

    VERSION

    This manual page was last updated 2015-08-05 16:03 BST and refers to bcftools git version 1.2-106-gef11927+.

    BCF1

    The BCF1 format output by versions of samtools <= 0.1.19 is not +commands can thus be combined with Unix pipes.

    VERSION

    This manual page was last updated 2015-09-02 15:10 BST and refers to bcftools git version 1.2-119-g0dbe41e+.

    BCF1

    The BCF1 format output by versions of samtools <= 0.1.19 is not compatible with this version of bcftools. To read BCF1 files one can use the view command from old versions of bcftools packaged with samtools versions <= 0.1.19 to convert to VCF, which can then be read by @@ -151,14 +151,32 @@ Comma-separated list of samples to include or exclude if prefixed with "^".

    --S, --samples-file FILE +-S, --samples-file FILE
    File of sample names to include or exclude if prefixed with "^". One sample per line. The command bcftools call accepts an optional second - column indicating ploidy (0, 1 or 2) and can parse also PED files. - With bcftools call -C trio, PED file is expected. -
    + column indicating ploidy (0, 1 or 2) or sex (as defined by + --ploidy, for example "F" or "M"), and can parse also PED + files. If the second column is not present, + the sex "F" is assumed. + With bcftools call -C trio, PED file is expected. File + formats examples: +
  •     sample1    1
    +    sample2    2
    +    sample3    2
    +
    +  or
    +
    +    sample1    M
    +    sample2    F
    +    sample3    F
    +
    +  or a .ped file (here is shown a minimum working example, the first column is
    +  ignored and the last indicates sex: 1=male, 2=female)
    +
    +    ignored daughterA fatherA motherA 2
    +    ignored sonB fatherB motherB 1
    -t, --targets [^]chr|chr:pos|chr:from-to|chr:from-[,…]
    Similar as -r, --regions, but the next position is accessed by streaming the @@ -323,6 +341,27 @@
    see Common Options
    +--ploidy ASSEMBLY[?] +
    + predefined ploidy, use list (or any other unused word) to print a list + of all predefined assemblies. Append a question mark to print the actual + definition. See also --ploidy-file. +
    +--ploidy-file FILE +
    + ploidy definition given as a space/tab-delimited list of + CHROM, FROM, TO, SEX, PLOIDY. The SEX codes are arbitrary and + correspond to the ones used by --samples-file. + The default ploidy can be given using the starred records (see + below), unlisted regions have ploidy 2. The default ploidy definition is +
        X 1 60000 M 1
    +    X 2699521 154931043 M 1
    +    Y 1 59373566 M 1
    +    Y 1 59373566 F 0
    +    MT 1 16569 M 1
    +    MT 1 16569 F 1
    +    *  * *     M 2
    +    *  * *     F 2
    -r, --regions chr|chr:pos|chr:from-to|chr:from-[,…]
    see Common Options @@ -1560,7 +1599,7 @@
    exclude sites where all samples are phased
    --q, --min-af FLOAT[:nref|:alt1|:minor|:'major'|:'nonmajor'] +-q, --min-af FLOAT[:nref|:alt1|:minor|:major|:nonmajor]
    minimum allele frequency (INFO/AC / INFO/AN) of sites to be printed. Specifying the type of allele is optional and can be set to @@ -1568,7 +1607,7 @@ frequent (minor), the most frequent (major) or sum of all but the most frequent (nonmajor) alleles.
    --Q, --max-af FLOAT[:nref|:alt1|:minor|:'major'|:'nonmajor'] +-Q, --max-af FLOAT[:nref|:alt1|:minor|:major|:nonmajor]
    maximum allele frequency (INFO/AC / INFO/AN) of sites to be printed. Specifying the type of allele is optional and can be set to @@ -1586,16 +1625,23 @@
    -v, --types snps|indels|mnps|other
    - comma-separated list of variant types to select + comma-separated list of variant types to select. Site is selected if + any of the ALT alleles is of the type requested. Types are determined + by comparing the REF and ALT alleles in the VCF record not INFO tags + like INFO/INDEL or INFO/VT. Use --include to select based on INFO + tags.
    -V, --exclude-types snps|indels|mnps|other
    - comma-separated list of variant types to exclude + comma-separated list of variant types to exclude. Site is excluded if + any of the ALT alleles is of the type requested. Types are determined + by comparing the REF and ALT alleles in the VCF record not INFO tags + like INFO/INDEL or INFO/VT. Use --exclude to exclude based on INFO tags.
    -x, --private
    print sites where only the subset samples carry an non-reference allele. - Requires --samples or --samples-file. + Requires --samples or --samples-file.
    -X, --exclude-private
    diff --git a/doc/bcftools.txt b/doc/bcftools.txt index 728e8f515..bd3270ba0 100644 --- a/doc/bcftools.txt +++ b/doc/bcftools.txt @@ -190,7 +190,7 @@ specific commands to see if they apply. Comma-separated list of samples to include or exclude if prefixed with "^". -*-S, --samples-file* [^]'FILE':: +*-S, --samples-file* [^]'FILE'[[samples_file]]:: File of sample names to include or exclude if prefixed with "^". One sample per line. The command *<>* accepts an optional second From cabeeb269722a0c6882574dd13dd81b83957ccc2 Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Wed, 2 Sep 2015 15:53:52 +0100 Subject: [PATCH 065/211] plot-vcfstats: fix bug in merging multiple stats files d4c7d5c73db224084f94f11d0b0fd40b2ef77d38 introduced new columns to the DP section of the stats files for the site depth distribiution. However when run without the -s option this the genotype ditribution will be now exist, but be filled with zeros causing the bug in #311. Fixes #311 and adds a test for this. Todo check other merges are working ok after any column additions. --- plot-vcfstats | 22 ++++++++++++--- test/check.chk | 2 ++ test/check.vcf | 7 +++-- test/check_merge.chk | 65 ++++++++++++++++++++++++++++++++++++++++++++ test/test.pl | 16 +++++++++-- 5 files changed, 102 insertions(+), 10 deletions(-) create mode 100644 test/check_merge.chk diff --git a/plot-vcfstats b/plot-vcfstats index 2ed9ec7f5..56cc4c77e 100755 --- a/plot-vcfstats +++ b/plot-vcfstats @@ -474,10 +474,24 @@ sub merge_dp { my ($a,$b) = @_; add_to_values($a,$b,\&cmp_num_op); - # recalculate fraction of GTs, cannot be simply summed - my $sum = 0; - for (my $i=0; $i<@$a; $i++) { $sum += $$a[$i][1]; } - for (my $i=0; $i<@$a; $i++) { $$a[$i][2] = $$a[$i][1]*100./$sum; } + # recalculate fraction of GTs and fraction of sites, cannot be simply summed + my $gsum = 0; # genotype sum + my $ssum = 0; # site sum + for (my $i=0; $i<@$a; $i++) + { + $gsum += $$a[$i][1]; + if (@{$$a[$i]}>3) { + $ssum += $$a[$i][3]; + } + else{ + push @{$$a[$i]}, (0,0); # older stats files will not have last 2 columns for (number of sites, fraction of sites), so fill in as zero + } + } + for (my $i=0; $i<@$a; $i++) + { + $$a[$i][2] = $gsum ? $$a[$i][1]*100./$gsum : 0; + $$a[$i][4] = $ssum ? $$a[$i][3]*100./$ssum : 0; + } } sub merge_GCsS diff --git a/test/check.chk b/test/check.chk index 0f78e654e..7792e00a4 100644 --- a/test/check.chk +++ b/test/check.chk @@ -69,6 +69,8 @@ DP 0 30 2 5.555556 0 0.000000 DP 0 31 16 44.444444 0 0.000000 DP 0 32 4 11.111111 0 0.000000 DP 0 35 4 11.111111 0 0.000000 +DP 0 60 0 0.000000 1 33.333333 +DP 0 62 0 0.000000 2 66.666667 # PSC, Per-sample counts # PSC [2]id [3]sample [4]nRefHom [5]nNonRefHom [6]nHets [7]nTransitions [8]nTransversions [9]nIndels [10]average depth [11]nSingletons PSC 0 A 0 2 4 3 2 9 28.7 1 diff --git a/test/check.vcf b/test/check.vcf index 8fe38e40c..055fd4342 100644 --- a/test/check.vcf +++ b/test/check.vcf @@ -1,6 +1,7 @@ ##fileformat=VCFv4.1 ##INFO= ##FORMAT= +##INFO= ##INFO= ##FORMAT= ##FORMAT= @@ -27,9 +28,9 @@ 1 3184885 . TAAAA TA,T 61.5 PASS AN=4;AC=2,2 GT:GQ:DP 1/2:12:10 1/2:12:10 2 3199812 . G GTT,GT 82.7 PASS AN=4;AC=2,2 GT:GQ:DP 1/2:322:26 1/2:322:26 3 3212016 . CTT C,CT 79 PASS AN=4;AC=2,2 GT:GQ:DP 1/2:91:26 1/2:91:26 -4 3258448 . TACACACAC T 59.9 PASS AN=4;AC=2 GT:GQ:DP 0/1:325:31 0/1:325:31 -4 3258449 . GCAAA GA,G 59.9 PASS AN=4;AC=2 GT:GQ:DP 0/1:325:31 0/1:325:31 -4 3258450 . AAAAGAAAAAG A,AAAAAAG 59.9 PASS AN=4;AC=2 GT:GQ:DP 0/1:325:31 0/1:325:31 +4 3258448 . TACACACAC T 59.9 PASS DP=62;AN=4;AC=2 GT:GQ:DP 0/1:325:31 0/1:325:31 +4 3258449 . GCAAA GA,G 59.9 PASS DP=62;AN=4;AC=2 GT:GQ:DP 0/1:325:31 0/1:325:31 +4 3258450 . AAAAGAAAAAG A,AAAAAAG 59.9 PASS DP=60;AN=4;AC=2 GT:GQ:DP 0/1:325:31 0/1:325:31 4 3258451 . AAA AGT 59.9 PASS AN=4;AC=2 GT:GQ:DP 0/1:325:31 0/1:325:31 4 3258452 . AAA AGA 59.9 PASS AN=4;AC=2 GT:GQ:DP 0/1:325:31 0/1:325:31 4 3258453 . AACA AGA 59.9 PASS AN=4;AC=2 GT:GQ:DP 0/1:325:31 0/1:325:31 diff --git a/test/check_merge.chk b/test/check_merge.chk new file mode 100644 index 000000000..846be5bf5 --- /dev/null +++ b/test/check_merge.chk @@ -0,0 +1,65 @@ +# +# Definition of sets +# ID [2]id [3]tab-separated file names +# SN, Summary numbers +# SN [2]id [3]key [4]value +SN 0 number of indels: 9 +SN 0 number of records: 18 +SN 0 number of multiallelic SNP sites: 1 +SN 0 number of SNPs: 5 +SN 0 number of others: 2 +SN 0 number of MNPs: 1 +SN 0 number of multiallelic sites: 6 +SN 0 number of samples: 2 +SN 0 number of no-ALTs: 1 +# # TSTV, transition/transversions: +# TSTV [2]id [3]ts [4]tv [5]ts/tv [6]ts (1st ALT) [7]tv (1st ALT) [8]ts/tv (1st ALT) +TSTV 0 3 2 1.50 3 1 3.00 +# Sis, Singleton stats +# SiS [2]id [3]allele count [4]number of SNPs [5]number of transitions [6]number of transversions [7]number of indels [8]repeat-consistent [9]repeat-inconsistent [10]not applicable +SiS 0 1 3 1 2 0 0 0 0 +# AF, Stats by non-reference allele frequency +# AF [2]id [3]allele frequency [4]number of SNPs [5]number of transitions [6]number of transversions [7]number of indels [8]repeat-consistent [9]repeat-inconsistent [10]not applicable +AF 0 0.000000 3 1 2 2 0 0 2 +AF 0 49.000000 0 0 0 12 0 0 12 +AF 0 74.000000 1 1 0 0 0 0 0 +AF 0 99.000000 1 1 0 0 0 0 0 +# IDD, InDel distribution +# IDD [2]id [3]length (deletions negative) [4]count +IDD 0 -10 1 +IDD 0 -8 1 +IDD 0 -4 3 +IDD 0 -3 4 +IDD 0 -2 1 +IDD 0 -1 2 +IDD 0 1 1 +IDD 0 2 1 +# ST, Substitution types +# ST [2]id [3]type [4]count +ST 0 A>C 0 +ST 0 A>G 0 +ST 0 A>T 0 +ST 0 C>A 0 +ST 0 C>G 0 +ST 0 C>T 0 +ST 0 G>A 3 +ST 0 G>C 1 +ST 0 G>T 1 +ST 0 T>A 0 +ST 0 T>C 0 +ST 0 T>G 0 +# DP, Depth distribution +# DP [2]id [3]bin [4]number of genotypes [5]fraction of genotypes (%) [6]number of sites [7]fraction of sites (%) +DP 0 60 0 0.000000 1 33.333333 +DP 0 62 0 0.000000 2 66.666667 +# QUAL, Stats by quality +# QUAL [2]id [3]Quality [4]number of SNPs [5]number of transitions (1st ALT) [6]number of transversions (1st ALT) [7]number of indels +QUAL 0 12 1 0 1 1 +QUAL 0 45 0 0 0 1 +QUAL 0 59 2 1 0 3 +QUAL 0 60 1 1 0 0 +QUAL 0 61 0 0 0 1 +QUAL 0 79 0 0 0 1 +QUAL 0 82 0 0 0 1 +QUAL 0 90 1 1 0 0 +QUAL 0 342 0 0 0 1 diff --git a/test/test.pl b/test/test.pl index 09087137d..595b8c0da 100755 --- a/test/test.pl +++ b/test/test.pl @@ -44,6 +44,7 @@ test_vcf_idxstats($opts,in=>'empty',args=>'-s',out=>'empty.idx.out'); test_vcf_idxstats($opts,in=>'empty',args=>'-n',out=>'empty.idx_count.out'); test_vcf_check($opts,in=>'check',out=>'check.chk'); +test_vcf_check_merge($opts,in=>'check',out=>'check_merge.chk'); test_vcf_stats($opts,in=>['stats.a','stats.b'],out=>'stats.chk',args=>'-s -'); test_vcf_isec($opts,in=>['isec.a','isec.b'],out=>'isec.ab.out',args=>'-n =2'); test_vcf_isec($opts,in=>['isec.a','isec.b'],out=>'isec.ab.flt.out',args=>'-n =2 -i"STRLEN(REF)==2"'); @@ -128,8 +129,6 @@ test_vcf_view($opts,in=>'view.minmaxac',out=>'view.minmaxac.1.out',args=>q[-H -q0.3:major],reg=>''); test_vcf_call($opts,in=>'mpileup',out=>'mpileup.1.out',args=>'-mv'); test_vcf_call($opts,in=>'mpileup',out=>'mpileup.2.out',args=>'-mvg0'); -test_vcf_call($opts,in=>'mpileup.X',out=>'mpileup.X.out',args=>'-mv --ploidy-file {PATH}/mpileup.ploidy -S {PATH}/mpileup.samples'); -test_vcf_call($opts,in=>'mpileup.X',out=>'mpileup.X.out',args=>'-mv --ploidy-file {PATH}/mpileup.ploidy -S {PATH}/mpileup.ped'); test_vcf_call_cAls($opts,in=>'mpileup',out=>'mpileup.cAls.out',tab=>'mpileup'); test_vcf_filter($opts,in=>'filter.1',out=>'filter.1.out',args=>'-mx -g2 -G2'); test_vcf_filter($opts,in=>'filter.2',out=>'filter.2.out',args=>q[-e'QUAL==59.2 || (INDEL=0 & (FMT/GQ=25 | FMT/DP=10))' -sModified -S.]); @@ -423,6 +422,18 @@ sub test_vcf_check test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools stats -s - $$opts{tmp}/$args{in}.vcf.gz | grep -v '^# The command' | grep -v '^# This' | grep -v '^ID\t'"); test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools view -Ob $$opts{tmp}/$args{in}.vcf.gz | $$opts{bin}/bcftools stats -s - | grep -v '^# The command' | grep -v '^# This' | grep -v '^ID\t'"); } + +sub test_vcf_check_merge +{ + my ($opts,%args) = @_; + bgzip_tabix_vcf($opts,$args{in}); + cmd("$$opts{bin}/bcftools stats -r 1 $$opts{tmp}/$args{in}.vcf.gz > $$opts{tmp}/$args{in}.1.chk"); + cmd("$$opts{bin}/bcftools stats -r 2 $$opts{tmp}/$args{in}.vcf.gz > $$opts{tmp}/$args{in}.2.chk"); + cmd("$$opts{bin}/bcftools stats -r 3 $$opts{tmp}/$args{in}.vcf.gz > $$opts{tmp}/$args{in}.3.chk"); + cmd("$$opts{bin}/bcftools stats -r 4 $$opts{tmp}/$args{in}.vcf.gz > $$opts{tmp}/$args{in}.4.chk"); + test_cmd($opts,%args,cmd=>"$$opts{bin}/plot-vcfstats -m $$opts{tmp}/$args{in}.1.chk $$opts{tmp}/$args{in}.2.chk $$opts{tmp}/$args{in}.3.chk $$opts{tmp}/$args{in}.4.chk | grep -v 'plot-vcfstats' | grep -v '^# The command' | grep -v '^# This' | grep -v '^ID\t'"); +} + sub test_vcf_stats { my ($opts,%args) = @_; @@ -530,7 +541,6 @@ sub test_vcf_view sub test_vcf_call { my ($opts,%args) = @_; - $args{args} =~ s/{PATH}/$$opts{path}/g; test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools call $args{args} $$opts{path}/$args{in}.vcf | grep -v ^##bcftools_"); test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools call -Ob $args{args} $$opts{path}/$args{in}.vcf | $$opts{bin}/bcftools view | grep -v ^##bcftools_"); } From 03cfc6a3058f0e02fe50b891b98248a16dbdd5ec Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Wed, 2 Sep 2015 16:28:03 +0100 Subject: [PATCH 066/211] add back in tests accidentally deleted in previous commit --- test/test.pl | 5 ++++- 1 file changed, 4 insertions(+), 1 deletion(-) diff --git a/test/test.pl b/test/test.pl index 595b8c0da..d2497c4be 100755 --- a/test/test.pl +++ b/test/test.pl @@ -129,6 +129,8 @@ test_vcf_view($opts,in=>'view.minmaxac',out=>'view.minmaxac.1.out',args=>q[-H -q0.3:major],reg=>''); test_vcf_call($opts,in=>'mpileup',out=>'mpileup.1.out',args=>'-mv'); test_vcf_call($opts,in=>'mpileup',out=>'mpileup.2.out',args=>'-mvg0'); +test_vcf_call($opts,in=>'mpileup.X',out=>'mpileup.X.out',args=>'-mv --ploidy-file {PATH}/mpileup.ploidy -S {PATH}/mpileup.samples'); +test_vcf_call($opts,in=>'mpileup.X',out=>'mpileup.X.out',args=>'-mv --ploidy-file {PATH}/mpileup.ploidy -S {PATH}/mpileup.ped'); test_vcf_call_cAls($opts,in=>'mpileup',out=>'mpileup.cAls.out',tab=>'mpileup'); test_vcf_filter($opts,in=>'filter.1',out=>'filter.1.out',args=>'-mx -g2 -G2'); test_vcf_filter($opts,in=>'filter.2',out=>'filter.2.out',args=>q[-e'QUAL==59.2 || (INDEL=0 & (FMT/GQ=25 | FMT/DP=10))' -sModified -S.]); @@ -541,7 +543,8 @@ sub test_vcf_view sub test_vcf_call { my ($opts,%args) = @_; - test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools call $args{args} $$opts{path}/$args{in}.vcf | grep -v ^##bcftools_"); + $args{args} =~ s/{PATH}/$$opts{path}/g; + test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools call $args{args} $$opts{path}/$args{in}.vcf | grep -v ^##bcftools_"); test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools call -Ob $args{args} $$opts{path}/$args{in}.vcf | $$opts{bin}/bcftools view | grep -v ^##bcftools_"); } sub test_vcf_call_cAls From 590b69775fe04ef57527a3fcc071fb9ce4a9babb Mon Sep 17 00:00:00 2001 From: John Marshall Date: Wed, 2 Sep 2015 16:34:27 +0100 Subject: [PATCH 067/211] Fix whitespace [trivial] --- test/test.pl | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/test/test.pl b/test/test.pl index d2497c4be..2564c80d5 100755 --- a/test/test.pl +++ b/test/test.pl @@ -543,8 +543,8 @@ sub test_vcf_view sub test_vcf_call { my ($opts,%args) = @_; - $args{args} =~ s/{PATH}/$$opts{path}/g; - test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools call $args{args} $$opts{path}/$args{in}.vcf | grep -v ^##bcftools_"); + $args{args} =~ s/{PATH}/$$opts{path}/g; + test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools call $args{args} $$opts{path}/$args{in}.vcf | grep -v ^##bcftools_"); test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools call -Ob $args{args} $$opts{path}/$args{in}.vcf | $$opts{bin}/bcftools view | grep -v ^##bcftools_"); } sub test_vcf_call_cAls From 5cf52c44249ffdb4c823e0ae40eea48915a80523 Mon Sep 17 00:00:00 2001 From: Jason Piper Date: Thu, 3 Sep 2015 11:12:43 +0800 Subject: [PATCH 068/211] Add test for splitting and merging in one go --- test/norm.split.and.norm.out | 64 ++++++++++++++++++++++++++++++++++++ test/test.pl | 1 + 2 files changed, 65 insertions(+) create mode 100644 test/norm.split.and.norm.out diff --git a/test/norm.split.and.norm.out b/test/norm.split.and.norm.out new file mode 100644 index 000000000..86154affc --- /dev/null +++ b/test/norm.split.and.norm.out @@ -0,0 +1,64 @@ +##fileformat=VCFv4.1 +##FILTER= +##INFO= +##FORMAT= +##FORMAT= +##FORMAT= +##contig= +##contig= +##contig= +##contig= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##INFO= +#CHROM POS ID REF ALT QUAL FILTER INFO FORMAT XY00001 XY00002 +1 105 . TAAACCCTA T 999 PASS INDEL;AN=4;AC=2;DP=19;ISTR=SomeString;XRF=1e+06,2e+06;XRI=1111,2222;XRS=AAA,BBB;XAF=1e+06;XAI=1111;XAS=AAA;XGF=1e+06,2e+06,3e+06;XGI=1111,2222,3333;XGS=A,B,C GT:PL:DP:FRF:FRI:FRS:FAF:FAI:FAS:FGF:FGI:FGS 1/0:1,2,3:1:1e+06,2e+06:1111,2222:AAAA,BBB:1e+06:1111:A:1e+06,2e+06,3e+06:1111,2222,3333:A,BB,CCC 1/0:1,2,3:1:1e+06,2e+06:1111,2222:AAAA,BBB:1e+06:1111:A:1e+06,2e+06,3e+06:1111,2222,3333:A,BB,CCC +1 105 . TA T 999 PASS INDEL;AN=4;AC=2;DP=19;ISTR=SomeString;XRF=1e+06,500000;XRI=1111,5555;XRS=AAA,DDD;XAF=500000;XAI=5555;XAS=DDD;XGF=1e+06,500000,9e+09;XGI=1111,5555,9999;XGS=A,E,F GT:PL:DP:FRF:FRI:FRS:FAF:FAI:FAS:FGF:FGI:FGS 0/1:1,4,6:1:1e+06,500000:1111,5555:AAAA,CC:500000:5555:BB:1e+06,500000,9e+09:1111,5555,9999:A,EEEE,FFFFF 0/1:1,4,6:1:1e+06,500000:1111,5555:AAAA,CC:500000:5555:BB:1e+06,500000,9e+09:1111,5555,9999:A,EEEE,FFFFF +2 1 . GGGCGTCTCATAGCTGGAGCAATGGCGAGCGCCTGGACAAGGGAGGGGAAGGGGTTCTTATTACTGACGCGGGTAGCCCCTACTGCTGTGTGGTTCCCCTATTTTTTTTTTTTTCTTTTTGAGACGGAGTCTCGCTCTGTCACCCAGGCTGGAGTGCAGTGGCACAATCTCGGCTCACTGCAAGCTCCACC ACG 999 PASS INDEL;AN=4;AC=2 GT:DP 1/0:1 1/0:1 +2 101 . A ATT 999 PASS INDEL;AN=4;AC=4 GT:DP 1/1:1 1/1:1 +2 101 . A AT 999 PASS INDEL;AN=4;AC=2 GT:DP 0/1:1 0/1:1 +2 114 . T TTC 999 PASS INDEL;AN=4;AC=2 GT:DP 1/0:1 1/0:1 +2 115 . C T 999 PASS INDEL;AN=4;AC=4 GT:DP 1/1:1 1/1:1 +20 3 . G CT 999 PASS INDEL;AN=4;AC=2 GT 0/1 0/1 +20 5 . TG CT 999 PASS INDEL;AN=4;AC=2 GT 1/0 1/0 +20 5 . TGG T . PASS INDEL;AN=4;AC=2 GT:PL:DP 0/1:1,4,6:1 0/1:1,4,6:1 +20 5 . T TG . PASS INDEL;AN=4;AC=0 GT:PL:DP 0/0:1,7,10:1 0/0:1,7,10:1 +20 5 . TGGG AC . PASS INDEL;AN=4;AC=0 GT:PL:DP 0/0:1,11,15:1 0/0:1,11,15:1 +20 6 . GGG AC . PASS INDEL;AN=4;AC=2 GT:PL:DP 1/0:1,2,3:1 1/0:1,2,3:1 +20 59 . AG . 999 PASS AN=4 GT:PL:DP 0/0:0:4 0/0:0:4 +20 81 . A C 999 PASS AN=4;AC=2 GT:PL:DP 0/1:255,0,255:13 0/1:255,0,255:13 +20 84 . G T 999 PASS AN=4;AC=2 GT:PL:DP 0/1:255,0,255:13 0/1:255,0,255:13 +20 95 . T A 999 PASS AN=4;AC=2 GT:PL:DP 0/1:255,0,255:13 0/1:255,0,255:13 +20 95 . TCACCG AAAAAA 999 PASS AN=4;AC=2 GT:PL:DP 0/1:255,0,255:13 0/1:255,0,255:13 +20 273 . C CAA 999 PASS INDEL;AN=4;AC=2 GT:PL:DP 1/0:0,3,5:1 1/0:0,3,5:1 +20 273 . C CAAA 999 PASS INDEL;AN=4;AC=2 GT:PL:DP 0/1:0,3,5:1 0/1:0,3,5:1 +20 273 . C CAAAAAAAAAA 999 PASS INDEL;AN=0;AC=0 GT:PL:DP ./.:0,0,0:0 ./.:0,0,0:0 +20 273 . C CAA 999 PASS INDEL;AN=0;AC=0 GT:PL:DP ./.:0,0,0:0 ./.:0,0,0:0 +20 275 . A C 999 PASS INDEL;AN=2;AC=0 GT:PL:DP:FGF:FGI:FGS:FSTR 0:0,0:0:1e+06,2e+06:1111,2222:A,BB:WORD 0:0,0:0:1e+06,2e+06:1111,2222:A,BB:WORD +20 275 . A G 999 PASS INDEL;AN=2;AC=2 GT:PL:DP:FGF:FGI:FGS:FSTR 1:0,0:0:1e+06,3e+06:1111,3333:A,CCC:WORD 1:0,0:0:1e+06,3e+06:1111,3333:A,CCC:WORD +20 300 . T C 999 PASS INDEL;AN=0;AC=0 GT:PL:DP ./.:0,0,0:0 ./.:0,0,0:0 +20 300 . T G 999 PASS INDEL;AN=0;AC=0 GT:PL:DP ./.:0,0,0:0 ./.:0,0,0:0 +21 1 id T TTTATTA 999 PASS INDEL;AN=0;AC=0 GT:DP ./.:0 ./.:0 +21 1 id T TTTATTATTATTATTATTA 999 PASS INDEL;AN=0;AC=0 GT:DP ./.:0 ./.:0 +21 1 id TTTA T 999 PASS INDEL;AN=0;AC=0 GT:DP ./.:0 ./.:0 +21 1 id T TTATTA 999 PASS INDEL;AN=0;AC=0 GT:DP ./.:0 ./.:0 diff --git a/test/test.pl b/test/test.pl index 2564c80d5..6f5056519 100755 --- a/test/test.pl +++ b/test/test.pl @@ -92,6 +92,7 @@ test_vcf_query($opts,in=>'annotate2',out=>'query.21.out',args=>q[-e'IFLT="."' -f'%POS %IFLT\\n']); test_vcf_norm($opts,in=>'norm',out=>'norm.out',fai=>'norm'); test_vcf_norm($opts,in=>'norm.split',out=>'norm.split.out',args=>'-m-'); +test_vcf_norm($opts,in=>'norm.split',fai=>'norm',out=>'norm.split.and.norm.out',args=>'-m-'); test_vcf_norm($opts,in=>'norm.merge',out=>'norm.merge.out',args=>'-m+'); test_vcf_norm($opts,in=>'norm.merge.2',out=>'norm.merge.2.out',args=>'-m+'); test_vcf_norm($opts,in=>'norm.merge.3',out=>'norm.merge.3.out',args=>'-m+'); From 77d9c1801e05bae982b1a8064f65d8a6f8c9830c Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Thu, 3 Sep 2015 14:11:07 +0100 Subject: [PATCH 069/211] Fix in consensus, last position in the buffer was not updated. Resolves #306 --- consensus.c | 2 +- test/consensus2.1.out | 10 ++++++++++ test/consensus2.2.out | 12 ++++++++++++ test/consensus2.fa | 10 ++++++++++ test/consensus2.vcf | 9 +++++++++ test/test.pl | 2 ++ 6 files changed, 44 insertions(+), 1 deletion(-) create mode 100644 test/consensus2.1.out create mode 100644 test/consensus2.2.out create mode 100644 test/consensus2.fa create mode 100644 test/consensus2.vcf diff --git a/consensus.c b/consensus.c index 732526a63..7a615fef0 100644 --- a/consensus.c +++ b/consensus.c @@ -567,7 +567,7 @@ static void consensus(args_t *args) } // is the cached fasta buffer full enough? if not, read more fasta, no flushing - if ( args->fa_ori_pos + args->fa_buf.l - args->fa_mod_off <= rec->pos + rec->rlen ) + if ( args->fa_ori_pos + args->fa_buf.l - args->fa_mod_off < rec->pos + rec->rlen ) { unread_vcf_line(args, rec_ptr); break; diff --git a/test/consensus2.1.out b/test/consensus2.1.out new file mode 100644 index 000000000..65ec8528c --- /dev/null +++ b/test/consensus2.1.out @@ -0,0 +1,10 @@ +>1 +CTACCATATGTGACATATAAAAAAGAACATAACCTACGTATCAACTAAAGTGGTTGTTA +>2 +CCTACCATATGTGACATATAAAAAAGAACATAACCTACGTATCAACTAAAGTGGTTGTTA +>3 +CCCTACCATATGTGACATATAAAAAAGAACATAACCTACGTATCAACTAAAGTGGTTGTT +A +>4 +CCCCTACCATATGTGACATATAAAAAAGAACATAACCTACGTATCAACTAAAGTGGTTGT +TA diff --git a/test/consensus2.2.out b/test/consensus2.2.out new file mode 100644 index 000000000..2040354d9 --- /dev/null +++ b/test/consensus2.2.out @@ -0,0 +1,12 @@ +>1 +CTACCATATGTGACATATAAAAAAGAACATAACCTACGTATCAACTAAAGTGGTTGTTCA +A +>2 +CCTACCATATGTGACATATAAAAAAGAACATAACCTACGTATCAACTAAAGTGGTTGTTC +AA +>3 +CCCTACCATATGTGACATATAAAAAAGAACATAACCTACGTATCAACTAAAGTGGTTGTT +CAA +>4 +CCCCTACCATATGTGACATATAAAAAAGAACATAACCTACGTATCAACTAAAGTGGTTGT +TCAA diff --git a/test/consensus2.fa b/test/consensus2.fa new file mode 100644 index 000000000..9f3522f0c --- /dev/null +++ b/test/consensus2.fa @@ -0,0 +1,10 @@ +>1 +CTACCATATGTGACATATAAAAAAGAACATAACCTACGTATCAACTAAAGTGGTTGTTC +>2 +CCTACCATATGTGACATATAAAAAAGAACATAACCTACGTATCAACTAAAGTGGTTGTTC +>3 +CCCTACCATATGTGACATATAAAAAAGAACATAACCTACGTATCAACTAAAGTGGTTGTT +C +>4 +CCCCTACCATATGTGACATATAAAAAAGAACATAACCTACGTATCAACTAAAGTGGTTGT +TC diff --git a/test/consensus2.vcf b/test/consensus2.vcf new file mode 100644 index 000000000..ca4c0595d --- /dev/null +++ b/test/consensus2.vcf @@ -0,0 +1,9 @@ +##fileformat=VCFv4.2 +##FORMAT= +##INFO= +##ALT= +#CHROM POS ID REF ALT QUAL FILTER INFO FORMAT NA001 +1 59 . C a,Caa . PASS . GT 1|2 +2 60 . C a,Caa . PASS . GT 1|2 +3 61 . C a,Caa . PASS . GT 1|2 +4 62 . C a,Caa . PASS . GT 1|2 diff --git a/test/test.pl b/test/test.pl index 2564c80d5..f1a589c38 100755 --- a/test/test.pl +++ b/test/test.pl @@ -206,6 +206,8 @@ test_vcf_consensus_chain($opts,in=>'consensus',out=>'consensus.3.chain',chain=>'consensus.3.chain',fa=>'consensus.fa',mask=>'consensus.tab',args=>'-i'); test_vcf_consensus($opts,in=>'consensus',out=>'consensus.4.out',fa=>'consensus.fa',args=>'-H 1'); test_vcf_consensus_chain($opts,in=>'consensus',out=>'consensus.4.chain',chain=>'consensus.4.chain',fa=>'consensus.fa',args=>'-H 1'); +test_vcf_consensus($opts,in=>'consensus2',out=>'consensus2.1.out',fa=>'consensus2.fa',args=>'-H 1'); +test_vcf_consensus($opts,in=>'consensus2',out=>'consensus2.2.out',fa=>'consensus2.fa',args=>'-H 2'); print "\nNumber of tests:\n"; printf " total .. %d\n", $$opts{nok}+$$opts{nfailed}; From 5940dc04d24120ddba8763b0f1bf7c1a1304778c Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Tue, 15 Sep 2015 10:05:30 +0100 Subject: [PATCH 070/211] plot-vcfstats: ensure merged SN fields are in a specific order Fixes #318 --- plot-vcfstats | 20 +++++++++++++++----- test/check_merge.chk | 12 ++++++------ 2 files changed, 21 insertions(+), 11 deletions(-) diff --git a/plot-vcfstats b/plot-vcfstats index 56cc4c77e..e46b3eab8 100755 --- a/plot-vcfstats +++ b/plot-vcfstats @@ -124,7 +124,7 @@ sub parse_params { id=>'SN', header=>'SN, Summary numbers', - exp=>"# SN [2]id [3]key [4]value" + exp=>"# SN\t[2]id\t[3]key\t[4]value" }, { id=>'TSTV', @@ -222,6 +222,17 @@ sub parse_params exp=>"# HWE\t[2]id\t[3]1st ALT allele frequency\t[4]Number of observations\t[5]25th percentile\t[6]median\t[7]75th percentile", }, ], + SN_keys=>[ + 'number of samples:', + 'number of records:', + 'number of no-ALTs:', + 'number of SNPs:', + 'number of MNPs:', + 'number of indels:', + 'number of others:', + 'number of multiallelic sites:', + 'number of multiallelic SNP sites:', + ], }; for my $sec (@{$$opts{sections}}) { $$opts{exp}{$$sec{id}} = $$sec{exp}; $$opts{id2sec}{$$sec{id}} = $sec; } while (defined(my $arg=shift(@ARGV))) @@ -1613,10 +1624,8 @@ sub plot_overlap_by_AF_col "; - } - sub plot_indel_distribution { my ($opts,$id) = @_; @@ -1769,6 +1778,7 @@ sub fmt_slide3v \\hslide{$title}{$slide} ]; } + sub fmt_slide3h { my ($opts, $image, $title) = @_; @@ -2097,7 +2107,6 @@ sub create_pdf print STDERR "Finished: $pdf_file\n" unless !$$opts{verbose}; } - sub merge_vcfstats { my ($opts) = @_; @@ -2131,8 +2140,9 @@ sub merge_vcfstats for my $id (keys %{$$opts{dat}}) { if ( exists($$opts{exp}{$id}) ) { next; } - for my $key (keys %{$$opts{dat}{$id}}) + for my $key (@{$$opts{SN_keys}}) { + next unless exists $$opts{dat}{$id}{$key}; print $fh "SN\t$id\t$key\t$$opts{dat}{$id}{$key}\n"; } } diff --git a/test/check_merge.chk b/test/check_merge.chk index 846be5bf5..3df3baefa 100644 --- a/test/check_merge.chk +++ b/test/check_merge.chk @@ -2,16 +2,16 @@ # Definition of sets # ID [2]id [3]tab-separated file names # SN, Summary numbers -# SN [2]id [3]key [4]value -SN 0 number of indels: 9 +# SN [2]id [3]key [4]value +SN 0 number of samples: 2 SN 0 number of records: 18 -SN 0 number of multiallelic SNP sites: 1 +SN 0 number of no-ALTs: 1 SN 0 number of SNPs: 5 -SN 0 number of others: 2 SN 0 number of MNPs: 1 +SN 0 number of indels: 9 +SN 0 number of others: 2 SN 0 number of multiallelic sites: 6 -SN 0 number of samples: 2 -SN 0 number of no-ALTs: 1 +SN 0 number of multiallelic SNP sites: 1 # # TSTV, transition/transversions: # TSTV [2]id [3]ts [4]tv [5]ts/tv [6]ts (1st ALT) [7]tv (1st ALT) [8]ts/tv (1st ALT) TSTV 0 3 2 1.50 3 1 3.00 From ae4c9b0fe44048137599cc6317ea6f3d6fc49bad Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Tue, 15 Sep 2015 11:42:40 +0100 Subject: [PATCH 071/211] docs: mention that --fasta-ref is required for left-alignment and normalization as pointed out in #315 --- doc/bcftools.1 | 12 +++++++----- doc/bcftools.html | 17 ++++++++++------- doc/bcftools.txt | 13 ++++++++----- 3 files changed, 25 insertions(+), 17 deletions(-) diff --git a/doc/bcftools.1 b/doc/bcftools.1 index 3194bad86..d0e609ed1 100644 --- a/doc/bcftools.1 +++ b/doc/bcftools.1 @@ -2,12 +2,12 @@ .\" Title: bcftools .\" Author: [see the "AUTHORS" section] .\" Generator: DocBook XSL Stylesheets v1.76.1 -.\" Date: 2015-09-02 15:10 BST +.\" Date: 2015-09-15 11:42 BST .\" Manual: \ \& .\" Source: \ \& .\" Language: English .\" -.TH "BCFTOOLS" "1" "2015\-09\-02 15:10 BST" "\ \&" "\ \&" +.TH "BCFTOOLS" "1" "2015\-09\-15 11:42 BST" "\ \&" "\ \&" .\" ----------------------------------------------------------------- .\" * Define some portability stuff .\" ----------------------------------------------------------------- @@ -41,7 +41,7 @@ Most commands accept VCF, bgzipped VCF and BCF with filetype detected automatica BCFtools is designed to work on a stream\&. It regards an input file "\-" as the standard input (stdin) and outputs to the standard output (stdout)\&. Several commands can thus be combined with Unix pipes\&. .SS "VERSION" .sp -This manual page was last updated \fB2015\-09\-02 15:10 BST\fR and refers to bcftools git version \fB1\&.2\-119\-g0dbe41e+\fR\&. +This manual page was last updated \fB2015\-09\-15 11:42 BST\fR and refers to bcftools git version \fB1\&.2\-127\-g5940dc0+\fR\&. .SS "BCF1" .sp The BCF1 format output by versions of samtools <= 0\&.1\&.19 is \fBnot\fR compatible with this version of bcftools\&. To read BCF1 files one can use the view command from old versions of bcftools packaged with samtools versions <= 0\&.1\&.19 to convert to VCF, which can then be read by this version of bcftools\&. @@ -1857,7 +1857,7 @@ see .RE .SS "bcftools norm [\fIOPTIONS\fR] \fIfile\&.vcf\&.gz\fR" .sp -Left\-align and normalize indels, check if REF alleles match the reference, split multiallelic sites into multiple rows; recover multiallelics from multiple rows\&. +Left\-align and normalize indels, check if REF alleles match the reference, split multiallelic sites into multiple rows; recover multiallelics from multiple rows\&. Left\-alignment and normalization will only be applied if the \fB\-\-fasta\-ref\fR option is supplied\&. .PP \fB\-c, \-\-check\-ref\fR \fIe\fR|\fIw\fR|\fIx\fR|\fIs\fR .RS 4 @@ -1878,7 +1878,9 @@ remove duplicate lines of the same type .PP \fB\-f, \-\-fasta\-ref\fR \fIFILE\fR .RS 4 -reference sequence +reference sequence\&. Supplying this option will turn on left\-alignment and normalization, however, see also the +\fB\-\-do\-not\-normalize\fR +option below\&. .RE .PP \fB\-m, \-\-multiallelics\fR ←|+>[\fIsnps\fR|\fIindels\fR|\fIboth\fR|\fIany\fR] diff --git a/doc/bcftools.html b/doc/bcftools.html index a32fa9ddf..3ac3e8614 100644 --- a/doc/bcftools.html +++ b/doc/bcftools.html @@ -1,13 +1,13 @@ -bcftools

    Name

    bcftools — utilities for variant calling and manipulating VCFs and BCFs.

    Synopsis

    bcftools [--version|--version-only] [--help] [COMMAND] [OPTIONS]

    DESCRIPTION

    BCFtools is a set of utilities that manipulate variant calls in the Variant +bcftools

    Name

    bcftools — utilities for variant calling and manipulating VCFs and BCFs.

    Synopsis

    bcftools [--version|--version-only] [--help] [COMMAND] [OPTIONS]

    DESCRIPTION

    BCFtools is a set of utilities that manipulate variant calls in the Variant Call Format (VCF) and its binary counterpart BCF. All commands work transparently with both VCFs and BCFs, both uncompressed and BGZF-compressed.

    Most commands accept VCF, bgzipped VCF and BCF with filetype detected automatically even when streaming from a pipe. Indexed VCF and BCF will work in all situations. Un-indexed VCF and BCF and streams will work in most, but not all situations.

    BCFtools is designed to work on a stream. It regards an input file "-" as the standard input (stdin) and outputs to the standard output (stdout). Several -commands can thus be combined with Unix pipes.

    VERSION

    This manual page was last updated 2015-09-02 15:10 BST and refers to bcftools git version 1.2-119-g0dbe41e+.

    BCF1

    The BCF1 format output by versions of samtools <= 0.1.19 is not +commands can thus be combined with Unix pipes.

    VERSION

    This manual page was last updated 2015-09-15 11:42 BST and refers to bcftools git version 1.2-127-g5940dc0+.

    BCF1

    The BCF1 format output by versions of samtools <= 0.1.19 is not compatible with this version of bcftools. To read BCF1 files one can use the view command from old versions of bcftools packaged with samtools versions <= 0.1.19 to convert to VCF, which can then be read by @@ -1027,9 +1027,10 @@ -R, --regions-file file

    see Common Options -

    bcftools norm [OPTIONS] file.vcf.gz

    Left-align and normalize indels, check if REF alleles match the reference, +

    bcftools norm [OPTIONS] file.vcf.gz

    Left-align and normalize indels, check if REF alleles match the reference, split multiallelic sites into multiple rows; recover multiallelics from -multiple rows.

    +multiple rows. Left-alignment and normalization will only be applied if +the --fasta-ref option is supplied.

    -c, --check-ref e|w|x|s
    what to do when incorrect or missing REF allele is encountered: @@ -1042,9 +1043,11 @@
    remove duplicate lines of the same type
    --f, --fasta-ref FILE +-f, --fasta-ref FILE
    - reference sequence + reference sequence. Supplying this option will turn on left-alignment + and normalization, however, see also the --do-not-normalize + option below.
    -m, --multiallelics ←|+>[snps|indels|both|any]
    @@ -1056,7 +1059,7 @@ both; if SNPs and indels should be merged into a single record, specify any.
    --N, --do-not-normalize +-N, --do-not-normalize
    the -c s option can be used to fix or set the REF allele from the reference -f. The -N option will not turn on indel normalisation diff --git a/doc/bcftools.txt b/doc/bcftools.txt index bd3270ba0..94064e445 100644 --- a/doc/bcftools.txt +++ b/doc/bcftools.txt @@ -1085,9 +1085,10 @@ For "vertical" merge take a look at *<>* instead. [[norm]] === bcftools norm ['OPTIONS'] 'file.vcf.gz' -Left-align and normalize indels, check if REF alleles match the reference, +Left-align and normalize indels, check if REF alleles match the reference, split multiallelic sites into multiple rows; recover multiallelics from -multiple rows. +multiple rows. Left-alignment and normalization will only be applied if +the *<>* option is supplied. *-c, --check-ref* 'e'|'w'|'x'|'s':: what to do when incorrect or missing REF allele is encountered: @@ -1099,8 +1100,10 @@ multiple rows. *-D, --remove-duplicates*:: remove duplicate lines of the same type -*-f, --fasta-ref* 'FILE':: - reference sequence +*-f, --fasta-ref* 'FILE'[[fasta_ref]]:: + reference sequence. Supplying this option will turn on left-alignment + and normalization, however, see also the *<>* + option below. *-m, --multiallelics* <-|+>['snps'|'indels'|'both'|'any']:: split multiallelic sites into biallelic records ('-') or join @@ -1111,7 +1114,7 @@ multiple rows. 'both'; if SNPs and indels should be merged into a single record, specify 'any'. -*-N, --do-not-normalize*:: +*-N, --do-not-normalize*[[do_not_normalize]]:: the '-c s' option can be used to fix or set the REF allele from the reference '-f'. The '-N' option will not turn on indel normalisation as the '-f' option normally implies From 274c64259d5ca4ac6ba6da1ed77ec89ce4c9081b Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Wed, 16 Sep 2015 10:21:10 +0100 Subject: [PATCH 072/211] PL to determine sex with +vcf2sex --- plugins/vcf2sex.c | 275 +++++++++++++++++++++++++++++++++++++--------- 1 file changed, 221 insertions(+), 54 deletions(-) diff --git a/plugins/vcf2sex.c b/plugins/vcf2sex.c index bad4c3dba..17f561472 100644 --- a/plugins/vcf2sex.c +++ b/plugins/vcf2sex.c @@ -31,18 +31,41 @@ #include #include #include +#include #include "bcftools.h" #include "ploidy.h" +#define GUESS_GT 1 +#define GUESS_PL 2 + +typedef struct +{ + uint64_t nhet, nhom, nmiss; +} +count_t; + +typedef struct +{ + char *chr; + uint32_t start, end; + int *sex2ploidy; // sex ploidies + count_t *counts; // per-sample counts: counts[isample] +} +reg_stats_t; + typedef struct { int nsites, nsex, *sex2ploidy, dflt_ploidy, max_ploidy, guess; - int ncounts, *counts, nsample, verbose; + count_t bg_counts; // background het/hom counts for regions with the same ploidy in all sexes + reg_stats_t *reg_stats; // counts for all regions, used with -g + int nreg_stats, nsample, verbose; + int *counts, ncounts; // number of observed GTs with given ploidy, used when -g is not given float *sex2prob, min_hets; - int32_t *gts, ngts; + int32_t *gts, ngts, *pls, npls; bcf_srs_t *sr; bcf_hdr_t *hdr; ploidy_t *ploidy; + char *background; } args_t; @@ -55,15 +78,23 @@ const char *usage(void) { return "\n" - "About: Determine sample sex by either checking the presence of haploid/diploid\n" - " genotypes (requires correct ploidy in the VCF) or by counting homs/hets\n" - " in haploid regions.\n" + "About: Determine sample sex by checking the presence of haploid/diploid genotypes\n" + " (requires correct ploidy in the VCF). Alternatively, determine the sex by\n" + " counting homs/hets (-g GT) or most likely hom/het genotypes (-g PL) in haploid\n" + " regions. With -g, a region is deemed haploid when the fraction of hets in the\n" + " region is significantly smaller than in the background region. For example,\n" + " the default \"-m 0.3\" requires the het rate to be at least 30% of the background\n" + " rate. If the background region is disabled (\"-b -\"), the threshold -m is interpreted\n" + " directly as the minimum fraction of hets in the region.\n" + "\n" "Usage: bcftools +vcf2sex -- [Plugin Options]\n" "Plugin options:\n" - " -g, --guess do not trust genotypes ploidy, count hom/hets\n" - " -m, --min-hets minimum fraction of hets in diploid regions [0.05]\n" - " -n, --nsites number of sites to check per region (ignored with -g) [10]\n" - " -p, --ploidy space/tab-delimited list of CHROM,FROM,TO,SEX,PLOIDY\n" + " -b, --background diploid region to determine normal hom/hets counts [X:60001-2699520]\n" + " -g, --guess determine ploidy by counting hom/hets (GT) or most likely genotypes (PL)\n" + " -m, --min-hets minimum fraction of hets in diploid regions [0.3]\n" + " -n, --nsites number of sites to check per region (ignored with -g) [10]\n" + " -p, --ploidy space/tab-delimited list of CHROM,FROM,TO,SEX,PLOIDY\n" + " -v, --verbose print debugging information\n" "\n" "Example:\n" " # Default ploidy, if -p not given. Unlisted regions have ploidy 2\n" @@ -74,9 +105,36 @@ const char *usage(void) " \n" " bcftools +vcf2sex in.vcf.gz\n" " bcftools +vcf2sex in.vcf.gz -- -n 10\n" + " bcftools +vcf2sex in.vcf.gz -- -g GT\n" "\n"; } +reg_stats_t *expand_regs(args_t *args, char *seq, uint32_t start, uint32_t end) +{ + args->nreg_stats++; + args->reg_stats = (reg_stats_t*) realloc(args->reg_stats,sizeof(reg_stats_t)*args->nreg_stats); + reg_stats_t *stats = args->reg_stats + args->nreg_stats-1; + stats->chr = strdup(seq); + stats->start = start; + stats->end = end; + stats->sex2ploidy = (int*) malloc(sizeof(int)*args->nsex); + memcpy(stats->sex2ploidy,args->sex2ploidy,sizeof(int)*args->nsex); + stats->counts = (count_t*) calloc(args->nsample,sizeof(count_t)); + return stats; +} +void destroy_regs(args_t *args) +{ + int i; + for (i=0; inreg_stats; i++) + { + free(args->reg_stats[i].chr); + free(args->reg_stats[i].counts); + free(args->reg_stats[i].sex2ploidy); + } + free(args->reg_stats); + args->nreg_stats = 0; +} + int process_region_precise(args_t *args, char *seq, regitr_t *itr) { int k = 1; @@ -137,85 +195,188 @@ int process_region_precise(args_t *args, char *seq, regitr_t *itr) int process_region_guess(args_t *args, char *seq, regitr_t *itr) { - int ismpl, k = 1; - uint32_t start = itr->reg[itr->i].start, end = itr->reg[itr->i].end; - while ( itr->i+kn && start==itr->reg[itr->i+k].start && end==itr->reg[itr->i+k].end ) k++; - - int ret = ploidy_query(args->ploidy, seq, start, args->sex2ploidy, NULL, NULL); - assert(ret); + int kitr = 1; + uint32_t start = 0, end = INT_MAX; + reg_stats_t *stats = NULL; - memset(args->counts,0,args->ncounts*sizeof(int)); + if ( itr ) + { + start = itr->reg[itr->i].start; + end = itr->reg[itr->i].end; + while ( itr->i+kitrn && start==itr->reg[itr->i+kitr].start && end==itr->reg[itr->i+kitr].end ) kitr++; + + int min,max,ret = ploidy_query(args->ploidy, seq, start, args->sex2ploidy, &min, &max); + assert(ret); + stats = expand_regs(args, seq,start,end); + } + else + { + // background region + int spos, epos; + const char *ptr = hts_parse_reg(args->background, &spos, &epos); + if ( !ptr ) + error("Could not parse the region: %s\n", args->background); + seq = (char*) malloc(ptr - args->background + 1); + memcpy(seq,args->background,ptr-args->background); + seq[ptr-args->background] = 0; + } + + if ( bcf_sr_seek(args->sr,seq,start)!=0 ) + { + // sequence not present + if ( !itr ) free(seq); + return kitr; + } + int ismpl, rid = bcf_hdr_name2id(args->hdr,seq); + if ( !itr ) free(seq); - if ( bcf_sr_seek(args->sr,seq,start)!=0 ) return k; // sequence not present - int rid = bcf_hdr_name2id(args->hdr,seq); while ( bcf_sr_next_line(args->sr) ) { bcf1_t *rec = bcf_sr_get_line(args->sr,0); if ( rec->rid!=rid || rec->pos > end ) break; - bcf_fmt_t *fmt = bcf_get_fmt(args->hdr, rec, "GT"); - for (ismpl=0; ismplnsample; ismpl++) + if ( args->guess & GUESS_GT ) // use GTs to guess the ploidy + { + bcf_fmt_t * fmt = bcf_get_fmt(args->hdr, rec, "GT"); + for (ismpl=0; ismplnsample; ismpl++) + { + count_t *counts = stats ? &stats->counts[ismpl] : &args->bg_counts; + int gt = bcf_gt_type(fmt, ismpl, NULL,NULL); + if ( gt==GT_UNKN ) counts->nmiss++; + else if ( gt==GT_HET_RA || gt==GT_HET_AA ) counts->nhet++; + else counts->nhom++; + } + } + else // use PLs to guess the ploidy { - int gt = bcf_gt_type(fmt, ismpl, NULL,NULL); - if ( gt==GT_UNKN ) args->counts[ismpl*3+0]++; // missing - else if ( gt==GT_HET_RA || gt==GT_HET_AA ) args->counts[ismpl*3+1]++; // het - else args->counts[ismpl*3+2]++; // hom + int npl = bcf_get_format_int32(args->hdr,rec,"PL",&args->pls,&args->npls); + if ( npl<=0 ) continue; + npl /= args->nsample; + for (ismpl=0; ismplnsample; ismpl++) + { + int32_t *ptr = args->pls + ismpl*npl; + int phom = INT_MAX, phet = INT_MAX, ial, jal, k = 0; + for (ial=0; ialn_allele; ial++) + { + if ( ptr[k] == bcf_int32_missing || ptr[k] == bcf_int32_vector_end ) break; + if ( phom > ptr[k] ) phom = ptr[k]; + k++; + for (jal=0; jal ptr[k] ) phet = ptr[k]; + k++; + } + } + count_t *counts = stats ? &stats->counts[ismpl] : &args->bg_counts; + if ( k == rec->n_allele ) counts->nhom++; // haploid + else if ( k != rec->n_allele*(rec->n_allele+1)/2 ) counts->nmiss++; + else if ( phet < phom ) counts->nhet++; + else counts->nhom++; + } } } + return kitr; +} - for (ismpl=0; ismplnsample; ismpl++) +void sex2prob_guess(args_t *args) +{ + int ismpl, ireg; + uint64_t nhom,nhet,nmiss; + float bg_het = -1; + + if ( args->background ) { - float sum = 0, *probs = args->sex2prob + ismpl*args->nsex; - int i, *counts = args->counts + ismpl*(args->max_ploidy+1); - float fhet = (counts[1]+counts[2]) ? (float)counts[1]/(counts[1]+counts[2]) : 0; - for (i=0; imax_ploidy+1; i++) sum += counts[i]; - for (i=0; insex; i++) + process_region_guess(args, NULL, NULL); + nhom = args->bg_counts.nhom; + nhet = args->bg_counts.nhet; + nmiss = args->bg_counts.nmiss; + bg_het = nhom+nhet ? (float)nhet/(nhom+nhet) : 0; + + if ( args->verbose ) { - // a very simple heuristics to determine sex by counting hets/homs/missing sites, - // in human nhet/nhom ~ 0.2 - int ploidy = args->sex2ploidy[i]; - float prob = 1; - if ( ploidy==0 ) - prob = sum ? counts[0] / sum : 1; // fraction of missing sites - else if ( ploidy==1 ) - { - if ( counts[1]+counts[2] ) prob = fhet > args->min_hets ? 0.1 : 0.9; - prob *= sum ? 1 - counts[0] / sum : 1./args->nsex; - } - else + printf("# [1]BGR\t[2]Region\t[3]Het fraction\t[4]nHet\t[5]nHom\t[6]nMissing\n"); + printf("BGR\t%s\t%f\t%"PRId64"\t%"PRId64"\t%"PRId64"\n", args->background,bg_het,nhet,nhom,nmiss); + } + } + + // a very simple heuristics to determine sex by counting hets/homs/missing sites + for (ireg=0; iregnreg_stats; ireg++) + { + reg_stats_t *stats = &args->reg_stats[ireg]; + for (ismpl=0; ismplnsample; ismpl++) + { + uint64_t nhom = stats->counts[ismpl].nhom; + uint64_t nhet = stats->counts[ismpl].nhet; + uint64_t nmiss = stats->counts[ismpl].nmiss; + float fhet = nhom+nhet ? (float)nhet/(nhom+nhet) : 0; + + if ( args->verbose ) + printf("DBG\t%s:%d-%d\t%s\t%f\t%"PRId64"\t%"PRId64"\t%"PRId64"\n", stats->chr,stats->start+1,stats->end+1,args->hdr->samples[ismpl],fhet,nhet,nhom,nmiss); + + int i, ntot = nhom + nhet + nmiss; + if ( !ntot ) continue; + + float *probs = args->sex2prob + ismpl*args->nsex; + for (i=0; insex; i++) { - if ( counts[1]+counts[2] ) prob = fhet > args->min_hets ? 0.9 : 0.1; - prob *= sum ? 1 - counts[0] / sum : 1./args->nsex; + int ploidy = stats->sex2ploidy[i]; + float prob; + if ( ploidy==0 ) + prob = (float) nmiss / ntot; // fraction of missing sites + else if ( ploidy==1 ) + { + // NB: these numbers (0.1,0.9) are made up, to be improved + if ( bg_het<0 ) + prob = fhet > args->min_hets ? 0.1 : 0.9; + else + prob = fhet > args->min_hets*bg_het ? 0.1 : 0.9; + prob *= 1 - (float)nmiss / ntot; + } + else + { + if ( bg_het<0 ) + prob = fhet > args->min_hets ? 0.9 : 0.1; + else + prob = fhet > args->min_hets*bg_het ? 0.9 : 0.1; + prob *= 1 - (float)nmiss / ntot; + } + probs[i] *= prob; } - probs[i] *= prob; } - if ( args->verbose ) - printf("DBG\t%s:%d-%d\t%s\t%f\t%d\t%d\t%d\n", seq,start+1,end+1,args->hdr->samples[ismpl], fhet,counts[0],counts[1],counts[2]); } - - return k; } int run(int argc, char **argv) { args_t *args = (args_t*) calloc(1,sizeof(args_t)); args->nsites = 10; - args->min_hets = 0.05; + args->min_hets = 0.3; + args->background = "X:60001-2699520"; static struct option loptions[] = { {"verbose",1,0,'v'}, {"ploidy",1,0,'p'}, {"nsites",1,0,'n'}, - {"guess",0,0,'g'}, + {"guess",1,0,'g'}, {"min-hets",1,0,'m'}, + {"background",1,0,'b'}, {0,0,0,0} }; char c, *tmp, *ploidy_fname = NULL; - while ((c = getopt_long(argc, argv, "p:n:gm:v",loptions,NULL)) >= 0) + while ((c = getopt_long(argc, argv, "p:n:g:m:vb:",loptions,NULL)) >= 0) { switch (c) { + case 'b': + if ( !strcmp("-",optarg) ) args->background = NULL; + else args->background = optarg; + break; case 'v': args->verbose = 1; break; - case 'g': args->guess = 1; break; + case 'g': + if ( !strcasecmp(optarg,"GT") ) args->guess = GUESS_GT; + else if ( !strcasecmp(optarg,"PL") ) args->guess = GUESS_PL; + else error("The argument not recognised, expected --guess GT or --guess PL: %s\n", optarg); + break; case 'm': args->min_hets = strtod(optarg,&tmp); if ( *tmp ) error("Unexpected argument to --min-hets: %s\n", optarg); @@ -232,7 +393,8 @@ int run(int argc, char **argv) args->sr = bcf_sr_init(); args->sr->require_index = 1; - if ( !argv[0] || !bcf_sr_add_reader(args->sr,argv[0]) ) error("%s", usage()); + if ( !argv[0] ) error("%s", usage()); + if ( !bcf_sr_add_reader(args->sr,argv[0]) ) error("Error: %s\n", bcf_sr_strerror(args->sr->errnum)); args->hdr = args->sr->readers[0].header; args->nsample = bcf_hdr_nsamples(args->hdr); @@ -271,11 +433,14 @@ int run(int argc, char **argv) regitr_t itr; regidx_overlap(idx, seqs[i], 0, UINT32_MAX, &itr); while ( itr.i < itr.n ) + { if ( args->guess ) itr.i += process_region_guess(args, seqs[i], &itr); else itr.i += process_region_precise(args, seqs[i], &itr); + } } + if ( args->guess ) sex2prob_guess(args); for (i=0; insample; i++) { @@ -298,9 +463,11 @@ int run(int argc, char **argv) bcf_sr_destroy(args->sr); ploidy_destroy(args->ploidy); + destroy_regs(args); free(args->sex2ploidy); free(args->counts); free(args->gts); + free(args->pls); free(args->sex2prob); free(args); return 0; From 4dd02c378c874a0053a62e584e54c71597287fdf Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Wed, 16 Sep 2015 10:25:22 +0100 Subject: [PATCH 073/211] new setGT plugin could deprecate or drop missing2ref plugin as functionality included in setGT --- plugins/setGT.c | 223 ++++++++++++++++++++++++++++++++++++++++++++++++ test/test.pl | 1 + 2 files changed, 224 insertions(+) create mode 100644 plugins/setGT.c diff --git a/plugins/setGT.c b/plugins/setGT.c new file mode 100644 index 000000000..55e0f27ea --- /dev/null +++ b/plugins/setGT.c @@ -0,0 +1,223 @@ +/* plugins/setGT.c -- set gentoypes to given values + + Copyright (C) 2015 Genome Research Ltd. + + Author: Petr Danecek + +Permission is hereby granted, free of charge, to any person obtaining a copy +of this software and associated documentation files (the "Software"), to deal +in the Software without restriction, including without limitation the rights +to use, copy, modify, merge, publish, distribute, sublicense, and/or sell +copies of the Software, and to permit persons to whom the Software is +furnished to do so, subject to the following conditions: + +The above copyright notice and this permission notice shall be included in +all copies or substantial portions of the Software. + +THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS OR +IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF MERCHANTABILITY, +FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. IN NO EVENT SHALL +THE AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY CLAIM, DAMAGES OR OTHER +LIABILITY, WHETHER IN AN ACTION OF CONTRACT, TORT OR OTHERWISE, ARISING +FROM, OUT OF OR IN CONNECTION WITH THE SOFTWARE OR THE USE OR OTHER +DEALINGS IN THE SOFTWARE. */ + +#include +#include +#include +#include +#include +#include +#include "bcftools.h" + +bcf_hdr_t *in_hdr, *out_hdr; +int32_t *gts = NULL, mgts = 0; +int *arr = NULL, marr = 0; +uint64_t nchanged = 0; +int tgt_mask = 0, new_mask = 0, new_gt = 0; + +#define GT_MISSING 1 +#define GT_PARTIAL (1<<1) +#define GT_REF (1<<2) +#define GT_MAJOR (1<<3) +#define GT_PHASED (1<<4) +#define GT_UNPHASED (1<<5) +#define GT_ALL (1<<6) + +const char *about(void) +{ + return "Set genotypes: partially missing to missing, missing to ref/major allele, etc.\n"; +} + +const char *usage(void) +{ + return + "About: Sets genotypes. The target genotypes can be specified as:\n" + " ./. .. completely missing (\".\" or \"./.\", depending on ploidy)\n" + " ./x .. partially missing (e.g., \"./0\" or \".|1\" but not \"./.\")\n" + " . .. partially or completely missing\n" + " a .. all genotypes\n" + " and the new genotype can be one of:\n" + " . .. missing (\".\" or \"./.\", keeps ploidy)\n" + " 0 .. reference allele\n" + " M .. major allele\n" + " p .. phased genotype\n" + " u .. unphase genotype and sort by allele (1|0 becomes 0/1)\n" + "Usage: bcftools +setGT [General Options] -- [Plugin Options]\n" + "Options:\n" + " run \"bcftools plugin\" for a list of common options\n" + "\n" + "Plugin options:\n" + " -n, --new-gt Genotypes to set, see above\n" + " -t, --target-gt Genotypes to change, see above\n" + "\n" + "Example:\n" + " # set missing genotypes (\"./.\") to phased ref genotypes (\"0|0\")\n" + " bcftools +setGT in.vcf -- -t . -n 0p\n" + "\n" + " # set partially missing genotypes to completely missing\n" + " bcftools +setGT in.vcf -- -t ./x -n .\n" + "\n"; +} + + +int init(int argc, char **argv, bcf_hdr_t *in, bcf_hdr_t *out) +{ + int c; + static struct option loptions[] = + { + {"new-gt",1,0,'n'}, + {"target-gt",0,0,'t'}, + {0,0,0,0} + }; + while ((c = getopt_long(argc, argv, "?hn:t:",loptions,NULL)) >= 0) + { + switch (c) + { + case 'n': new_mask = bcf_gt_phased(0); + if ( strchr(optarg,'.') ) new_mask |= GT_MISSING; + if ( strchr(optarg,'0') ) new_mask |= GT_REF; + if ( strchr(optarg,'M') ) new_mask |= GT_MAJOR; + if ( strchr(optarg,'p') ) new_mask |= GT_PHASED; + if ( strchr(optarg,'u') ) new_mask |= GT_UNPHASED; + break; + case 't': + if ( !strcmp(optarg,".") ) tgt_mask |= GT_MISSING|GT_PARTIAL; + if ( !strcmp(optarg,"./x") ) tgt_mask |= GT_PARTIAL; + if ( !strcmp(optarg,"./.") ) tgt_mask |= GT_MISSING; + if ( !strcmp(optarg,"a") ) tgt_mask |= GT_ALL; + break; + case 'h': + case '?': + default: fprintf(stderr,"%s", usage()); exit(1); break; + } + } + in_hdr = in; + out_hdr = out; + + if ( !new_mask ) error("Expected -n option\n"); + if ( !tgt_mask ) error("Expected -t option\n"); + + if ( new_mask & GT_MISSING ) new_gt = bcf_gt_missing; + if ( new_mask & GT_REF ) new_gt = new_mask>_PHASED ? bcf_gt_phased(0) : bcf_gt_unphased(0); + + return 0; +} + +bcf1_t *process(bcf1_t *rec) +{ + if ( !rec->n_sample ) return rec; + + int ngts = bcf_get_genotypes(in_hdr, rec, >s, &mgts); + ngts /= rec->n_sample; + int i, j, changed = 0; + + // Calculating allele frequency for each allele and determining major allele + // only do this if use_major is true + int an = 0, maxAC = -1, majorAllele = -1; + if ( new_mask & GT_MAJOR ) + { + hts_expand(int,rec->n_allele,marr,arr); + int ret = bcf_calc_ac(in_hdr,rec,arr,BCF_UN_FMT); + if ( ret<= 0 ) + error("Could not calculate allele count at %s:%d\n", bcf_seqname(in_hdr,rec),rec->pos+1); + + for(i=0; i < rec->n_allele; ++i) + { + an += arr[i]; + if (arr[i] > maxAC) + { + maxAC = arr[i]; + majorAllele = i; + } + } + + // replacing new_gt by major allele + new_gt = new_mask & GT_PHASED ? bcf_gt_phased(majorAllele) : bcf_gt_unphased(majorAllele); + } + + // replace gts + for (i=0; in_sample; i++) + { + int ploidy = 0, nmiss = 0; + int32_t *ptr = gts + i*ngts; + for (j=0; j0 && ptr[l-1]>x ) + { + ptr[l] = ptr[l-1]; + l--; + } + ptr[l] = x; + } + continue; + } + + for (j=0; jn_sample); + return rec; +} + +void destroy(void) +{ + free(arr); + fprintf(stderr,"Filled %"PRId64" alleles\n", nchanged); + free(gts); +} + + diff --git a/test/test.pl b/test/test.pl index a1374881d..e89bee534 100755 --- a/test/test.pl +++ b/test/test.pl @@ -161,6 +161,7 @@ test_vcf_annotate($opts,in=>'annotate4',vcf=>'annots4',out=>'annotate8.out',args=>'-c +INFO'); test_vcf_annotate($opts,in=>'annotate4',tab=>'annots4',out=>'annotate8.out',args=>'-c CHROM,POS,REF,ALT,+FA,+FR,+IA,+IR,+SA,+SR'); test_vcf_plugin($opts,in=>'plugin1',out=>'missing2ref.out',cmd=>'+missing2ref'); +test_vcf_plugin($opts,in=>'plugin1',out=>'missing2ref.out',cmd=>'+setGT',args=>'-- -t . -n 0'); test_vcf_annotate($opts,in=>'annotate9',tab=>'annots9',out=>'annotate9.out',args=>'-c CHROM,POS,REF,ALT,+ID'); test_vcf_plugin($opts,in=>'plugin1',out=>'fill-AN-AC.out',cmd=>'+fill-AN-AC'); test_vcf_plugin($opts,in=>'plugin1',out=>'dosage.out',cmd=>'+dosage'); From f46aa3eb40ee8ee1424f6000770aea5c41fd1411 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Tue, 8 Sep 2015 11:06:35 +0100 Subject: [PATCH 074/211] Plugins to use bcf_gt_is_missing instead of the old bcf_int32_missing --- plugins/dosage.c | 2 +- plugins/vcf2sex.c | 4 +++- 2 files changed, 4 insertions(+), 2 deletions(-) diff --git a/plugins/dosage.c b/plugins/dosage.c index bbfe2e547..ddc6297e1 100644 --- a/plugins/dosage.c +++ b/plugins/dosage.c @@ -140,7 +140,7 @@ int calc_dosage_GT(bcf1_t *rec) float dsg = 0; for (j=0; j0 ? dsg : -1); diff --git a/plugins/vcf2sex.c b/plugins/vcf2sex.c index 17f561472..6a9a626cf 100644 --- a/plugins/vcf2sex.c +++ b/plugins/vcf2sex.c @@ -169,8 +169,10 @@ int process_region_precise(args_t *args, char *seq, regitr_t *itr) int32_t *gts = args->gts + ngts*ismpl; int igt, ploidy = 0; for (igt=0; igtcounts[ismpl*(args->max_ploidy+1) + ploidy]++; if ( args->verbose ) fprintf(stderr,"%s:%d\t%s\tploidy=%d\n", seq,rec->pos+1,args->hdr->samples[ismpl],ploidy); From 84aff628c299bcabe8814b5ef373cc0718dcc839 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Tue, 28 Apr 2015 14:00:33 +0100 Subject: [PATCH 075/211] fixploidy: Do not exit on lines without GT, leave unchanged --- plugins/fixploidy.c | 7 +++++-- 1 file changed, 5 insertions(+), 2 deletions(-) diff --git a/plugins/fixploidy.c b/plugins/fixploidy.c index ab4c8f597..717ffef3a 100644 --- a/plugins/fixploidy.c +++ b/plugins/fixploidy.c @@ -167,12 +167,15 @@ bcf1_t *process(bcf1_t *rec) { int i,j, max_ploidy; - ploidy_query(ploidy, (char*)bcf_seqname(in_hdr,rec), rec->pos, sex2ploidy,NULL,&max_ploidy); - int ngts = bcf_get_genotypes(in_hdr, rec, >_arr, &ngt_arr); + if ( ngts<0 ) + return rec; // GT field not present + if ( ngts % n_sample ) error("Error at %s:%d: wrong number of GT fields\n",bcf_seqname(in_hdr,rec),rec->pos+1); + ploidy_query(ploidy, (char*)bcf_seqname(in_hdr,rec), rec->pos, sex2ploidy,NULL,&max_ploidy); + ngts /= n_sample; if ( ngts < max_ploidy ) { From e63a37f5eba494ffc2878bc325145253f1f0388c Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Tue, 17 Feb 2015 10:39:39 +0000 Subject: [PATCH 076/211] convert: Report the number of written records --- vcfconvert.c | 17 ++++++++++------- 1 file changed, 10 insertions(+), 7 deletions(-) diff --git a/vcfconvert.c b/vcfconvert.c index c3d793e86..b9cfc46b1 100644 --- a/vcfconvert.c +++ b/vcfconvert.c @@ -679,7 +679,7 @@ static void vcf_to_gensample(args_t *args) } int prev_rid = -1, prev_pos = -1; - int no_alt = 0, non_biallelic = 0, filtered = 0, ndup = 0; + int no_alt = 0, non_biallelic = 0, filtered = 0, ndup = 0, nok = 0; BGZF *gout = bgzf_open(gen_fname, gen_compressed ? "wg" : "wu"); while ( bcf_sr_next_line(args->files) ) { @@ -713,10 +713,11 @@ static void vcf_to_gensample(args_t *args) { int ret = bgzf_write(gout, str.s, str.l); if ( ret!= str.l ) error("Error writing %s: %s\n", gen_fname,strerror(errno)); + nok++; } } - fprintf(stderr, "%d records skipped: %d/%d/%d/%d no-ALT/non-biallelic/filtered/duplicated\n", - no_alt+non_biallelic+filtered+ndup, no_alt, non_biallelic, filtered, ndup); + fprintf(stderr, "%d records written, %d skipped: %d/%d/%d/%d no-ALT/non-biallelic/filtered/duplicated\n", + nok, no_alt+non_biallelic+filtered+ndup, no_alt, non_biallelic, filtered, ndup); if ( str.m ) free(str.s); if ( bgzf_close(gout)!=0 ) error("Error closing %s: %s\n", gen_fname,strerror(errno)); @@ -804,7 +805,7 @@ static void vcf_to_haplegendsample(args_t *args) if ( ret != str.l ) error("Error writing %s: %s\n", legend_fname, strerror(errno)); } - int no_alt = 0, non_biallelic = 0, filtered = 0; + int no_alt = 0, non_biallelic = 0, filtered = 0, nok = 0; while ( bcf_sr_next_line(args->files) ) { bcf1_t *line = bcf_sr_get_line(args->files,0); @@ -845,8 +846,9 @@ static void vcf_to_haplegendsample(args_t *args) ret = bgzf_write(lout, str.s, str.l); if ( ret != str.l ) error("Error writing %s: %s\n", legend_fname, strerror(errno)); } + nok++; } - fprintf(stderr, "%d records skipped: %d/%d/%d no-ALT/non-biallelic/filtered\n", no_alt+non_biallelic+filtered, no_alt, non_biallelic, filtered); + fprintf(stderr, "%d records written, %d skipped: %d/%d/%d no-ALT/non-biallelic/filtered\n", nok,no_alt+non_biallelic+filtered, no_alt, non_biallelic, filtered); if ( str.m ) free(str.s); if ( hout && bgzf_close(hout)!=0 ) error("Error closing %s: %s\n", hap_fname, strerror(errno)); if ( lout && bgzf_close(lout)!=0 ) error("Error closing %s: %s\n", legend_fname, strerror(errno)); @@ -937,7 +939,7 @@ static void vcf_to_hapsample(args_t *args) // open haps output BGZF *hout = hap_fname ? bgzf_open(hap_fname, hap_compressed ? "wg" : "wu") : NULL; - int no_alt = 0, non_biallelic = 0, filtered = 0; + int no_alt = 0, non_biallelic = 0, filtered = 0, nok = 0; while ( bcf_sr_next_line(args->files) ) { bcf1_t *line = bcf_sr_get_line(args->files,0); @@ -967,8 +969,9 @@ static void vcf_to_hapsample(args_t *args) ret = bgzf_write(hout, str.s, str.l); // write hap file if ( ret != str.l ) error("Error writing %s: %s\n", hap_fname, strerror(errno)); } + nok++; } - fprintf(stderr, "%d records skipped: %d/%d/%d no-ALT/non-biallelic/filtered\n", no_alt+non_biallelic+filtered, no_alt, non_biallelic, filtered); + fprintf(stderr, "%d records written, %d skipped: %d/%d/%d no-ALT/non-biallelic/filtered\n", nok, no_alt+non_biallelic+filtered, no_alt, non_biallelic, filtered); if ( str.m ) free(str.s); if ( hout && bgzf_close(hout)!=0 ) error("Error closing %s: %s\n", hap_fname, strerror(errno)); if (hap_fname) free(hap_fname); From f1129e66aa0940debff302fa788bdb5ba02713f5 Mon Sep 17 00:00:00 2001 From: Jason Piper Date: Thu, 17 Sep 2015 12:05:14 +0800 Subject: [PATCH 077/211] Update test VCF headers to v4.2 --- test/norm.merge.out | 2 +- test/norm.merge.strict.out | 2 +- test/norm.merge.vcf | 2 +- test/norm.out | 2 +- test/norm.setref.out | 2 +- test/norm.setref.vcf | 2 +- test/norm.split.and.norm.out | 2 +- test/norm.split.out | 2 +- test/norm.split.vcf | 2 +- test/norm.vcf | 2 +- 10 files changed, 10 insertions(+), 10 deletions(-) diff --git a/test/norm.merge.out b/test/norm.merge.out index 6dd3f3110..f5b1092ff 100644 --- a/test/norm.merge.out +++ b/test/norm.merge.out @@ -1,4 +1,4 @@ -##fileformat=VCFv4.1 +##fileformat=VCFv4.2 ##FILTER= ##INFO= ##FORMAT= diff --git a/test/norm.merge.strict.out b/test/norm.merge.strict.out index c24dc9beb..1395d2224 100644 --- a/test/norm.merge.strict.out +++ b/test/norm.merge.strict.out @@ -1,4 +1,4 @@ -##fileformat=VCFv4.1 +##fileformat=VCFv4.2 ##FILTER= ##INFO= ##FORMAT= diff --git a/test/norm.merge.vcf b/test/norm.merge.vcf index a24e36fba..e89178e78 100644 --- a/test/norm.merge.vcf +++ b/test/norm.merge.vcf @@ -1,4 +1,4 @@ -##fileformat=VCFv4.1 +##fileformat=VCFv4.2 ##FILTER= ##INFO= ##FORMAT= diff --git a/test/norm.out b/test/norm.out index 6db87c14f..e6796d1e1 100644 --- a/test/norm.out +++ b/test/norm.out @@ -1,4 +1,4 @@ -##fileformat=VCFv4.1 +##fileformat=VCFv4.2 ##FILTER= ##INFO= ##FORMAT= diff --git a/test/norm.setref.out b/test/norm.setref.out index 0f20abdad..2856b0ab7 100644 --- a/test/norm.setref.out +++ b/test/norm.setref.out @@ -1,4 +1,4 @@ -##fileformat=VCFv4.1 +##fileformat=VCFv4.2 ##FILTER= ##INFO= ##FORMAT= diff --git a/test/norm.setref.vcf b/test/norm.setref.vcf index 8e0665793..da78f10ac 100644 --- a/test/norm.setref.vcf +++ b/test/norm.setref.vcf @@ -1,4 +1,4 @@ -##fileformat=VCFv4.1 +##fileformat=VCFv4.2 ##FILTER= ##INFO= ##FORMAT= diff --git a/test/norm.split.and.norm.out b/test/norm.split.and.norm.out index 86154affc..64838edaa 100644 --- a/test/norm.split.and.norm.out +++ b/test/norm.split.and.norm.out @@ -1,4 +1,4 @@ -##fileformat=VCFv4.1 +##fileformat=VCFv4.2 ##FILTER= ##INFO= ##FORMAT= diff --git a/test/norm.split.out b/test/norm.split.out index 38b1323df..b919211d7 100644 --- a/test/norm.split.out +++ b/test/norm.split.out @@ -1,4 +1,4 @@ -##fileformat=VCFv4.1 +##fileformat=VCFv4.2 ##FILTER= ##INFO= ##FORMAT= diff --git a/test/norm.split.vcf b/test/norm.split.vcf index 2d8c0883b..7f039d16d 100644 --- a/test/norm.split.vcf +++ b/test/norm.split.vcf @@ -1,4 +1,4 @@ -##fileformat=VCFv4.1 +##fileformat=VCFv4.2 ##FILTER= ##INFO= ##FORMAT= diff --git a/test/norm.vcf b/test/norm.vcf index 52f5f8827..d000655cc 100644 --- a/test/norm.vcf +++ b/test/norm.vcf @@ -1,4 +1,4 @@ -##fileformat=VCFv4.1 +##fileformat=VCFv4.2 ##FILTER= ##INFO= ##FORMAT= From ceb1524cffb03ec5e560d228f85c18309acd4bf2 Mon Sep 17 00:00:00 2001 From: kretzsch Date: Tue, 22 Sep 2015 18:00:40 +0100 Subject: [PATCH 078/211] convert -H: Fixes issue #274; adds support for haploid and missing alleles --- test/convert.gt.noHead.vcf | 35 +++++++++++++++++ test/convert.gt.vcf | 43 +++++++++++++++++++++ test/convert.hls.gt.hap | 34 ++++++++++++++++ test/convert.hls.gt.legend | 35 +++++++++++++++++ test/convert.hls.gt.samples | 11 ++++++ test/test.pl | 8 ++++ vcfconvert.c | 77 ++++++++++++++++++++++++++++--------- 7 files changed, 224 insertions(+), 19 deletions(-) create mode 100644 test/convert.gt.noHead.vcf create mode 100644 test/convert.gt.vcf create mode 100644 test/convert.hls.gt.hap create mode 100644 test/convert.hls.gt.legend create mode 100644 test/convert.hls.gt.samples diff --git a/test/convert.gt.noHead.vcf b/test/convert.gt.noHead.vcf new file mode 100644 index 000000000..2d1d7cdcf --- /dev/null +++ b/test/convert.gt.noHead.vcf @@ -0,0 +1,35 @@ +#CHROM POS ID REF ALT QUAL FILTER INFO FORMAT NA00001 NA00002 NA00003 NA00004 NA00005 NA00006 NA00007 NA00008 NA00009 NA00010 +X 2698560 . G A . . . GT 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 +X 2698630 . A G . . . GT 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 +X 2698758 . CAA C . . . GT 0|0 0|1 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 +X 2698769 . AAG A . . . GT 1|0 1|1 0|1 1|0 1|0 0|0 0|0 0|0 0|0 0|0 +X 2698770 . AG A . . . GT 0|0 0|1 0|0 0|0 1|0 0|0 0|0 0|0 0|0 0|0 +X 2698770 . AG AAGG . . . GT 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 +X 2698789 . C G . . . GT 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 +X 2698822 . A C . . . GT 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 +X 2698831 . G A . . . GT 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 +X 2698889 . T C . . . GT 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 +X 2698923 . G A . . . GT 1|0 0|1 0|1 1|0 1|0 0|0 0|0 0|0 0|0 0|0 +X 2698953 . A AGG . . . GT 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 +X 2698954 . G A . . . GT 1|0 1|1 0|1 1|0 1|0 0|0 0|0 0|1 0|0 0|0 +X 2699002 . C A . . . GT 0|0 0|0 .|. 0|0 0|0 0|0 0|0 0|0 0|0 0|0 +X 2699025 . T C . . . GT 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 +X 2699091 . G A . . . GT 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 +X 2699187 . T C . . . GT 0|0 0|0 1|0 0|0 0|1 1|0 1|0 0|0 0|0 0/1 +X 2699188 . G C . . . GT 0|0 0|0 1|0 0|0 0|1 1|0 1|0 0|0 0|0 0|1 +X 2699189 . T C . . . GT 0|0 0|0 1|0 0|0 0|1 1|0 1|0 0|0 0|0 0|1 +X 2699217 . C T . . . GT 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 +X 2699246 . C A . . . GT 1|0 1|1 0|1 1|1 1|0 0|1 0|0 0|1 0|0 1|0 +X 2699275 . T G . . . GT 0|0 0|0 1|0 0|0 0|1 1|1 1|0 0|0 0|0 0|1 +X 2699350 . A T . . . GT 0|0 0|0 1|0 0|0 0|1 1|0 1|0 0|0 0|0 0|1 +X 2699360 . T C . . . GT 0|0 0|0 1|0 0|0 0|1 1|0 1|0 0|0 0|0 0|1 +X 2699450 . A C . . . GT 0|0 0|0 1|0 0|0 0|1 1|0 1|0 0|0 0|0 0|1 +X 2699507 . T C . . . GT 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 +X 2699555 . C A . . . GT 0 1 1 0 1 1|1 1|0 0|1 0|0 0|1 +X 2699645 . G T . . . GT 0 1 0 0 0 0|0 0|0 0|1 0|0 0|0 +X 2699676 . G A . . . GT 0 0 1 0 1 1|0 1|0 0|0 0|0 0|1 +X 2699728 . C T . . . GT 0 0 0 0 0 0|0 0|0 0|0 0|0 0|0 +X 2699775 . C A . . . GT 0 0 0 0 0 0|0 0|0 0|0 0|0 0|0 +X 2699898 . C CT . . . GT 0 0 1 0 1 1|0 1|0 0|0 0|0 0|1 +X 2699968 . A G . . . GT . 0 0 1 0 0|1 0|0 0|0 0|1 1|0 +X 2699970 . T C . . . GT 0 0 0 0 0 0|0 0|0 0|0 0|0 0|0 diff --git a/test/convert.gt.vcf b/test/convert.gt.vcf new file mode 100644 index 000000000..7c719a2a3 --- /dev/null +++ b/test/convert.gt.vcf @@ -0,0 +1,43 @@ +##fileformat=VCFv4.1 +##FILTER= +##FORMAT= +##contig= +##bcftools_normVersion=1.2+htslib-1.2.1 +##bcftools_normCommand=norm -m - convert.vcf +##bcftools_annotateVersion=1.2+htslib-1.2.1 +##bcftools_annotateCommand=annotate -x FORMAT,QUAL +#CHROM POS ID REF ALT QUAL FILTER INFO FORMAT NA00001 NA00002 NA00003 NA00004 NA00005 NA00006 NA00007 NA00008 NA00009 NA00010 +X 2698560 . G A . . . GT 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 +X 2698630 . A G . . . GT 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 +X 2698758 . CAA C . . . GT 0|0 0|1 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 +X 2698769 . AAG A . . . GT 1|0 1|1 0|1 1|0 1|0 0|0 0|0 0|0 0|0 0|0 +X 2698770 . AG A . . . GT 0|0 0|1 0|0 0|0 1|0 0|0 0|0 0|0 0|0 0|0 +X 2698770 . AG AAGG . . . GT 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 +X 2698789 . C G . . . GT 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 +X 2698822 . A C . . . GT 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 +X 2698831 . G A . . . GT 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 +X 2698889 . T C . . . GT 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 +X 2698923 . G A . . . GT 1|0 0|1 0|1 1|0 1|0 0|0 0|0 0|0 0|0 0|0 +X 2698953 . A AGG . . . GT 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 +X 2698954 . G A . . . GT 1|0 1|1 0|1 1|0 1|0 0|0 0|0 0|1 0|0 0|0 +X 2699002 . C A . . . GT 0|0 0|0 .|. 0|0 0|0 0|0 0|0 0|0 0|0 0|0 +X 2699025 . T C . . . GT 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 +X 2699091 . G A . . . GT 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 +X 2699187 . T C . . . GT 0|0 0|0 1|0 0|0 0|1 1|0 1|0 0|0 0|0 0/1 +X 2699188 . G C . . . GT 0|0 0|0 1|0 0|0 0|1 1|0 1|0 0|0 0|0 0|1 +X 2699189 . T C . . . GT 0|0 0|0 1|0 0|0 0|1 1|0 1|0 0|0 0|0 0|1 +X 2699217 . C T . . . GT 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 +X 2699246 . C A . . . GT 1|0 1|1 0|1 1|1 1|0 0|1 0|0 0|1 0|0 1|0 +X 2699275 . T G . . . GT 0|0 0|0 1|0 0|0 0|1 1|1 1|0 0|0 0|0 0|1 +X 2699350 . A T . . . GT 0|0 0|0 1|0 0|0 0|1 1|0 1|0 0|0 0|0 0|1 +X 2699360 . T C . . . GT 0|0 0|0 1|0 0|0 0|1 1|0 1|0 0|0 0|0 0|1 +X 2699450 . A C . . . GT 0|0 0|0 1|0 0|0 0|1 1|0 1|0 0|0 0|0 0|1 +X 2699507 . T C . . . GT 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 0|0 +X 2699555 . C A . . . GT 0 1 1 0 1 1|1 1|0 0|1 0|0 0|1 +X 2699645 . G T . . . GT 0 1 0 0 0 0|0 0|0 0|1 0|0 0|0 +X 2699676 . G A . . . GT 0 0 1 0 1 1|0 1|0 0|0 0|0 0|1 +X 2699728 . C T . . . GT 0 0 0 0 0 0|0 0|0 0|0 0|0 0|0 +X 2699775 . C A . . . GT 0 0 0 0 0 0|0 0|0 0|0 0|0 0|0 +X 2699898 . C CT . . . GT 0 0 1 0 1 1|0 1|0 0|0 0|0 0|1 +X 2699968 . A G . . . GT . 0 0 1 0 0|1 0|0 0|0 0|1 1|0 +X 2699970 . T C . . . GT 0 0 0 0 0 0|0 0|0 0|0 0|0 0|0 diff --git a/test/convert.hls.gt.hap b/test/convert.hls.gt.hap new file mode 100644 index 000000000..a5db463c0 --- /dev/null +++ b/test/convert.hls.gt.hap @@ -0,0 +1,34 @@ +0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +0 0 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 1 1 0 1 1 0 1 0 0 0 0 0 0 0 0 0 0 0 +0 0 0 1 0 0 0 0 1 0 0 0 0 0 0 0 0 0 0 0 +0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 0 1 0 1 1 0 1 0 0 0 0 0 0 0 0 0 0 0 +0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 1 1 0 1 1 0 1 0 0 0 0 0 0 1 0 0 0 0 +0 0 0 0 ? ? 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +0 0 0 0 1 0 0 0 0 1 1 0 1 0 0 0 0 0 0* 1* +0 0 0 0 1 0 0 0 0 1 1 0 1 0 0 0 0 0 0 1 +0 0 0 0 1 0 0 0 0 1 1 0 1 0 0 0 0 0 0 1 +0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 1 1 0 1 1 1 1 0 0 1 0 0 0 1 0 0 1 0 +0 0 0 0 1 0 0 0 0 1 1 1 1 0 0 0 0 0 0 1 +0 0 0 0 1 0 0 0 0 1 1 0 1 0 0 0 0 0 0 1 +0 0 0 0 1 0 0 0 0 1 1 0 1 0 0 0 0 0 0 1 +0 0 0 0 1 0 0 0 0 1 1 0 1 0 0 0 0 0 0 1 +0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +0 - 1 - 1 - 0 - 1 - 1 1 1 0 0 1 0 0 0 1 +0 - 1 - 0 - 0 - 0 - 0 0 0 0 0 1 0 0 0 0 +0 - 0 - 1 - 0 - 1 - 1 0 1 0 0 0 0 0 0 1 +0 - 0 - 0 - 0 - 0 - 0 0 0 0 0 0 0 0 0 0 +0 - 0 - 0 - 0 - 0 - 0 0 0 0 0 0 0 0 0 0 +0 - 0 - 1 - 0 - 1 - 1 0 1 0 0 0 0 0 0 1 +? - 0 - 0 - 1 - 0 - 0 1 0 0 0 0 0 1 1 0 +0 - 0 - 0 - 0 - 0 - 0 0 0 0 0 0 0 0 0 0 diff --git a/test/convert.hls.gt.legend b/test/convert.hls.gt.legend new file mode 100644 index 000000000..990d7725c --- /dev/null +++ b/test/convert.hls.gt.legend @@ -0,0 +1,35 @@ +id position a0 a1 +X:2698560_G_A 2698560 G A +X:2698630_A_G 2698630 A G +X:2698758_CAA_C 2698758 CAA C +X:2698769_AAG_A 2698769 AAG A +X:2698770_AG_A 2698770 AG A +X:2698770_AG_AAGG 2698770 AG AAGG +X:2698789_C_G 2698789 C G +X:2698822_A_C 2698822 A C +X:2698831_G_A 2698831 G A +X:2698889_T_C 2698889 T C +X:2698923_G_A 2698923 G A +X:2698953_A_AGG 2698953 A AGG +X:2698954_G_A 2698954 G A +X:2699002_C_A 2699002 C A +X:2699025_T_C 2699025 T C +X:2699091_G_A 2699091 G A +X:2699187_T_C 2699187 T C +X:2699188_G_C 2699188 G C +X:2699189_T_C 2699189 T C +X:2699217_C_T 2699217 C T +X:2699246_C_A 2699246 C A +X:2699275_T_G 2699275 T G +X:2699350_A_T 2699350 A T +X:2699360_T_C 2699360 T C +X:2699450_A_C 2699450 A C +X:2699507_T_C 2699507 T C +X:2699555_C_A 2699555 C A +X:2699645_G_T 2699645 G T +X:2699676_G_A 2699676 G A +X:2699728_C_T 2699728 C T +X:2699775_C_A 2699775 C A +X:2699898_C_CT 2699898 C CT +X:2699968_A_G 2699968 A G +X:2699970_T_C 2699970 T C diff --git a/test/convert.hls.gt.samples b/test/convert.hls.gt.samples new file mode 100644 index 000000000..c1eea1a98 --- /dev/null +++ b/test/convert.hls.gt.samples @@ -0,0 +1,11 @@ +sample population group sex +NA00001 NA00001 NA00001 2 +NA00002 NA00002 NA00002 2 +NA00003 NA00003 NA00003 2 +NA00004 NA00004 NA00004 2 +NA00005 NA00005 NA00005 2 +NA00006 NA00006 NA00006 2 +NA00007 NA00007 NA00007 2 +NA00008 NA00008 NA00008 2 +NA00009 NA00009 NA00009 2 +NA00010 NA00010 NA00010 2 diff --git a/test/test.pl b/test/test.pl index e89bee534..8b3ae3a21 100755 --- a/test/test.pl +++ b/test/test.pl @@ -196,6 +196,7 @@ test_vcf_convert($opts,in=>'convert',out=>'convert.hls.haps',args=>'-h -,.,.'); test_vcf_convert($opts,in=>'convert',out=>'convert.hls.legend',args=>'-h .,-,.'); test_vcf_convert($opts,in=>'convert',out=>'convert.hls.samples',args=>'-h .,.,-'); +test_vcf_convert_hls2vcf($opts,h=>'convert.hls.gt.hap',l=>'convert.hls.gt.legend',s=>'convert.hls.gt.samples',out=>'convert.gt.noHead.vcf',args=>'-H'); test_vcf_convert($opts,in=>'convert',out=>'convert.hs.hap',args=>'--hapsample -,.'); test_vcf_convert($opts,in=>'convert',out=>'convert.hs.sample',args=>'--hapsample .,-'); test_vcf_convert_gvcf($opts,in=>'convert.gvcf',out=>'convert.gvcf.out',fa=>'gvcf.fa',args=>'--gvcf2vcf'); @@ -506,6 +507,13 @@ sub test_vcf_convert test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools convert $args{args} $$opts{tmp}/$args{in}.vcf.gz"); test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools view -Ob $$opts{tmp}/$args{in}.vcf.gz | $$opts{bin}/bcftools convert $args{args}"); } +sub test_vcf_convert_hls2vcf +{ + my ($opts,%args) = @_; + my $hls = join(',', map { "$$opts{path}/$_" }( $args{h}, $args{l}, $args{s} ) ); + test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools convert $args{args} $hls | grep -v ^##"); + test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools convert $args{args} $hls -Ou | $$opts{bin}/bcftools view | grep -v ^##"); +} sub test_vcf_convert_gvcf { my ($opts,%args) = @_; diff --git a/vcfconvert.c b/vcfconvert.c index b9cfc46b1..f602648d5 100644 --- a/vcfconvert.c +++ b/vcfconvert.c @@ -241,27 +241,61 @@ static int tsv_setter_haps(tsv_t *tsv, bcf1_t *rec, void *usr) if ( args->rev_als ) { a0 = bcf_gt_phased(1); a1 = bcf_gt_phased(0); } else { a0 = bcf_gt_phased(0); a1 = bcf_gt_phased(1); } + // up is short for "unphased" + int nup = 0; for (i=0; iss + 4*i; + char *ss = tsv->ss + 4*i + nup; + int up = 0, all; - if ( !ss[0] || !ss[1] || !ss[2] ) + for (all=0; all < 2; all++){ + // checking for premature ending + if ( !ss[0] || !ss[1] || !ss[2] || + (up && (!ss[3] || !ss[4]) ) ) + { + fprintf(stderr,"Wrong number of fields at %d-th sample ([%c][%c][%c]). ",i+1,ss[0],ss[1],ss[2]); + return -1; + } + + switch(ss[all*2+up]){ + case '0': + args->gts[2*i+all] = a0; + break; + case '1' : + args->gts[2*i+all] = a1; + break; + case '?' : + // there is no macro to express phased missing allele + args->gts[2*i+all] = bcf_gt_phased(-1); + break; + case '-' : + args->gts[2*i+all] = bcf_int32_vector_end; + break; + default : + fprintf(stderr,"Could not parse: [%c][%s]\n", ss[all*2+up],tsv->ss); + return -1; + } + if( ss[all*2+up+1]=='*' ) up = up + 1; + } + + if(up && up != 2) { - fprintf(stderr,"Wrong number of fields at %d-th sample ([%c][%c][%c]). ",i+1,ss[0],ss[1],ss[2]); + fprintf(stderr,"Missing unphased marker '*': [%c][%s]", ss[2+up], tsv->ss); return -1; } - if ( ss[0]=='0' ) args->gts[2*i] = a0; - else if ( ss[0]=='1' ) args->gts[2*i] = a1; - else { fprintf(stderr,"Could not parse: [%c][%s]\n", ss[0],tsv->ss); return -1; } - - if ( ss[2]=='0' ) args->gts[2*i+1] = a0; - else if ( ss[2]=='1' ) args->gts[2*i+1] = a1; - else { fprintf(stderr,"Could not parse: [%c][%s]\n", ss[2],tsv->ss); return -1; } + // change alleles to unphased if the alleles are unphased + if ( up ) + { + args->gts[2*i] = bcf_gt_unphased(bcf_gt_allele(args->gts[2*i])); + args->gts[2*i+1] = bcf_gt_unphased(bcf_gt_allele(args->gts[2*i+1])); + } + nup = nup + up; } - if ( tsv->ss[(nsamples-1)*4+3] ) + if ( tsv->ss[(nsamples-1)*4+3+nup] ) { - fprintf(stderr,"Wrong number of fields (%d-th column = [%c]). ", nsamples*2,tsv->ss[(nsamples-1)*4+1]); + fprintf(stderr,"nup: %d", nup); + fprintf(stderr,"Wrong number of fields (%d-th column = [%c]). ", nsamples*2,tsv->ss[(nsamples-1)*4+nup]); return -1; } @@ -379,13 +413,14 @@ static void haplegendsample_to_vcf(args_t *args) * Convert from IMPUTE2 hap/legend/sample output files to VCF * * hap: - * 0 1 0 1 1 1 + * 0 1 0 1 * legend: * id position a0 a1 * 1:186946386_G_T 186946386 G T * sample: - * QTL190044 - * QTL190053 + * sample population group sex + * sample1 sample1 sample1 2 + * sample2 sample2 sample2 2 * * Output: VCF with filled GT */ @@ -444,16 +479,20 @@ static void haplegendsample_to_vcf(args_t *args) bcf_hdr_printf(args->header, "##contig=", args->str.s,0x7fffffff); // MAX_CSI_COOR bcf_hdr_append_version(args->header, args->argc, args->argv, "bcftools_convert"); - int i, nsamples; - char **samples = hts_readlist(sample_fname, 1, &nsamples); - for (i=0; iheader,samples[i]); } bcf_hdr_add_sample(args->header,NULL); - for (i=0; ioutfname,hts_bcf_wmode(args->output_type)); From c29c8c31431642a0890e838b01028dc5b001682e Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Mon, 16 Mar 2015 21:10:48 +0000 Subject: [PATCH 079/211] Fixed bug in trio calling introduced by bcc7b26e --- mcall.c | 33 +++++++++++++++++---------------- 1 file changed, 17 insertions(+), 16 deletions(-) diff --git a/mcall.c b/mcall.c index b37593c1b..ddb5d625c 100644 --- a/mcall.c +++ b/mcall.c @@ -900,10 +900,11 @@ static void mcall_call_genotypes(call_t *call, bcf1_t *rec, int nals, int nout_a static void mcall_call_trio_genotypes(call_t *call, bcf1_t *rec, int nals, int nout_als, int out_als) { int ia, ib, i; - int nsmpl = bcf_hdr_nsamples(call->hdr); - int ngts = nals*(nals+1)/2; - double *gls = call->GLs - ngts; - double *pdg = call->pdg - ngts; + int nsmpl = bcf_hdr_nsamples(call->hdr); + int ngts = nals*(nals+1)/2; + int nout_gts = nout_als*(nout_als+1)/2; + double *gls = call->GLs - nout_gts; + double *pdg = call->pdg - ngts; // Calculate individuals' genotype likelihoods P(X=i) int isample; @@ -912,19 +913,19 @@ static void mcall_call_trio_genotypes(call_t *call, bcf1_t *rec, int nals, int n int ploidy = call->ploidy ? call->ploidy[isample] : 2; int32_t *gts = call->ugts + isample; - gls += ngts; + gls += nout_gts; pdg += ngts; // Skip samples with all pdg's equal to 1. These have zero depth. for (i=0; isample[i]; - double *gl = call->GLs + ngts*ismpl; + double *gl = call->GLs + nout_gts*ismpl; if ( gl[0]==1 ) continue; int j, jmax = 0; double max = gl[0]; - for (j=1; jsample[i]; - double *gl = call->GLs + ngts*ismpl; + double *gl = call->GLs + nout_gts*ismpl; if ( gl[0]==1 ) continue; int igt = trio[itr]>>((2-i)*4) & 0xf; assert( !call->ploidy || call->ploidy[ismpl]>0 ); @@ -1042,10 +1043,10 @@ static void mcall_call_trio_genotypes(call_t *call, bcf1_t *rec, int nals, int n if ( !uc_is_mendelian ) { uc_lk += log(1 - trio_Pm); - //fprintf(stderr,"c_lk=%e uc_lk=%e c_itr=%d%d%d uc_itr=%d%d%d\n", c_lk,uc_lk,c_itr>>8&0xf,c_itr>>4&0xf,c_itr&0xf,uc_itr>>8&0xf,uc_itr>>4&0xf,uc_itr&0xf); + // fprintf(stderr,"c_lk=%e uc_lk=%e c_itr=%d%d%d uc_itr=%d%d%d\n", c_lk,uc_lk,c_itr>>8&0xf,c_itr>>4&0xf,c_itr&0xf,uc_itr>>8&0xf,uc_itr>>4&0xf,uc_itr&0xf); if ( c_lk < uc_lk ) { c_lk = uc_lk; c_itr = uc_itr; } } - //fprintf(stderr,"best_lk=%e best_itr=%d%d%d uc_itr=%d%d%d\n", c_lk,c_itr>>8&0xf,c_itr>>4&0xf,c_itr&0xf,uc_itr>>8&0xf,uc_itr>>4&0xf,uc_itr&0xf); + // fprintf(stderr,"best_lk=%e best_itr=%d%d%d uc_itr=%d%d%d\n", c_lk,c_itr>>8&0xf,c_itr>>4&0xf,c_itr&0xf,uc_itr>>8&0xf,uc_itr>>4&0xf,uc_itr&0xf); // Set genotypes for father, mother, child and calculate genotype qualities for (i=0; i<3; i++) @@ -1053,11 +1054,11 @@ static void mcall_call_trio_genotypes(call_t *call, bcf1_t *rec, int nals, int n // GT int ismpl = fam->sample[i]; int igt = c_itr>>((2-i)*4) & 0xf; - double *gl = call->GLs + ngts*ismpl; + double *gl = call->GLs + nout_gts*ismpl; int32_t *gts = call->cgts + ismpl; if ( gl[0]==1 || igt==GT_SKIP ) // zero depth, set missing genotypes { - gts[0] = bcf_gt_missing; + gts[0] = -1; // bcf_float_set_missing(call->GQs[ismpl]); continue; } @@ -1107,7 +1108,7 @@ static void mcall_call_trio_genotypes(call_t *call, bcf1_t *rec, int nals, int n cgts++; ugts++; gts += 2; - if ( bcf_gt_is_missing(ugts[0]) ) + if ( ugts[0]==-1 ) { gts[0] = bcf_gt_missing; gts[1] = ploidy==2 ? bcf_gt_missing : bcf_int32_vector_end; From 537228096a897fc814cfb60d6599189835ba976e Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Wed, 30 Sep 2015 08:03:35 +0100 Subject: [PATCH 080/211] vcfindex: make index -s work even if length attribute is not present --- vcfindex.c | 8 +------- 1 file changed, 1 insertion(+), 7 deletions(-) diff --git a/vcfindex.c b/vcfindex.c index 24ac8a87a..e40fab52c 100644 --- a/vcfindex.c +++ b/vcfindex.c @@ -97,13 +97,7 @@ int vcf_index_stats(char *fname, int stats) if (stats&2 || !records) continue; bcf_hrec_t *hrec = bcf_hdr_get_hrec(hdr, BCF_HL_CTG, "ID", seq[i], NULL); int hkey = hrec ? bcf_hrec_find_key(hrec, "length") : -1; - if (hkey<0) - { - fprintf(stderr,"could not get contig length for %s\n", seq[i]); - return 1; - } - fprintf(out, "%s\t%s", seq[i], strcmp(hrec->vals[hkey], "2147483647")==0 ? "." : hrec->vals[hkey]); - fprintf(out, "\t%" PRIu64 "\n", records); + fprintf(out,"%s\t%s\t%" PRIu64 "\n", seq[i], hkey<0?".":hrec->vals[hkey], records); } if (!sum) { From 6d2faf230ec8caf6d1dddbaeb6e3a152fc13c68d Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Thu, 24 Sep 2015 14:30:38 +0100 Subject: [PATCH 081/211] Bringing "call --gvcf" from experimental to main repo. --- call.h | 18 +---- gvcf.c | 190 ++++++++++++++++++++++++++++++++++++++------- gvcf.h | 41 ++++++++++ mcall.c | 31 +++----- test/mpileup.2.out | 27 +++---- test/test.pl | 2 +- vcfcall.c | 110 ++++++++++---------------- 7 files changed, 277 insertions(+), 142 deletions(-) create mode 100644 gvcf.h diff --git a/call.h b/call.h index cc5e6d7b0..bbf0a52b4 100644 --- a/call.h +++ b/call.h @@ -33,8 +33,8 @@ THE SOFTWARE. */ #define CALL_VARONLY (1<<1) #define CALL_CONSTR_TRIO (1<<2) #define CALL_CONSTR_ALLELES (1<<3) -#define CALL_CHR_X (1<<4) -#define CALL_CHR_Y (1<<5) +// +// #define CALL_FMT_GQ (1<<6) #define CALL_FMT_GP (1<<7) @@ -49,15 +49,6 @@ typedef struct } family_t; -typedef struct -{ - int min_dp, mdp; // minimum per-sample depth of a gVCF block - int32_t rid, start, end, *gt, *dp; - char ref[2]; // reference base at start position - bcf1_t *line; -} -gvcf_t; - typedef struct _ccall_t ccall_t; typedef struct { @@ -96,7 +87,7 @@ typedef struct bcf1_t *rec; bcf_hdr_t *hdr; uint32_t flag; // One or more of the CALL_* flags defined above - uint8_t *ploidy, all_diploid; + uint8_t *ploidy, all_diploid, unseen; double pl2p[256]; // PL to 10^(-PL/10) table int32_t *PLs; // VCF PL likelihoods (rw) @@ -129,9 +120,6 @@ void qcall_destroy(call_t *call); void call_init_pl2p(call_t *call); uint32_t *call_trio_prep(int is_x, int is_son); -/** gVCF */ -void gvcf_write(htsFile *fh, gvcf_t *gvcf, bcf_hdr_t *hdr, bcf1_t *rec, int is_ref); - void init_allele_trimming_maps(call_t *call, int als, int nals); void mcall_trim_numberR(call_t *call, bcf1_t *rec, int nals, int nout_als, int out_als); diff --git a/gvcf.c b/gvcf.c index bba5df767..b82d658d8 100644 --- a/gvcf.c +++ b/gvcf.c @@ -1,6 +1,6 @@ /* gvcf.c -- support for gVCF files. - Copyright (C) 2014 Genome Research Ltd. + Copyright (C) 2014-2015 Genome Research Ltd. Author: Petr Danecek @@ -22,33 +22,117 @@ LIABILITY, WHETHER IN AN ACTION OF CONTRACT, TORT OR OTHERWISE, ARISING FROM, OUT OF OR IN CONNECTION WITH THE SOFTWARE OR THE USE OR OTHER DEALINGS IN THE SOFTWARE. */ -#include "call.h" +#include "gvcf.h" +#include "bcftools.h" -void gvcf_write(htsFile *fh, gvcf_t *gvcf, bcf_hdr_t *hdr, bcf1_t *rec, int is_ref) +struct _gvcf_t +{ + int *dp_range, ndp_range; // per-sample DP ranges + int prev_range; // 0 if not in a block + int32_t *dp, mdp, *pl, mpl, npl; + int32_t *tmp, mtmp, *gts, ngts,mgts, nqsum,mqsum; + float *qsum; + int32_t rid, start, end, min_dp; + kstring_t als; + bcf1_t *line; +}; + +void gvcf_update_header(gvcf_t *gvcf, bcf_hdr_t *hdr) +{ + bcf_hdr_append(hdr,"##INFO="); + bcf_hdr_append(hdr,"##INFO="); +} + +gvcf_t *gvcf_init(const char *dp_ranges) +{ + gvcf_t *gvcf = (gvcf_t*) calloc(1,sizeof(gvcf_t)); + gvcf->line = bcf_init(); + + int n = 1; + const char *ss = dp_ranges; + while ( *ss ) + { + if ( *ss==',' ) n++; + ss++; + } + gvcf->ndp_range = n; + gvcf->dp_range = (int*) malloc(sizeof(int)*gvcf->ndp_range); + + n = 0; + ss = dp_ranges; + while ( *ss ) + { + char *se = (char*) ss; + gvcf->dp_range[n++] = strtol(ss,&se,10); + if ( se==ss ) return NULL; + if ( *se==',' && se[1] ) { ss = se+1; continue; } + else if ( !*se ) break; + return NULL; + } + return gvcf; +} + +void gvcf_destroy(gvcf_t *gvcf) +{ + free(gvcf->dp_range); + free(gvcf->dp); + free(gvcf->pl); + free(gvcf->tmp); + free(gvcf->qsum); + free(gvcf->gts); + free(gvcf->als.s); + if ( gvcf->line ) bcf_destroy(gvcf->line); + free(gvcf); +} + +bcf1_t *gvcf_write(gvcf_t *gvcf, htsFile *fh, bcf_hdr_t *hdr, bcf1_t *rec, int is_ref) { int i, ret, nsmpl = bcf_hdr_nsamples(hdr); + int can_collapse = is_ref ? 1 : 0; + int32_t dp_range = 0, min_dp = 0; + + // No record and nothing to flush? + if ( !rec && !gvcf->prev_range ) return NULL; - // Flush gVCF block if chr changed, non-ref call encountered, depth is too - // low, or no more records to come - if ( rec && is_ref ) + // Flush gVCF block if there are no more records, chr changed, a gap + // encountered, or other conditions not met (block broken by a non-ref or DP too low). + int needs_flush = can_collapse ? 0 : 1; + + + // Can the record be included in a gVCF block? That is, is this a ref-only site? + if ( rec && can_collapse ) { bcf_unpack(rec, BCF_UN_ALL); // per-sample depth - ret = bcf_get_format_int32(hdr, rec, "DP", &gvcf->dp, &gvcf->mdp); + ret = bcf_get_format_int32(hdr, rec, "DP", &gvcf->tmp, &gvcf->mtmp); if ( ret==nsmpl ) { - for (i=0; idp[i] < gvcf->min_dp ) break; - if ( itmp[0]; + for (i=1; i gvcf->tmp[i] ) min_dp = gvcf->tmp[i]; + + for (i=0; indp_range; i++) + if ( min_dp < gvcf->dp_range[i] ) break; + + dp_range = i; + if ( !dp_range ) { - is_ref = 0; // the depth is too low - rec = NULL; + // leave the record unchanged, DP is too small. Alternatively, return NULL here + // to skip these sites + needs_flush = 1; + can_collapse = 0; } } + else + needs_flush = 1; // DP field not present } - if ( gvcf->rid!=-1 && (!rec || gvcf->rid!=rec->rid || !is_ref || rec->pos > gvcf->end+1) ) + if ( gvcf->prev_range && gvcf->prev_range!=dp_range ) needs_flush = 1; + if ( !rec || gvcf->rid!=rec->rid || rec->pos > gvcf->end+1 ) needs_flush = 1; + + // If prev_range is set, something can be flushed + if ( gvcf->prev_range && needs_flush ) { // mpileup can output two records with the same position, SNP and // indel. Make sure the end position does not include the non-variant @@ -61,29 +145,83 @@ void gvcf_write(htsFile *fh, gvcf_t *gvcf, bcf_hdr_t *hdr, bcf1_t *rec, int is_r gvcf->line->rid = gvcf->rid; gvcf->line->pos = gvcf->start; gvcf->line->rlen = gvcf->end - gvcf->start; - bcf_update_alleles_str(hdr, gvcf->line, gvcf->ref); - bcf_update_info_int32(hdr, gvcf->line, "END", &gvcf->end, 1); - bcf_update_genotypes(hdr, gvcf->line, gvcf->gt, nsmpl*2); + bcf_update_alleles_str(hdr, gvcf->line, gvcf->als.s); + if ( gvcf->start+1 < gvcf->end ) // create gVCF record only if it spans at least two sites + bcf_update_info_int32(hdr, gvcf->line, "END", &gvcf->end, 1); + bcf_update_info_int32(hdr, gvcf->line, "MinDP", &gvcf->min_dp, 1); + if ( gvcf->nqsum>0 ) + bcf_update_info_float(hdr, gvcf->line, "QS", gvcf->qsum, gvcf->nqsum); + if ( gvcf->ngts ) + bcf_update_genotypes(hdr,gvcf->line,gvcf->gts,gvcf->ngts); + if ( gvcf->npl>0 ) + bcf_update_format_int32(hdr, gvcf->line, "PL", gvcf->pl, gvcf->npl); + bcf_update_format_int32(hdr, gvcf->line, "DP", gvcf->dp, nsmpl); bcf_write1(fh, hdr, gvcf->line); + gvcf->prev_range = 0; + gvcf->rid = -1; + gvcf->npl = 0; + gvcf->nqsum = 0; + gvcf->ngts = 0; - gvcf->rid = -1; + if ( !rec ) return NULL; // just flushing the buffer, this was last record } - if ( !rec ) return; - - if ( is_ref ) + if ( can_collapse ) { - if ( gvcf->rid==-1 ) + if ( !gvcf->prev_range ) { + hts_expand(int32_t,nsmpl,gvcf->mdp,gvcf->dp); + memcpy(gvcf->dp,gvcf->tmp,nsmpl*sizeof(int32_t)); // tmp still contains DP from rec + gvcf->npl = bcf_get_format_int32(hdr, rec, "PL", &gvcf->pl, &gvcf->mpl); + + gvcf->nqsum = bcf_get_info_float(hdr,rec,"QS",&gvcf->qsum,&gvcf->mqsum); + gvcf->ngts = bcf_get_genotypes(hdr,rec,&gvcf->gts,&gvcf->mgts); + gvcf->rid = rec->rid; gvcf->start = rec->pos; - gvcf->ref[0] = rec->d.allele[0][0]; - gvcf->ref[1] = 0; + gvcf->als.l = 0; + kputs(rec->d.allele[0],&gvcf->als); + for (i=1; in_allele; i++) + { + kputc(',',&gvcf->als); + kputs(rec->d.allele[i],&gvcf->als); + } + gvcf->min_dp = min_dp; + } + else + { + if ( gvcf->min_dp > min_dp ) gvcf->min_dp = min_dp; + for (i=0; idp[i] > gvcf->tmp[i] ) gvcf->dp[i] = gvcf->tmp[i]; + ret = bcf_get_format_int32(hdr, rec, "PL", &gvcf->tmp, &gvcf->mtmp); + if ( ret>=0 ) + { + if ( ret!=nsmpl*3 ) error("Unexpected number of PL fields\n"); + for (i=0; ipl[3*i+1] > gvcf->tmp[3*i+1] ) + { + gvcf->pl[3*i+1] = gvcf->tmp[3*i+1]; + gvcf->pl[3*i+2] = gvcf->tmp[3*i+2]; + } + else if ( gvcf->pl[3*i+1]==gvcf->tmp[3*i+1] && gvcf->pl[3*i+2] > gvcf->tmp[3*i+2] ) + gvcf->pl[3*i+2] = gvcf->tmp[3*i+2]; + } + } + else + gvcf->npl = 0; } - gvcf->end = rec->pos; - return; + gvcf->prev_range = dp_range; + if ( bcf_get_info_int32(hdr,rec,"END",&gvcf->tmp,&gvcf->mtmp)==1 ) + gvcf->end = gvcf->tmp[0] - 1; // from 1-based to 0-based + else + gvcf->end = rec->pos; + return NULL; } - bcf_write1(fh, hdr, rec); + if ( is_ref && min_dp ) + bcf_update_info_int32(hdr, rec, "MinDP", &min_dp, 1); + + return rec; } diff --git a/gvcf.h b/gvcf.h new file mode 100644 index 000000000..784e1f6d8 --- /dev/null +++ b/gvcf.h @@ -0,0 +1,41 @@ +/* gvcf.[ch] - Helper functions for gVCF support + + The MIT License + + Copyright (c) 2015 Genome Research Ltd. + + Author: Petr Danecek + + Permission is hereby granted, free of charge, to any person obtaining a copy + of this software and associated documentation files (the "Software"), to deal + in the Software without restriction, including without limitation the rights + to use, copy, modify, merge, publish, distribute, sublicense, and/or sell + copies of the Software, and to permit persons to whom the Software is + furnished to do so, subject to the following conditions: + + The above copyright notice and this permission notice shall be included in + all copies or substantial portions of the Software. + + THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS OR + IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF MERCHANTABILITY, + FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. IN NO EVENT SHALL THE + AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY CLAIM, DAMAGES OR OTHER + LIABILITY, WHETHER IN AN ACTION OF CONTRACT, TORT OR OTHERWISE, ARISING FROM, + OUT OF OR IN CONNECTION WITH THE SOFTWARE OR THE USE OR OTHER DEALINGS IN + THE SOFTWARE. + + */ + +#ifndef __GVCF_H__ +#define __GVCF_H__ + +#include "bcftools.h" + +typedef struct _gvcf_t gvcf_t; + +gvcf_t *gvcf_init(const char *dp_ranges); +void gvcf_update_header(gvcf_t *gvcf, bcf_hdr_t *hdr); +bcf1_t *gvcf_write(gvcf_t *gvcf, htsFile *fh, bcf_hdr_t *hdr, bcf1_t *rec, int is_ref); +void gvcf_destroy(gvcf_t *gvcf); + +#endif diff --git a/mcall.c b/mcall.c index ddb5d625c..e62fd4c47 100644 --- a/mcall.c +++ b/mcall.c @@ -691,7 +691,7 @@ static void mcall_set_ref_genotypes(call_t *call, int nals) int ngts = nals*(nals+1)/2; int nsmpl = bcf_hdr_nsamples(call->hdr); - for (i=0; i<4; i++) call->ac[i] = 0; + for (i=0; iac[i] = 0; call->nhets = 0; call->ndiploid = 0; @@ -1335,13 +1335,7 @@ static void mcall_constrain_alleles(call_t *call, bcf1_t *rec, int unseen) */ int mcall(call_t *call, bcf1_t *rec) { - int i, unseen = -1; - for (i=1; in_allele; i++) - { - if ( rec->d.allele[i][0]=='X' ) { unseen = i; break; } // old X - if ( rec->d.allele[i][0]=='<' && rec->d.allele[i][1]=='X' && rec->d.allele[i][1]=='>' ) { unseen = i; break; } // old - if ( rec->d.allele[i][0]=='<' && rec->d.allele[i][1]=='*' && rec->d.allele[i][1]=='>' ) { unseen = i; break; } // new <*> - } + int i, unseen = call->unseen; // Force alleles when calling genotypes given alleles was requested if ( call->flag & CALL_CONSTR_ALLELES ) mcall_constrain_alleles(call, rec, unseen); @@ -1417,9 +1411,7 @@ int mcall(call_t *call, bcf1_t *rec) nout = 0; for (i=0; id.allele[i][0]=='X' ) continue; // old version of unseen allele "X" - if ( rec->d.allele[i][0]=='<' && rec->d.allele[i][1]=='X' && rec->d.allele[i][2]=='>' ) continue; // old version of unseen allele, "" - if ( rec->d.allele[i][0]=='<' && rec->d.allele[i][1]=='*' && rec->d.allele[i][2]=='>' ) continue; // new version of unseen allele, "<*>" + if ( i>0 && i==unseen ) continue; out_als |= 1<hdr, rec, "HOB", &hob, 1); // Quality of a variant site. fabs() to avoid negative zeros in VCF output when CALL_KEEPALT is set - rec->qual = call->lk_sum==-HUGE_VAL ? 0 : fabs(-4.343*(call->ref_lk - call->lk_sum)); + rec->qual = call->lk_sum==-HUGE_VAL || call->ref_lk==0 ? 0 : fabs(-4.343*(call->ref_lk - call->lk_sum)); } else { // Set the quality of a REF site - rec->qual = call->lk_sum==-HUGE_VAL ? 0 : -4.343*log(1 - exp(call->ref_lk - call->lk_sum)); + rec->qual = call->lk_sum==-HUGE_VAL || call->ref_lk==0 ? 0 : -4.343*log(1 - exp(call->ref_lk - call->lk_sum)); } if ( rec->qual>999 ) rec->qual = 999; if ( rec->qual>50 ) rec->qual = rint(rec->qual); @@ -1492,13 +1484,14 @@ int mcall(call_t *call, bcf1_t *rec) bcf_update_genotypes(call->hdr, rec, call->gts, nsmpl*2); // DP4 tag - if ( bcf_get_info_float(call->hdr, rec, "I16", &call->anno16, &call->n16)!=16 ) - error("I16 hasn't 16 fields at %s:%d\n", call->hdr->id[BCF_DT_CTG][rec->rid].key,rec->pos+1); - int32_t dp[4]; dp[0] = call->anno16[0]; dp[1] = call->anno16[1]; dp[2] = call->anno16[2]; dp[3] = call->anno16[3]; - bcf_update_info_int32(call->hdr, rec, "DP4", dp, 4); + if ( bcf_get_info_float(call->hdr, rec, "I16", &call->anno16, &call->n16)==16 ) + { + int32_t dp[4]; dp[0] = call->anno16[0]; dp[1] = call->anno16[1]; dp[2] = call->anno16[2]; dp[3] = call->anno16[3]; + bcf_update_info_int32(call->hdr, rec, "DP4", dp, 4); - int32_t mq = (call->anno16[8]+call->anno16[10])/(call->anno16[0]+call->anno16[1]+call->anno16[2]+call->anno16[3]); - bcf_update_info_int32(call->hdr, rec, "MQ", &mq, 1); + int32_t mq = (call->anno16[8]+call->anno16[10])/(call->anno16[0]+call->anno16[1]+call->anno16[2]+call->anno16[3]); + bcf_update_info_int32(call->hdr, rec, "MQ", &mq, 1); + } bcf_update_info_int32(call->hdr, rec, "I16", NULL, 0); // remove I16 tag bcf_update_info_int32(call->hdr, rec, "QS", NULL, 0); // remove QS tag diff --git a/test/mpileup.2.out b/test/mpileup.2.out index 4a415ea8e..1090fbd52 100644 --- a/test/mpileup.2.out +++ b/test/mpileup.2.out @@ -19,6 +19,8 @@ ##FORMAT= ##FORMAT= ##FORMAT= +##INFO= +##INFO= ##FORMAT= ##INFO= ##INFO= @@ -26,28 +28,27 @@ ##INFO= ##INFO= ##INFO= -##INFO= #CHROM POS ID REF ALT QUAL FILTER INFO FORMAT HG00100 HG00101 HG00102 -17 1 . A . . . END=301 GT 0/0 0/0 0/0 +17 1 . A . . . END=301;MinDP=1 GT:DP 0/0:5 0/0:1 0/0:3 17 302 . T TA 488 . INDEL;IDV=7;IMF=1;DP=25;VDB=0.27613;SGB=-4.22417;MQSB=0.0443614;MQ0F=0;ICB=0.8;HOB=0.222222;AC=4;AN=6;DP4=2,4,8,11;MQ=49 GT:PL:DP:DV 0/1:167,0,96:11:6 0/1:157,0,9:7:6 1/1:201,21,0:7:7 -17 303 . G . . . END=827 GT 0/0 0/0 0/0 +17 303 . G . . . END=827;MinDP=2 GT:DP 0/0:9 0/0:2 0/0:3 17 828 . T C 409 . DP=25;VDB=0.842082;SGB=-4.20907;RPB=0.950652;MQB=1;MQSB=1;BQB=0.929717;MQ0F=0;ICB=0.8;HOB=0.222222;AC=4;AN=6;DP4=2,4,8,11;MQ=60 GT:PL:DP:DV 0/1:211,0,35:12:10 0/1:116,0,91:9:5 1/1:120,12,0:4:4 -17 829 . T . . . END=833 GT 0/0 0/0 0/0 +17 829 . T . . . END=833;MinDP=4 GT:DP 0/0:11 0/0:8 0/0:4 17 834 . G A 364 . DP=25;VDB=0.788006;SGB=-4.01214;RPB=0.999233;MQB=1;MQSB=1;BQB=0.821668;MQ0F=0;ICB=0.8;HOB=0.222222;AC=4;AN=6;DP4=2,3,7,10;MQ=60 GT:PL:DP:DV 0/1:185,0,46:11:9 0/1:128,0,59:8:5 1/1:89,9,0:3:3 -17 835 . T . . . END=1664 GT 0/0 0/0 0/0 +17 835 . T . . . END=1664;MinDP=1 GT:DP 0/0:5 0/0:2 0/0:1 17 1665 . T C 3.10665 . DP=20;VDB=0.1;SGB=0.346553;RPB=0.222222;MQB=0.611111;MQSB=0.988166;BQB=0.944444;MQ0F=0;ICB=0.128205;HOB=0.0555556;AC=1;AN=6;DP4=7,11,1,1;MQ=55 GT:PL:DP:DV 0/0:0,21,185:7:0 0/0:0,27,222:9:0 0/1:35,0,51:4:2 -17 1666 . G . . . END=1868 GT 0/0 0/0 0/0 +17 1666 . G . . . END=1868;MinDP=0 GT:DP 0/0:6 0/0:0 0/0:1 17 1869 . A T 138 . DP=24;VDB=0.928022;SGB=-11.9537;RPB=0.984127;MQB=0.96464;MQSB=0.931547;BQB=0.359155;MQ0F=0;ICB=0.8;HOB=0.222222;AC=4;AN=6;DP4=6,9,5,4;MQ=58 GT:PL:DP:DV 0/1:115,0,224:18:7 0/1:16,0,104:5:1 1/1:42,3,0:1:1 -17 1870 . C . . . END=2040 GT 0/0 0/0 0/0 +17 1870 . C . . . END=2040;MinDP=1 GT:DP 0/0:13 0/0:2 0/0:1 17 2041 . G A 447 . DP=31;VDB=0.816435;SGB=-4.18892;RPB=0.88473;MQB=0.972375;MQSB=0.968257;BQB=0.311275;MQ0F=0;ICB=0.8;HOB=0.222222;AC=4;AN=6;DP4=6,5,12,7;MQ=58 GT:PL:DP:DV 0/1:229,0,212:21:11 0/1:32,0,24:2:1 1/1:223,21,0:7:7 -17 2042 . G . . . END=2219 GT 0/0 0/0 0/0 +17 2042 . G . . . END=2219;MinDP=1 GT:DP 0/0:8 0/0:1 0/0:3 17 2220 . G A 303 . DP=21;VDB=0.532753;SGB=-3.51597;RPB=0.964198;MQB=0.898397;MQSB=0.875769;BQB=0.0354359;MQ0F=0;ICB=0.8;HOB=0.222222;AC=4;AN=6;DP4=6,2,1,11;MQ=58 GT:PL:DP:DV 0/1:139,0,130:12:6 0/1:69,0,46:4:2 1/1:131,12,0:4:4 -17 2221 . G . . . END=2563 GT 0/0 0/0 0/0 +17 2221 . G . . . END=2563;MinDP=0 GT:DP 0/0:5 0/0:0 0/0:2 17 2564 . A G 233 . DP=15;VDB=0.690812;SGB=-3.20711;RPB=0.197899;MQB=1;MQSB=1;BQB=0.965069;MQ0F=0;ICB=0.8;HOB=0.222222;AC=4;AN=6;DP4=1,4,4,5;MQ=60 GT:PL:DP:DV 0/1:88,0,78:6:3 0/1:57,0,56:4:2 1/1:124,12,0:4:4 -17 2565 . A . . . END=3103 GT 0/0 0/0 0/0 +17 2565 . A . . . END=3103;MinDP=0 GT:DP 0/0:6 0/0:0 0/0:1 17 3104 . C T 24.2837 . DP=25;VDB=0.8;SGB=0.346553;RPB=0.717391;MQB=0.956522;MQSB=0.962269;BQB=0.978261;MQ0F=0;ICB=0.128205;HOB=0.0555556;AC=1;AN=6;DP4=8,15,2,0;MQ=58 GT:PL:DP:DV 0/0:0,48,255:16:0 0/0:0,12,144:4:0 0/1:59,0,93:5:2 -17 3105 . T . . . END=3586 GT 0/0 0/0 0/0 +17 3105 . T . . . END=3586;MinDP=2 GT:DP 0/0:5 0/0:2 0/0:3 17 3587 . G A 358 . DP=29;VDB=0.902044;SGB=-3.91326;RPB=0.800999;MQB=1;MQSB=1;BQB=0.156944;MQ0F=0;ICB=0.8;HOB=0.222222;AC=4;AN=6;DP4=4,7,10,6;MQ=60 GT:PL:DP:DV 0/1:161,0,184:14:7 0/1:22,0,118:5:1 1/1:212,24,0:8:8 -17 3588 . A . . . END=3935 GT 0/0 0/0 0/0 +17 3588 . A . . . END=3935;MinDP=2 GT:DP 0/0:10 0/0:2 0/0:3 17 3936 . A G 469 . DP=37;VDB=0.0574114;SGB=-4.60123;RPB=0.741697;MQB=0.812605;MQSB=0.143788;BQB=0.883831;MQ0F=0;ICB=0.8;HOB=0.222222;AC=4;AN=6;DP4=5,6,6,17;MQ=56 GT:PL:DP:DV 0/1:233,0,206:20:11 0/1:77,0,58:6:4 1/1:196,24,0:8:8 -17 3937 . C . . . END=4101 GT 0/0 0/0 0/0 +17 3937 . C . . . END=4101;MinDP=0 GT:DP 0/0:1 0/0:0 0/0:0 diff --git a/test/test.pl b/test/test.pl index e89bee534..23a3fb499 100755 --- a/test/test.pl +++ b/test/test.pl @@ -129,7 +129,7 @@ test_vcf_view($opts,in=>'view.minmaxac',out=>'view.minmaxac.2.out',args=>q[-H -c6:nonmajor],reg=>''); test_vcf_view($opts,in=>'view.minmaxac',out=>'view.minmaxac.1.out',args=>q[-H -q0.3:major],reg=>''); test_vcf_call($opts,in=>'mpileup',out=>'mpileup.1.out',args=>'-mv'); -test_vcf_call($opts,in=>'mpileup',out=>'mpileup.2.out',args=>'-mvg0'); +test_vcf_call($opts,in=>'mpileup',out=>'mpileup.2.out',args=>'-mg0'); test_vcf_call($opts,in=>'mpileup.X',out=>'mpileup.X.out',args=>'-mv --ploidy-file {PATH}/mpileup.ploidy -S {PATH}/mpileup.samples'); test_vcf_call($opts,in=>'mpileup.X',out=>'mpileup.X.out',args=>'-mv --ploidy-file {PATH}/mpileup.ploidy -S {PATH}/mpileup.ped'); test_vcf_call_cAls($opts,in=>'mpileup',out=>'mpileup.cAls.out',tab=>'mpileup'); diff --git a/vcfcall.c b/vcfcall.c index 7943b9a1b..5633256a1 100644 --- a/vcfcall.c +++ b/vcfcall.c @@ -40,6 +40,7 @@ THE SOFTWARE. */ #include "call.h" #include "prob1.h" #include "ploidy.h" +#include "gvcf.h" void error(const char *format, ...); @@ -51,7 +52,7 @@ void error(const char *format, ...); #define CF_NO_GENO 1 #define CF_INS_MISSED (1<<1) #define CF_CCALL (1<<2) -#define CF_GVCF (1<<3) +// (1<<3) // (1<<4) // (1<<5) #define CF_ACGT_ONLY (1<<6) @@ -71,7 +72,7 @@ typedef struct htsFile *bcf_in, *out_fh; char *bcf_fname, *output_fname; char **samples; // for subsampling and ploidy - int nsamples, *samples_map; + int nsamples, *samples_map; // mapping from output sample names to original VCF char *regions, *targets; // regions to process int regions_is_file, targets_is_file; @@ -80,10 +81,10 @@ typedef struct int *sample2sex; // mapping for ploidy. If negative, interpreted as -1*ploidy int *sex2ploidy, *sex2ploidy_prev, nsex; ploidy_t *ploidy; + gvcf_t *gvcf; bcf1_t *missed_line; call_t aux; // parameters and temporary data - gvcf_t gvcf; int argc; char **argv; @@ -145,7 +146,7 @@ static ploidy_predef_t ploidy_predefs[] = "* * * F 2\n" }, { .alias = "GRCh38", - .about = "Human Genome reference assembly GRCh38 / hg38", + .about = "Human Genome reference assembly GRCh38 / hg38, plain chromosome naming (1,2,3,..)", .ploidy = "X 1 9999 M 1\n" "X 2781480 155701381 M 1\n" @@ -345,8 +346,6 @@ static void print_missed_line(bcf_sr_regions_t *regs, void *data) call_t *call = &args->aux; bcf1_t *missed = args->missed_line; - if ( args->flag & CF_GVCF ) error("todo: Combine --gvcf and --insert-missed\n"); - char *ss = regs->line.s; int i = 0; while ( iaux.srs->targets_als-1 && *ss ) @@ -405,6 +404,9 @@ static void init_data(args_t *args) for (i=0; insex; i++) args->sex2ploidy_prev[i] = 2; } + if ( args->gvcf ) + gvcf_update_header(args->gvcf, args->aux.hdr); + if ( args->samples_map ) { args->aux.hdr = bcf_hdr_subset(bcf_sr_get_header(args->aux.srs,0), args->nsamples, args->samples, args->samples_map); @@ -433,19 +435,6 @@ static void init_data(args_t *args) if ( args->flag & CF_CCALL ) ccall_init(&args->aux); - if ( args->flag&CF_GVCF ) - { - bcf_hdr_append(args->aux.hdr,"##INFO="); - args->gvcf.rid = -1; - args->gvcf.line = bcf_init1(); - args->gvcf.gt = (int32_t*) malloc(2*sizeof(int32_t)*bcf_hdr_nsamples(args->aux.hdr)); - for (i=0; iaux.hdr); i++) - { - args->gvcf.gt[2*i+0] = bcf_gt_unphased(0); - args->gvcf.gt[2*i+1] = bcf_gt_unphased(0); - } - } - bcf_hdr_remove(args->aux.hdr, BCF_HL_INFO, "QS"); bcf_hdr_remove(args->aux.hdr, BCF_HL_INFO, "I16"); @@ -469,15 +458,13 @@ static void destroy_data(args_t *args) } if ( args->missed_line ) bcf_destroy(args->missed_line); ploidy_destroy(args->ploidy); - if ( args->gvcf.line ) bcf_destroy(args->gvcf.line); - free(args->gvcf.gt); - free(args->gvcf.dp); free(args->sex2ploidy); free(args->sex2ploidy_prev); free(args->samples); free(args->samples_map); free(args->sample2sex); free(args->aux.ploidy); + if ( args->gvcf ) gvcf_destroy(args->gvcf); bcf_hdr_destroy(args->aux.hdr); hts_close(args->out_fh); bcf_sr_destroy(args->aux.srs); @@ -598,14 +585,14 @@ static void usage(args_t *args) fprintf(stderr, " -r, --regions restrict to comma-separated list of regions\n"); fprintf(stderr, " -R, --regions-file restrict to regions listed in a file\n"); fprintf(stderr, " -s, --samples list of samples to include [all samples]\n"); - fprintf(stderr, " -S, --samples-file PED file or a file with optional second column for ploidy (0, 1 or 2) [all samples]\n"); + fprintf(stderr, " -S, --samples-file PED file or a file with an optional column with sex (see man page for details) [all samples]\n"); fprintf(stderr, " -t, --targets similar to -r but streams rather than index-jumps\n"); fprintf(stderr, " -T, --targets-file similar to -R but streams rather than index-jumps\n"); fprintf(stderr, "\n"); fprintf(stderr, "Input/output options:\n"); fprintf(stderr, " -A, --keep-alts keep all possible alternate alleles at variant sites\n"); fprintf(stderr, " -f, --format-fields output format fields: GQ,GP (lowercase allowed) []\n"); - fprintf(stderr, " -g, --gvcf output gVCF blocks of homozygous REF calls\n"); + fprintf(stderr, " -g, --gvcf ,[...] group non-variant sites into gVCF blocks by minimum per-sample DP\n"); fprintf(stderr, " -i, --insert-missed output also sites missed by mpileup but present in -T\n"); fprintf(stderr, " -M, --keep-masked-ref keep sites with masked reference allele (REF=N)\n"); fprintf(stderr, " -V, --skip-variants skip indels/snps\n"); @@ -618,8 +605,6 @@ static void usage(args_t *args) fprintf(stderr, " -n, --novel-rate ,[...] likelihood of novel mutation for constrained trio calling, see man page for details [1e-8,1e-9,1e-9]\n"); fprintf(stderr, " -p, --pval-threshold variant if P(ref|D) mutation rate (use bigger for greater sensitivity) [1.1e-3]\n"); - fprintf(stderr, " -X, --chromosome-X haploid output for male samples (requires PED file with -s)\n"); - fprintf(stderr, " -Y, --chromosome-Y haploid output for males and skips females (requires PED file with -s)\n"); // todo (and more) // fprintf(stderr, "\nContrast calling and association test options:\n"); @@ -653,8 +638,8 @@ int main_vcfcall(int argc, char *argv[]) static struct option loptions[] = { {"help",0,0,'h'}, - {"gvcf",1,0,'g'}, {"format-fields",1,0,'f'}, + {"gvcf",1,0,'g'}, {"output",1,0,'o'}, {"output-type",1,0,'O'}, {"regions",1,0,'r'}, @@ -674,24 +659,19 @@ int main_vcfcall(int argc, char *argv[]) {"multiallelic-caller",0,0,'m'}, {"pval-threshold",1,0,'p'}, {"prior",1,0,'P'}, - {"chromosome-X",0,0,'X'}, - {"chromosome-Y",0,0,'Y'}, {"novel-rate",1,0,'n'}, {"ploidy",1,0,1}, {"ploidy-file",1,0,2}, + {"chromosome-X",1,0,'X'}, + {"chromosome-Y",1,0,'Y'}, {0,0,0,0} }; char *tmp = NULL; - while ((c = getopt_long(argc, argv, "h?o:O:r:R:s:S:t:T:ANMV:vcmp:C:XYn:P:f:ig:", loptions, NULL)) >= 0) + while ((c = getopt_long(argc, argv, "h?o:O:r:R:s:S:t:T:ANMV:vcmp:C:n:P:f:ig:XY", loptions, NULL)) >= 0) { switch (c) { - case 'g': - args.flag |= CF_GVCF; - args.gvcf.min_dp = strtol(optarg,&tmp,10); - if ( *tmp ) error("Could not parse, expected integer argument: -g %s\n", optarg); - break; case 2 : ploidy_fname = optarg; break; case 1 : ploidy = optarg; break; case 'X': ploidy = "X"; fprintf(stderr,"Warning: -X will be deprecated, please use --ploidy instead.\n"); break; @@ -703,6 +683,10 @@ int main_vcfcall(int argc, char *argv[]) case 'c': args.flag |= CF_CCALL; break; // the original EM based calling method case 'i': args.flag |= CF_INS_MISSED; break; case 'v': args.aux.flag |= CALL_VARONLY; break; + case 'g': + args.gvcf = gvcf_init(optarg); + if ( !args.gvcf ) error("Could not parse: --gvcf %s\n", optarg); + break; case 'o': args.output_fname = optarg; break; case 'O': switch (optarg[0]) { @@ -759,12 +743,6 @@ int main_vcfcall(int argc, char *argv[]) } if ( !args.ploidy ) error("Could not initialize ploidy\n"); - if ( args.flag & CF_GVCF ) - { - // Force some flags to avoid unnecessary branching - args.aux.flag &= ~CALL_KEEPALT; - args.aux.flag |= CALL_VARONLY; - } if ( (args.flag & CF_CCALL ? 1 : 0) + (args.flag & CF_MCALL ? 1 : 0) + (args.flag & CF_QCALL ? 1 : 0) > 1 ) error("Only one of -c or -m options can be given\n"); if ( !(args.flag & CF_CCALL) && !(args.flag & CF_MCALL) && !(args.flag & CF_QCALL) ) error("Expected -c or -m option\n"); if ( args.aux.n_perm && args.aux.ngrp1_samples<=0 ) error("Expected -1 with -U\n"); // not sure about this, please fix @@ -774,6 +752,7 @@ int main_vcfcall(int argc, char *argv[]) if ( !(args.flag & CF_MCALL) ) error("The \"-C alleles\" mode requires -m\n"); } if ( args.flag & CF_INS_MISSED && !(args.aux.flag&CALL_CONSTR_ALLELES) ) error("The -i option requires -C alleles\n"); + if ( args.aux.flag&CALL_VARONLY && args.gvcf ) error("The two options cannot be combined: --variants-only and --gvcf\n"); init_data(&args); while ( bcf_sr_next_line(args.aux.srs) ) @@ -783,27 +762,26 @@ int main_vcfcall(int argc, char *argv[]) bcf_unpack(bcf_rec, BCF_UN_STR); // Skip unwanted sites - if ( args.aux.flag & CALL_VARONLY ) + int i, is_indel = bcf_is_snp(bcf_rec) ? 0 : 1; + if ( (args.flag & CF_INDEL_ONLY) && !is_indel ) continue; + if ( (args.flag & CF_NO_INDEL) && is_indel ) continue; + if ( (args.flag & CF_ACGT_ONLY) && (bcf_rec->d.allele[0][0]=='N' || bcf_rec->d.allele[0][0]=='n') ) continue; // REF[0] is 'N' + + // Which allele is symbolic? All SNPs should have it, but not indels + args.aux.unseen = 0; + for (i=1; in_allele; i++) { - int is_ref = 0; - if ( bcf_rec->n_allele==1 ) is_ref = 1; // not a variant - else if ( bcf_rec->n_allele==2 ) - { - // second allele is mpileup's X, not a variant - if ( bcf_rec->d.allele[1][0]=='X' ) is_ref = 1; - else if ( bcf_rec->d.allele[1][0]=='<' && bcf_rec->d.allele[1][1]=='X' && bcf_rec->d.allele[1][2]=='>' ) is_ref = 1; - else if ( bcf_rec->d.allele[1][0]=='<' && bcf_rec->d.allele[1][1]=='*' && bcf_rec->d.allele[1][2]=='>' ) is_ref = 1; - } - if ( is_ref ) + if ( bcf_rec->d.allele[i][0]=='X' ) { args.aux.unseen = i; break; } // old X + if ( bcf_rec->d.allele[i][0]=='<' ) { - // gVCF output - if ( args.flag & CF_GVCF ) gvcf_write(args.out_fh, &args.gvcf, args.aux.hdr, bcf_rec, 1); - continue; + if ( bcf_rec->d.allele[i][1]=='X' && bcf_rec->d.allele[i][2]=='>' ) { args.aux.unseen = i; break; } // old + if ( bcf_rec->d.allele[i][1]=='*' && bcf_rec->d.allele[i][2]=='>' ) { args.aux.unseen = i; break; } // new <*> } } - if ( (args.flag & CF_INDEL_ONLY) && bcf_is_snp(bcf_rec) ) continue; // not an indel - if ( (args.flag & CF_NO_INDEL) && !bcf_is_snp(bcf_rec) ) continue; // not a SNP - if ( (args.flag & CF_ACGT_ONLY) && (bcf_rec->d.allele[0][0]=='N' || bcf_rec->d.allele[0][0]=='n') ) continue; // REF[0] is 'N' + int is_ref = (bcf_rec->n_allele==1 || (bcf_rec->n_allele==2 && args.aux.unseen>0)) ? 1 : 0; + + if ( is_ref && args.aux.flag&CALL_VARONLY ) + continue; bcf_unpack(bcf_rec, BCF_UN_ALL); if ( args.nsex ) set_ploidy(&args, bcf_rec); @@ -823,18 +801,14 @@ int main_vcfcall(int argc, char *argv[]) ret = ccall(&args.aux, bcf_rec); if ( ret==-1 ) error("Something is wrong\n"); - // gVCF output - if ( args.flag & CF_GVCF ) - { - gvcf_write(args.out_fh, &args.gvcf, args.aux.hdr, bcf_rec, ret?0:1); - continue; - } - // Normal output - if ( (args.aux.flag & CALL_VARONLY) && ret==0 ) continue; // not a variant - bcf_write1(args.out_fh, args.aux.hdr, bcf_rec); + if ( (args.aux.flag & CALL_VARONLY) && ret==0 && !args.gvcf ) continue; // not a variant + if ( args.gvcf ) + bcf_rec = gvcf_write(args.gvcf, args.out_fh, args.aux.hdr, bcf_rec, ret==1?1:0); + if ( bcf_rec ) + bcf_write1(args.out_fh, args.aux.hdr, bcf_rec); } - if ( args.flag & CF_GVCF ) gvcf_write(args.out_fh, &args.gvcf, args.aux.hdr, NULL, 0); + if ( args.gvcf ) gvcf_write(args.gvcf, args.out_fh, args.aux.hdr, NULL, 0); if ( args.flag & CF_INS_MISSED ) bcf_sr_regions_flush(args.aux.srs->targets); destroy_data(&args); return 0; From 2346a00c31f82638a6ec1a1c2a0ec6d9dbb13f7d Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Thu, 1 Oct 2015 09:29:57 +0100 Subject: [PATCH 082/211] vcfcall: gvcf calling not working with -c calling mode yet --- ccall.c | 7 +++---- test/mpileup.c.1.out | 43 +++++++++++++++++++++++++++++++++++++++++++ test/mpileup.c.X.out | 43 +++++++++++++++++++++++++++++++++++++++++++ test/test.pl | 4 ++++ vcfcall.c | 1 + 5 files changed, 94 insertions(+), 4 deletions(-) create mode 100644 test/mpileup.c.1.out create mode 100644 test/mpileup.c.X.out diff --git a/ccall.c b/ccall.c index 561b2e464..bb43d6138 100644 --- a/ccall.c +++ b/ccall.c @@ -232,11 +232,10 @@ static int update_bcf1(call_t *call, bcf1_t *rec, const bcf_p1rst_t *pr, double // Remove unused alleles int nals_ori = rec->n_allele, nals = !is_var && !(call->flag & CALL_KEEPALT) ? 1 : pr->rank0 < 2? 2 : pr->rank0+1; - if ( call->flag & CALL_KEEPALT && nals>1 ) + if ( call->flag & CALL_KEEPALT && call->unseen>0 ) { - if ( rec->d.allele[nals-1][0]=='X' ) nals--; // old version of unseen allele "X" - else if ( rec->d.allele[nals-1][0]=='<' && rec->d.allele[nals-1][1]=='X' && rec->d.allele[nals-1][2]=='>' ) nals--; // old version of unseen allele, "" - else if ( rec->d.allele[nals-1][0]=='<' && rec->d.allele[nals-1][1]=='*' && rec->d.allele[nals-1][2]=='>' ) nals--; // new version of unseen allele, "<*>" + assert( call->unseen==nals-1 ); + nals--; } if ( nalsn_allele ) diff --git a/test/mpileup.c.1.out b/test/mpileup.c.1.out new file mode 100644 index 000000000..1c4a0c82e --- /dev/null +++ b/test/mpileup.c.1.out @@ -0,0 +1,43 @@ +##fileformat=VCFv4.2 +##FILTER= +##samtoolsVersion=1.1-19-g6b249e2+htslib-1.1-74-g845c515 +##samtoolsCommand=samtools mpileup -uvDV -b xxx//mpileup.bam.list -f xxx//mpileup.ref.fa.gz +##reference=file://xxx//mpileup.ref.fa.gz +##contig= +##ALT= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +#CHROM POS ID REF ALT QUAL FILTER INFO FORMAT HG00100 HG00101 HG00102 +17 302 . T TA 999 . INDEL;IDV=7;IMF=1;DP=25;VDB=0.27613;SGB=-4.22417;MQSB=0.0443614;MQ0F=0;AF1=0.685575;AC1=4;DP4=2,4,8,11;MQ=51;FQ=61.4911;PV4=1,1,1,1 GT:PL:DP:DV 0/1:167,0,96:11:6 0/1:157,0,9:7:6 1/1:201,21,0:7:7 +17 828 . T C 999 . DP=25;VDB=0.842082;SGB=-4.20907;RPB=0.950652;MQB=1;MQSB=1;BQB=0.929717;MQ0F=0;AF1=0.656389;AC1=4;DP4=2,4,8,11;MQ=60;FQ=89.3748;PV4=1,1,1,0.32233 GT:PL:DP:DV 0/1:211,0,35:12:10 0/1:116,0,91:9:5 1/1:120,12,0:4:4 +17 834 . G A 999 . DP=25;VDB=0.788006;SGB=-4.01214;RPB=0.999233;MQB=1;MQSB=1;BQB=0.821668;MQ0F=0;AF1=0.646503;AC1=4;DP4=2,3,7,10;MQ=60;FQ=68.6952;PV4=1,1,1,0.228905 GT:PL:DP:DV 0/1:185,0,46:11:9 0/1:128,0,59:8:5 1/1:89,9,0:3:3 +17 1665 . T C 3.14059 . DP=20;VDB=0.1;SGB=0.346553;RPB=0.222222;MQB=0.611111;MQSB=0.988166;BQB=0.944444;MQ0F=0;AF1=0.167199;AC1=1;DP4=7,11,1,1;MQ=56;FQ=3.56819;PV4=1,0.239991,0.0798553,0.27333 GT:PL:DP:DV 0/0:0,21,185:7:0 0/0:0,27,222:9:0 0/1:35,0,51:4:2 +17 1869 . A T 134.348 . DP=24;VDB=0.928022;SGB=-11.9537;RPB=0.984127;MQB=0.96464;MQSB=0.931547;BQB=0.359155;MQ0F=0;AF1=0.598209;AC1=4;DP4=6,9,5,4;MQ=59;FQ=138.299;PV4=0.675175,0.0234896,1,0.324361 GT:PL:DP:DV 0/1:115,0,224:18:7 0/1:16,0,104:5:1 1/1:42,3,0:1:1 +17 2041 . G A 999 . DP=31;VDB=0.816435;SGB=-4.18892;RPB=0.88473;MQB=0.972375;MQSB=0.968257;BQB=0.311275;MQ0F=0;AF1=0.665982;AC1=4;DP4=6,5,12,7;MQ=59;FQ=999;PV4=0.71163,1,0.228209,0.143795 GT:PL:DP:DV 0/1:229,0,212:21:11 0/1:32,0,24:2:1 1/1:223,21,0:7:7 +17 2220 . G A 999 . DP=21;VDB=0.532753;SGB=-3.51597;RPB=0.964198;MQB=0.898397;MQSB=0.875769;BQB=0.0354359;MQ0F=0;AF1=0.656341;AC1=4;DP4=6,2,1,11;MQ=59;FQ=139.373;PV4=0.00443756,1,1,1 GT:PL:DP:DV 0/1:139,0,130:12:6 0/1:69,0,46:4:2 1/1:131,12,0:4:4 +17 2564 . A G 227.769 . DP=15;VDB=0.690812;SGB=-3.20711;RPB=0.197899;MQB=1;MQSB=1;BQB=0.965069;MQ0F=0;AF1=0.656337;AC1=4;DP4=1,4,4,5;MQ=60;FQ=97.3723;PV4=0.58042,1,1,1 GT:PL:DP:DV 0/1:88,0,78:6:3 0/1:57,0,56:4:2 1/1:124,12,0:4:4 +17 3104 . C T 24.364 . DP=25;VDB=0.8;SGB=0.346553;RPB=0.717391;MQB=0.956522;MQSB=0.962269;BQB=0.978261;MQ0F=0;AF1=0.170892;AC1=1;DP4=8,15,2,0;MQ=59;FQ=25.179;PV4=0.15,1,1,1 GT:PL:DP:DV 0/0:0,48,255:16:0 0/0:0,12,144:4:0 0/1:59,0,93:5:2 +17 3587 . G A 353.302 . DP=29;VDB=0.902044;SGB=-3.91326;RPB=0.800999;MQB=1;MQSB=1;BQB=0.156944;MQ0F=0;AF1=0.665739;AC1=4;DP4=4,7,10,6;MQ=60;FQ=358.057;PV4=0.25186,0.0986321,1,1 GT:PL:DP:DV 0/1:161,0,184:14:7 0/1:22,0,118:5:1 1/1:212,24,0:8:8 +17 3936 . A G 999 . DP=37;VDB=0.0574114;SGB=-4.60123;RPB=0.741697;MQB=0.812605;MQSB=0.143788;BQB=0.883831;MQ0F=0;AF1=0.666004;AC1=4;DP4=5,6,6,17;MQ=57;FQ=999;PV4=0.434446,0.125787,1,1 GT:PL:DP:DV 0/1:233,0,206:20:11 0/1:77,0,58:6:4 1/1:196,24,0:8:8 diff --git a/test/mpileup.c.X.out b/test/mpileup.c.X.out new file mode 100644 index 000000000..e35b12bce --- /dev/null +++ b/test/mpileup.c.X.out @@ -0,0 +1,43 @@ +##fileformat=VCFv4.2 +##FILTER= +##samtoolsVersion=1.1-19-g6b249e2+htslib-1.1-74-g845c515 +##samtoolsCommand=samtools mpileup -uvDV -b xxx//mpileup.bam.list -f xxx//mpileup.ref.fa.gz +##reference=file://xxx//mpileup.ref.fa.gz +##contig= +##ALT= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +#CHROM POS ID REF ALT QUAL FILTER INFO FORMAT HG00100 HG00101 HG00102 +X 302 . T TA 999 . INDEL;IDV=7;IMF=1;DP=25;VDB=0.27613;SGB=-4.22417;MQSB=0.0443614;MQ0F=0;AF1=0.685575;AC1=4;DP4=2,4,8,11;MQ=51;FQ=61.4911;PV4=1,1,1,1 GT:PL:DP:DV 0/1:167,0,96:11:6 0:157,0,9:7:6 1/1:201,21,0:7:7 +X 828 . T C 999 . DP=25;VDB=0.842082;SGB=-4.20907;RPB=0.950652;MQB=1;MQSB=1;BQB=0.929717;MQ0F=0;AF1=0.656389;AC1=4;DP4=2,4,8,11;MQ=60;FQ=89.3748;PV4=1,1,1,0.32233 GT:PL:DP:DV 0/1:211,0,35:12:10 0:116,91:9:5 1/1:120,12,0:4:4 +X 834 . G A 999 . DP=25;VDB=0.788006;SGB=-4.01214;RPB=0.999233;MQB=1;MQSB=1;BQB=0.821668;MQ0F=0;AF1=0.646503;AC1=4;DP4=2,3,7,10;MQ=60;FQ=68.6952;PV4=1,1,1,0.228905 GT:PL:DP:DV 0/1:185,0,46:11:9 0:128,59:8:5 1/1:89,9,0:3:3 +X 1665 . T C 3.14059 . DP=20;VDB=0.1;SGB=0.346553;RPB=0.222222;MQB=0.611111;MQSB=0.988166;BQB=0.944444;MQ0F=0;AF1=0.167199;AC1=1;DP4=7,11,1,1;MQ=56;FQ=3.56819;PV4=1,0.239991,0.0798553,0.27333 GT:PL:DP:DV 0/0:0,21,185:7:0 0/0:0,27,222:9:0 0/1:35,0,51:4:2 +X 1869 . A T 134.348 . DP=24;VDB=0.928022;SGB=-11.9537;RPB=0.984127;MQB=0.96464;MQSB=0.931547;BQB=0.359155;MQ0F=0;AF1=0.598209;AC1=4;DP4=6,9,5,4;MQ=59;FQ=138.299;PV4=0.675175,0.0234896,1,0.324361 GT:PL:DP:DV 0/1:115,0,224:18:7 0/1:16,0,104:5:1 1/1:42,3,0:1:1 +X 2041 . G A 999 . DP=31;VDB=0.816435;SGB=-4.18892;RPB=0.88473;MQB=0.972375;MQSB=0.968257;BQB=0.311275;MQ0F=0;AF1=0.665982;AC1=4;DP4=6,5,12,7;MQ=59;FQ=999;PV4=0.71163,1,0.228209,0.143795 GT:PL:DP:DV 0/1:229,0,212:21:11 0/1:32,0,24:2:1 1/1:223,21,0:7:7 +X 2220 . G A 999 . DP=21;VDB=0.532753;SGB=-3.51597;RPB=0.964198;MQB=0.898397;MQSB=0.875769;BQB=0.0354359;MQ0F=0;AF1=0.656341;AC1=4;DP4=6,2,1,11;MQ=59;FQ=139.373;PV4=0.00443756,1,1,1 GT:PL:DP:DV 0/1:139,0,130:12:6 0/1:69,0,46:4:2 1/1:131,12,0:4:4 +X 2564 . A G 227.769 . DP=15;VDB=0.690812;SGB=-3.20711;RPB=0.197899;MQB=1;MQSB=1;BQB=0.965069;MQ0F=0;AF1=0.656337;AC1=4;DP4=1,4,4,5;MQ=60;FQ=97.3723;PV4=0.58042,1,1,1 GT:PL:DP:DV 0/1:88,0,78:6:3 0/1:57,0,56:4:2 1/1:124,12,0:4:4 +X 3104 . C T 24.364 . DP=25;VDB=0.8;SGB=0.346553;RPB=0.717391;MQB=0.956522;MQSB=0.962269;BQB=0.978261;MQ0F=0;AF1=0.170892;AC1=1;DP4=8,15,2,0;MQ=59;FQ=25.179;PV4=0.15,1,1,1 GT:PL:DP:DV 0/0:0,48,255:16:0 0:0,144:4:0 0/1:59,0,93:5:2 +X 3587 . G A 353.302 . DP=29;VDB=0.902044;SGB=-3.91326;RPB=0.800999;MQB=1;MQSB=1;BQB=0.156944;MQ0F=0;AF1=0.665739;AC1=4;DP4=4,7,10,6;MQ=60;FQ=358.057;PV4=0.25186,0.0986321,1,1 GT:PL:DP:DV 0/1:161,0,184:14:7 0:22,118:5:1 1/1:212,24,0:8:8 +X 3936 . A G 999 . DP=37;VDB=0.0574114;SGB=-4.60123;RPB=0.741697;MQB=0.812605;MQSB=0.143788;BQB=0.883831;MQ0F=0;AF1=0.666004;AC1=4;DP4=5,6,6,17;MQ=57;FQ=999;PV4=0.434446,0.125787,1,1 GT:PL:DP:DV 0/1:233,0,206:20:11 0:77,58:6:4 1/1:196,24,0:8:8 diff --git a/test/test.pl b/test/test.pl index 23a3fb499..1c5259269 100755 --- a/test/test.pl +++ b/test/test.pl @@ -133,6 +133,10 @@ test_vcf_call($opts,in=>'mpileup.X',out=>'mpileup.X.out',args=>'-mv --ploidy-file {PATH}/mpileup.ploidy -S {PATH}/mpileup.samples'); test_vcf_call($opts,in=>'mpileup.X',out=>'mpileup.X.out',args=>'-mv --ploidy-file {PATH}/mpileup.ploidy -S {PATH}/mpileup.ped'); test_vcf_call_cAls($opts,in=>'mpileup',out=>'mpileup.cAls.out',tab=>'mpileup'); +test_vcf_call($opts,in=>'mpileup',out=>'mpileup.c.1.out',args=>'-cv'); +# test_vcf_call($opts,in=>'mpileup',out=>'mpileup.c.2.out',args=>'-cg0'); +test_vcf_call($opts,in=>'mpileup.X',out=>'mpileup.c.X.out',args=>'-cv --ploidy-file {PATH}/mpileup.ploidy -S {PATH}/mpileup.samples'); +test_vcf_call($opts,in=>'mpileup.X',out=>'mpileup.c.X.out',args=>'-cv --ploidy-file {PATH}/mpileup.ploidy -S {PATH}/mpileup.ped'); test_vcf_filter($opts,in=>'filter.1',out=>'filter.1.out',args=>'-mx -g2 -G2'); test_vcf_filter($opts,in=>'filter.2',out=>'filter.2.out',args=>q[-e'QUAL==59.2 || (INDEL=0 & (FMT/GQ=25 | FMT/DP=10))' -sModified -S.]); test_vcf_filter($opts,in=>'filter.3',out=>'filter.3.out',args=>q[-e'DP=19'],fmt=>'%POS\\t%FILTER\\t%DP[\\t%GT]\\n'); diff --git a/vcfcall.c b/vcfcall.c index 5633256a1..2287936bc 100644 --- a/vcfcall.c +++ b/vcfcall.c @@ -745,6 +745,7 @@ int main_vcfcall(int argc, char *argv[]) if ( !args.ploidy ) error("Could not initialize ploidy\n"); if ( (args.flag & CF_CCALL ? 1 : 0) + (args.flag & CF_MCALL ? 1 : 0) + (args.flag & CF_QCALL ? 1 : 0) > 1 ) error("Only one of -c or -m options can be given\n"); if ( !(args.flag & CF_CCALL) && !(args.flag & CF_MCALL) && !(args.flag & CF_QCALL) ) error("Expected -c or -m option\n"); + if ( (args.flag & CF_CCALL ? 1: 0) && args.gvcf ) error("gvcf -g option not functional with -c calling mode yet\n"); if ( args.aux.n_perm && args.aux.ngrp1_samples<=0 ) error("Expected -1 with -U\n"); // not sure about this, please fix if ( args.aux.flag & CALL_CONSTR_ALLELES ) { From 1d3d6fd6f6bc181ea1d80d5ce88f38609ffd8d8a Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Thu, 1 Oct 2015 11:24:24 +0100 Subject: [PATCH 083/211] vcfconvert: support for END tag when converting from oxford formats to VCF * add support for optional END tag defined in the parsed ID field as CHROM:POS_REF_ALT(_END)? * the oxford phase3 release legend file ID is of the format (RSID|CHROM):POS:REF:ALT(:END)? so would need to be preprocessed to use with the current convert command. The ALT fields in the phase3 release do contain ":" characters which makes parsing this a little trickier. * there is still a possibility that one could come across an underscore _ in the ALT fields. we are not dealing with that yet * add tests for hapsample2vcf * still todo: write out optional END when converting from VCF --- test/convert.gt.noHead.vcf | 1 + test/convert.hls.gt.hap | 1 + test/convert.hls.gt.legend | 1 + test/convert.hs.gt.hap | 35 +++++++++++++++++++++++++++++++++++ test/convert.hs.gt.samples | 12 ++++++++++++ test/test.pl | 8 ++++++++ vcfconvert.c | 15 +++++++++++++-- 7 files changed, 71 insertions(+), 2 deletions(-) create mode 100644 test/convert.hs.gt.hap create mode 100644 test/convert.hs.gt.samples diff --git a/test/convert.gt.noHead.vcf b/test/convert.gt.noHead.vcf index 2d1d7cdcf..53cdd859a 100644 --- a/test/convert.gt.noHead.vcf +++ b/test/convert.gt.noHead.vcf @@ -33,3 +33,4 @@ X 2699775 . C A . . . GT 0 0 0 0 0 0|0 0|0 0|0 0|0 0|0 X 2699898 . C CT . . . GT 0 0 1 0 1 1|0 1|0 0|0 0|0 0|1 X 2699968 . A G . . . GT . 0 0 1 0 0|1 0|0 0|0 0|1 1|0 X 2699970 . T C . . . GT 0 0 0 0 0 0|0 0|0 0|0 0|0 0|0 +X 2699990 . C . . END=2700054 GT 0|0 0|0 1|0 0|0 0|1 1|0 1|0 0|0 0|0 0|1 diff --git a/test/convert.hls.gt.hap b/test/convert.hls.gt.hap index a5db463c0..fe34c3074 100644 --- a/test/convert.hls.gt.hap +++ b/test/convert.hls.gt.hap @@ -32,3 +32,4 @@ 0 - 0 - 1 - 0 - 1 - 1 0 1 0 0 0 0 0 0 1 ? - 0 - 0 - 1 - 0 - 0 1 0 0 0 0 0 1 1 0 0 - 0 - 0 - 0 - 0 - 0 0 0 0 0 0 0 0 0 0 +0 0 0 0 1 0 0 0 0 1 1 0 1 0 0 0 0 0 0 1 diff --git a/test/convert.hls.gt.legend b/test/convert.hls.gt.legend index 990d7725c..1c88f60be 100644 --- a/test/convert.hls.gt.legend +++ b/test/convert.hls.gt.legend @@ -33,3 +33,4 @@ X:2699775_C_A 2699775 C A X:2699898_C_CT 2699898 C CT X:2699968_A_G 2699968 A G X:2699970_T_C 2699970 T C +X:2699990_C__2700054 2699990 C diff --git a/test/convert.hs.gt.hap b/test/convert.hs.gt.hap new file mode 100644 index 000000000..2e41c5c5b --- /dev/null +++ b/test/convert.hs.gt.hap @@ -0,0 +1,35 @@ +X:2698560_G_A X:2698560_G_A 2698560 G A 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +X:2698630_A_G X:2698630_A_G 2698630 A G 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +X:2698758_CAA_C X:2698758_CAA_C 2698758 CAA C 0 0 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +X:2698769_AAG_A X:2698769_AAG_A 2698769 AAG A 1 0 1 1 0 1 1 0 1 0 0 0 0 0 0 0 0 0 0 0 +X:2698770_AG_A X:2698770_AG_A 2698770 AG A 0 0 0 1 0 0 0 0 1 0 0 0 0 0 0 0 0 0 0 0 +X:2698770_AG_AAGG X:2698770_AG_AAGG 2698770 AG AAGG 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +X:2698789_C_G X:2698789_C_G 2698789 C G 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +X:2698822_A_C X:2698822_A_C 2698822 A C 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +X:2698831_G_A X:2698831_G_A 2698831 G A 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +X:2698889_T_C X:2698889_T_C 2698889 T C 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +X:2698923_G_A X:2698923_G_A 2698923 G A 1 0 0 1 0 1 1 0 1 0 0 0 0 0 0 0 0 0 0 0 +X:2698953_A_AGG X:2698953_A_AGG 2698953 A AGG 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +X:2698954_G_A X:2698954_G_A 2698954 G A 1 0 1 1 0 1 1 0 1 0 0 0 0 0 0 1 0 0 0 0 +X:2699002_C_A X:2699002_C_A 2699002 C A 0 0 0 0 ? ? 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +X:2699025_T_C X:2699025_T_C 2699025 T C 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +X:2699091_G_A X:2699091_G_A 2699091 G A 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +X:2699187_T_C X:2699187_T_C 2699187 T C 0 0 0 0 1 0 0 0 0 1 1 0 1 0 0 0 0 0 0* 1* +X:2699188_G_C X:2699188_G_C 2699188 G C 0 0 0 0 1 0 0 0 0 1 1 0 1 0 0 0 0 0 0 1 +X:2699189_T_C X:2699189_T_C 2699189 T C 0 0 0 0 1 0 0 0 0 1 1 0 1 0 0 0 0 0 0 1 +X:2699217_C_T X:2699217_C_T 2699217 C T 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +X:2699246_C_A X:2699246_C_A 2699246 C A 1 0 1 1 0 1 1 1 1 0 0 1 0 0 0 1 0 0 1 0 +X:2699275_T_G X:2699275_T_G 2699275 T G 0 0 0 0 1 0 0 0 0 1 1 1 1 0 0 0 0 0 0 1 +X:2699350_A_T X:2699350_A_T 2699350 A T 0 0 0 0 1 0 0 0 0 1 1 0 1 0 0 0 0 0 0 1 +X:2699360_T_C X:2699360_T_C 2699360 T C 0 0 0 0 1 0 0 0 0 1 1 0 1 0 0 0 0 0 0 1 +X:2699450_A_C X:2699450_A_C 2699450 A C 0 0 0 0 1 0 0 0 0 1 1 0 1 0 0 0 0 0 0 1 +X:2699507_T_C X:2699507_T_C 2699507 T C 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +X:2699555_C_A X:2699555_C_A 2699555 C A 0 - 1 - 1 - 0 - 1 - 1 1 1 0 0 1 0 0 0 1 +X:2699645_G_T X:2699645_G_T 2699645 G T 0 - 1 - 0 - 0 - 0 - 0 0 0 0 0 1 0 0 0 0 +X:2699676_G_A X:2699676_G_A 2699676 G A 0 - 0 - 1 - 0 - 1 - 1 0 1 0 0 0 0 0 0 1 +X:2699728_C_T X:2699728_C_T 2699728 C T 0 - 0 - 0 - 0 - 0 - 0 0 0 0 0 0 0 0 0 0 +X:2699775_C_A X:2699775_C_A 2699775 C A 0 - 0 - 0 - 0 - 0 - 0 0 0 0 0 0 0 0 0 0 +X:2699898_C_CT X:2699898_C_CT 2699898 C CT 0 - 0 - 1 - 0 - 1 - 1 0 1 0 0 0 0 0 0 1 +X:2699968_A_G X:2699968_A_G 2699968 A G ? - 0 - 0 - 1 - 0 - 0 1 0 0 0 0 0 1 1 0 +X:2699970_T_C X:2699970_T_C 2699970 T C 0 - 0 - 0 - 0 - 0 - 0 0 0 0 0 0 0 0 0 0 +X:2699990_C__2700054 X:2699990_C__2700054 2699990 C 0 0 0 0 1 0 0 0 0 1 1 0 1 0 0 0 0 0 0 1 diff --git a/test/convert.hs.gt.samples b/test/convert.hs.gt.samples new file mode 100644 index 000000000..080f72a0a --- /dev/null +++ b/test/convert.hs.gt.samples @@ -0,0 +1,12 @@ +ID_1 ID_2 missing +0 0 0 +NA00001 NA00001 0 +NA00002 NA00002 0 +NA00003 NA00003 0 +NA00004 NA00004 0 +NA00005 NA00005 0 +NA00006 NA00006 0 +NA00007 NA00007 0 +NA00008 NA00008 0 +NA00009 NA00009 0 +NA00010 NA00010 0 diff --git a/test/test.pl b/test/test.pl index 60e98df23..176243e3f 100755 --- a/test/test.pl +++ b/test/test.pl @@ -201,6 +201,7 @@ test_vcf_convert($opts,in=>'convert',out=>'convert.hls.legend',args=>'-h .,-,.'); test_vcf_convert($opts,in=>'convert',out=>'convert.hls.samples',args=>'-h .,.,-'); test_vcf_convert_hls2vcf($opts,h=>'convert.hls.gt.hap',l=>'convert.hls.gt.legend',s=>'convert.hls.gt.samples',out=>'convert.gt.noHead.vcf',args=>'-H'); +test_vcf_convert_hs2vcf($opts,h=>'convert.hs.gt.hap',s=>'convert.hs.gt.samples',out=>'convert.gt.noHead.vcf',args=>'--hapsample2vcf'); test_vcf_convert($opts,in=>'convert',out=>'convert.hs.hap',args=>'--hapsample -,.'); test_vcf_convert($opts,in=>'convert',out=>'convert.hs.sample',args=>'--hapsample .,-'); test_vcf_convert_gvcf($opts,in=>'convert.gvcf',out=>'convert.gvcf.out',fa=>'gvcf.fa',args=>'--gvcf2vcf'); @@ -518,6 +519,13 @@ sub test_vcf_convert_hls2vcf test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools convert $args{args} $hls | grep -v ^##"); test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools convert $args{args} $hls -Ou | $$opts{bin}/bcftools view | grep -v ^##"); } +sub test_vcf_convert_hs2vcf +{ + my ($opts,%args) = @_; + my $hs = join(',', map { "$$opts{path}/$_" }( $args{h}, $args{s} ) ); + test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools convert $args{args} $hs | grep -v ^##"); + test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools convert $args{args} $hs -Ou | $$opts{bin}/bcftools view | grep -v ^##"); +} sub test_vcf_convert_gvcf { my ($opts,%args) = @_; diff --git a/vcfconvert.c b/vcfconvert.c index f602648d5..54d066602 100644 --- a/vcfconvert.c +++ b/vcfconvert.c @@ -158,11 +158,19 @@ static int tsv_setter_chrom_pos_ref_alt(tsv_t *tsv, bcf1_t *rec, void *usr) if ( *se!='_' ) error("Could not parse REF in CHROM:POS_REF_ALT id: %s\n", tsv->ss); kputsn(ss,se-ss,&args->str); ss = ++se; - while ( se < tsv->se && *se!=':' ) se++; - if ( se < tsv->se && *se!=':' ) error("Could not parse ALT in CHROM:POS_REF_ALT id: %s\n", tsv->ss); + while ( se < tsv->se && *se!='_' && isspace(*tsv->se) ) se++; + if ( se < tsv->se && *se!='_' && isspace(*tsv->se) ) error("Could not parse ALT in CHROM:POS_REF_ALT id: %s\n", tsv->ss); kputc(',',&args->str); kputsn(ss,se-ss,&args->str); bcf_update_alleles_str(args->header, rec, args->str.s); + + // END - optional + if (*se && *se=='_') { + long end = strtol(se+1,&ss,10); + if ( ss==se+1 ) error("Could not parse END in CHROM:POS_REF_ALT_END: %s\n", tsv->ss); + bcf_update_info_int32(args->header, rec, "END", &end, 1); + } + return 0; } static int tsv_setter_verify_pos(tsv_t *tsv, bcf1_t *rec, void *usr) @@ -357,6 +365,7 @@ static void gensample_to_vcf(args_t *args) tsv_register(tsv, "GT_GP", tsv_setter_gt_gp, args); args->header = bcf_hdr_init("w"); + bcf_hdr_append(args->header, "##INFO="); bcf_hdr_append(args->header, "##FORMAT="); bcf_hdr_append(args->header, "##FORMAT="); bcf_hdr_printf(args->header, "##contig=", args->str.s,0x7fffffff); // MAX_CSI_COOR @@ -475,6 +484,7 @@ static void haplegendsample_to_vcf(args_t *args) tsv_register(hap_tsv, "HAPS", tsv_setter_haps, args); args->header = bcf_hdr_init("w"); + bcf_hdr_append(args->header, "##INFO="); bcf_hdr_append(args->header, "##FORMAT="); bcf_hdr_printf(args->header, "##contig=", args->str.s,0x7fffffff); // MAX_CSI_COOR bcf_hdr_append_version(args->header, args->argc, args->argv, "bcftools_convert"); @@ -589,6 +599,7 @@ static void hapsample_to_vcf(args_t *args) tsv_register(tsv, "HAPS", tsv_setter_haps, args); args->header = bcf_hdr_init("w"); + bcf_hdr_append(args->header, "##INFO="); bcf_hdr_append(args->header, "##FORMAT="); bcf_hdr_printf(args->header, "##contig=", args->str.s,0x7fffffff); // MAX_CSI_COOR bcf_hdr_append_version(args->header, args->argc, args->argv, "bcftools_convert"); From 1c126ece65bd04730a7114d942cb06abc3156654 Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Thu, 1 Oct 2015 13:48:10 +0100 Subject: [PATCH 084/211] docs: clarify merge behaviour for INFO and QUAL fields Resolves #305 --- doc/bcftools.txt | 6 +++++- 1 file changed, 5 insertions(+), 1 deletion(-) diff --git a/doc/bcftools.txt b/doc/bcftools.txt index 94064e445..f485507f6 100644 --- a/doc/bcftools.txt +++ b/doc/bcftools.txt @@ -1053,7 +1053,11 @@ For "vertical" merge take a look at *<>* instead. *-i, --info-rules* '-'|'TAG:METHOD'[,...]:: Rules for merging INFO fields (scalars or vectors) or '-' to disable the - default rules. 'METHOD' is one of 'sum', 'avg', 'min', 'max', 'join'. + default rules. 'METHOD' is one of 'sum', 'avg', 'min', 'max', 'join'. + Default is 'DP:sum,DP4:sum' if these fields exist in the input files. + Fields with no specified rule will take the value from the first input file. + The merged QUAL value is currently set to the maximum. This behaviour is + not user controllable at the moment. *-l, --file-list* 'FILE':: read file names from 'FILE' From 489657cc185ff530787dc383d26e3928a7b4ecfd Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Fri, 2 Oct 2015 12:07:13 +0100 Subject: [PATCH 085/211] add info plugin to add information metrics from GP tags --- plugins/info.c | 163 +++++++++++++++++++++++++++++++++++++++++++++++++ 1 file changed, 163 insertions(+) create mode 100644 plugins/info.c diff --git a/plugins/info.c b/plugins/info.c new file mode 100644 index 000000000..2252b3a8f --- /dev/null +++ b/plugins/info.c @@ -0,0 +1,163 @@ +/* plugins/info.c -- adds info metrics to a VCF file. + + Copyright (C) 2015 Genome Research Ltd. + + Author: Shane McCarthy + +Permission is hereby granted, free of charge, to any person obtaining a copy +of this software and associated documentation files (the "Software"), to deal +in the Software without restriction, including without limitation the rights +to use, copy, modify, merge, publish, distribute, sublicense, and/or sell +copies of the Software, and to permit persons to whom the Software is +furnished to do so, subject to the following conditions: + +The above copyright notice and this permission notice shall be included in +all copies or substantial portions of the Software. + +THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS OR +IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF MERCHANTABILITY, +FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. IN NO EVENT SHALL +THE AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY CLAIM, DAMAGES OR OTHER +LIABILITY, WHETHER IN AN ACTION OF CONTRACT, TORT OR OTHERWISE, ARISING +FROM, OUT OF OR IN CONNECTION WITH THE SOFTWARE OR THE USE OR OTHER +DEALINGS IN THE SOFTWARE. */ + + +/* + +Marchini & Howie, Nature Genetics, 11 (July 2010) + +Let G_ij in {0,1,2} be the genotype of the ith individual at the +jth SNP in a study cohort of N samples. Let + + p_ijk = P(G_ij = k | H,G) + +be the probability that the genotype at the jth SNP of the ith +individual is k. + +Let the expected allele dosage for the genotype at the jth SNP +of the ith individual be + + e_ij = p_ij1 + 2 * p_ij2 + +and define + + f_ij = p_ij1 + 4 * p_ij2 + +Let theta_j denote the (unknown) population allele frequency of the jth SNP +with: + + theta_j = SUM[i=1..N] e_ij / 2 * N + +The IMPUTE2 information measure is then: + + if theta_j in (0,1): + I(theta_j) = 1 - SUM[i=1..N](f_ij - e_ij^2) / 2 * N * theta_j * (1 - theta_j) + else: + I(theta_j) = 1 + +*/ + +#include +#include +#include +#include +#include + +const char *about(void) +{ + return "Add information metrics to the INFO field based on selected FORMAT tags.\n"; +} + +const char *usage(void) +{ + return + "\n" + "About: Add information metrics to the INFO field based on selected\n" + " FORMAT tags. Only the IMPUTE2 INFO metric from FORMAT/GP\n" + " tags is currently available.\n" + "Usage: bcftools +info [General Options] -- [Plugin Options]\n" + "Options:\n" + " run \"bcftools plugin\" for a list of common options\n" + "\n" + // "Plugin options:\n" + // " -i, --info information metrics to add [INFO]\n" // [BEAGLE_R2,MACH_R2] + // " -t, --tags VCF tags to determine the information from [GP]\n" + // "\n" + "Example:\n" + " bcftools +info in.vcf\n" + "\n"; +} + +bcf_hdr_t *in_hdr = NULL, *out_hdr = NULL; +int gp_type = BCF_HT_REAL; +uint8_t *buf = NULL; +int nbuf = 0; // NB: number of elements, not bytes +int nrec = 0, nskip_gp = 0, nskip_dip = 0; + +int init(int argc, char **argv, bcf_hdr_t *in, bcf_hdr_t *out) +{ + in_hdr = in; + out_hdr = out; + bcf_hdr_append(out_hdr,"##INFO="); + return 0; +} + +bcf1_t *process(bcf1_t *rec) +{ + int nval = 0, i, j, nret = bcf_get_format_values(in_hdr,rec,"GP",(void**)&buf,&nbuf,gp_type); + if ( nret<0 ) + { + if (!nskip_gp) fprintf(stderr, "[info.c] Warning: info tag not added to sites without GP tag\n"); + nskip_gp++; + return rec; // require FORMAT/GP tag, return site unchanged + } + + nret /= rec->n_sample; + if ( nret != 3 ) + { + if (!nskip_dip) fprintf(stderr, "[info.c] Warning: info tag not added to sites that are not biallelic diploid\n"); + nskip_dip++; + return rec; // require biallelic diploid, return site unchanged + } + + float esum = 0, e2sum = 0, fsum = 0; + #define BRANCH(type_t,is_missing,is_vector_end) \ + { \ + type_t *ptr = (type_t*) buf; \ + for (i=0; in_sample; i++) \ + { \ + float vals[3] = {0,0,0}; \ + for (j=0; j0 && theta<1) ? 1 - (fsum - e2sum) / (2 * (float)nval * theta * (1.0 - theta)) : 1; + + bcf_update_info_float(out_hdr, rec, "INFO", &info, 1); + nrec++; + return rec; +} + + +void destroy(void) +{ + fprintf(stderr,"Lines total/info-added/unchanged-no-tag/unchanged-not-biallelic-diploid:\t%d/%d/%d/%d\n", nrec+nskip_gp+nskip_dip, nrec, nskip_gp, nskip_dip); + free(buf); +} From c6458221addebc13e1749d716933ef84416bf11a Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Fri, 2 Oct 2015 12:15:21 +0100 Subject: [PATCH 086/211] mendelian plugin to check for mendelian inconsistencies --- plugins/mendelian.c | 248 ++++++++++++++++++++++++++++++++++++++++++++ 1 file changed, 248 insertions(+) create mode 100644 plugins/mendelian.c diff --git a/plugins/mendelian.c b/plugins/mendelian.c new file mode 100644 index 000000000..186e3e512 --- /dev/null +++ b/plugins/mendelian.c @@ -0,0 +1,248 @@ +/* The MIT License + + Copyright (c) 2015 Genome Research Ltd. + + Author: Petr Danecek + + Permission is hereby granted, free of charge, to any person obtaining a copy + of this software and associated documentation files (the "Software"), to deal + in the Software without restriction, including without limitation the rights + to use, copy, modify, merge, publish, distribute, sublicense, and/or sell + copies of the Software, and to permit persons to whom the Software is + furnished to do so, subject to the following conditions: + + The above copyright notice and this permission notice shall be included in + all copies or substantial portions of the Software. + + THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS OR + IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF MERCHANTABILITY, + FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. IN NO EVENT SHALL THE + AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY CLAIM, DAMAGES OR OTHER + LIABILITY, WHETHER IN AN ACTION OF CONTRACT, TORT OR OTHERWISE, ARISING FROM, + OUT OF OR IN CONNECTION WITH THE SOFTWARE OR THE USE OR OTHER DEALINGS IN + THE SOFTWARE. + + */ + +#include +#include +#include +#include +#include +#include +#include +#include "bcftools.h" + +#define MODE_COUNT 1 +#define MODE_LIST_GOOD 2 +#define MODE_LIST_BAD 4 +#define MODE_DELETE 8 + +typedef struct +{ + int nok, nbad; + int imother,ifather,ichild; +} +trio_t; + +typedef struct _args_t +{ + bcf_hdr_t *hdr; + int32_t *gt_arr; + int mode; + int ngt_arr, nrec; + trio_t *trios; + int ntrios; +} +args_t; + +static args_t args; + +const char *about(void) +{ + return "Count Mendelian consistent / inconsistent genotypes.\n"; +} + +const char *usage(void) +{ + return + "\n" + "About: Count Mendelian consistent / inconsistent genotypes.\n" + "Usage: bcftools +mendelian [General Options] -- [Plugin Options]\n" + "Options:\n" + " run \"bcftools plugin\" for a list of common options\n" + "\n" + "Plugin options:\n" + " -c, --count count the number of consistent sites\n" + " -d, --delete delete inconsistent genotypes (set to \"./.\")\n" + " -l, --list [+x] list consistent (+) or inconsistent (x) sites\n" + " -t, --trio names of mother, father and the child\n" + " -T, --trio-file list of trios, one per line\n" + "\n" + "Example:\n" + " bcftools +mendelian in.vcf -- -t Mother,Father,Child -c\n" + "\n"; +} + +int init(int argc, char **argv, bcf_hdr_t *in, bcf_hdr_t *out) +{ + char *trio_samples = NULL, *trio_file = NULL; + memset(&args,0,sizeof(args_t)); + args.hdr = in; + args.mode = 0; + + static struct option loptions[] = + { + {"trio",1,0,'t'}, + {"trio-file",1,0,'T'}, + {"delete",0,0,'d'}, + {"list",1,0,'l'}, + {"count",0,0,'c'}, + {0,0,0,0} + }; + char c; + while ((c = getopt_long(argc, argv, "?ht:T:l:cd",loptions,NULL)) >= 0) + { + switch (c) + { + case 'd': args.mode |= MODE_DELETE; break; + case 'c': args.mode |= MODE_COUNT; break; + case 'l': + if ( !strcmp("+",optarg) ) args.mode |= MODE_LIST_GOOD; + else if ( !strcmp("x",optarg) ) args.mode |= MODE_LIST_BAD; + else error("The argument not recognised: --list %s\n", optarg); + break; + case 't': trio_samples = optarg; break; + case 'T': trio_file = optarg; break; + case 'h': + case '?': + default: error("%s", usage()); break; + } + } + if ( optind != argc ) error(usage()); + if ( !trio_samples && !trio_file ) error("Expected the -t/T option\n"); + if ( !args.mode ) error("Expected one of the -c, -d or -l options\n"); + if ( args.mode&MODE_DELETE && !(args.mode&(MODE_LIST_GOOD|MODE_LIST_BAD)) ) args.mode |= MODE_LIST_GOOD|MODE_LIST_BAD; + + int i, n = 0; + char **list; + if ( trio_samples ) + { + args.ntrios = 1; + args.trios = (trio_t*) calloc(1,sizeof(trio_t)); + list = hts_readlist(trio_samples, 0, &n); + if ( n!=3 ) error("Expected three sample names with -t\n"); + args.trios[0].imother = bcf_hdr_id2int(args.hdr, BCF_DT_SAMPLE, list[0]); + args.trios[0].ifather = bcf_hdr_id2int(args.hdr, BCF_DT_SAMPLE, list[1]); + args.trios[0].ichild = bcf_hdr_id2int(args.hdr, BCF_DT_SAMPLE, list[2]); + for (i=0; iimother]; + b = args.gt_arr[2*trio->imother+1]; + c = args.gt_arr[2*trio->ifather]; + d = args.gt_arr[2*trio->ifather+1]; + e = args.gt_arr[2*trio->ichild]; + f = args.gt_arr[2*trio->ichild+1]; + if ( bcf_gt_is_missing(a) || bcf_gt_is_missing(b) ) continue; + if ( bcf_gt_is_missing(c) || bcf_gt_is_missing(d) ) continue; + if ( bcf_gt_is_missing(e) || bcf_gt_is_missing(f) ) continue; + + mother = (1<nok++; + } + else + { + trio->nbad++; + has_bad = 1; + if ( args.mode&MODE_DELETE ) + { + args.gt_arr[2*trio->imother] = bcf_gt_missing; + args.gt_arr[2*trio->imother+1] = bcf_gt_missing; + args.gt_arr[2*trio->ifather] = bcf_gt_missing; + args.gt_arr[2*trio->ifather+1] = bcf_gt_missing; + args.gt_arr[2*trio->ichild] = bcf_gt_missing; + args.gt_arr[2*trio->ichild+1] = bcf_gt_missing; + needs_update = 1; + } + } + } + + if ( needs_update && bcf_update_genotypes(args.hdr,rec,args.gt_arr,ngt) ) + error("Could not update GT field at %s:%d\n", bcf_seqname(args.hdr,rec),rec->pos+1); + + if ( args.mode&MODE_LIST_GOOD ) return has_bad ? NULL : rec; + if ( args.mode&MODE_LIST_BAD ) return has_bad ? rec : NULL; + + return NULL; +} + +void destroy(void) +{ + int i; + fprintf(stderr,"# [1]nOK\t[2]nBad\t[3]nSkipped\t[4]Trio\n"); + for (i=0; inok,trio->nbad,args.nrec-(trio->nok+trio->nbad), + bcf_hdr_int2id(args.hdr, BCF_DT_SAMPLE, trio->imother), + bcf_hdr_int2id(args.hdr, BCF_DT_SAMPLE, trio->ifather), + bcf_hdr_int2id(args.hdr, BCF_DT_SAMPLE, trio->ichild) + ); + } + free(args.gt_arr); + free(args.trios); +} + + + From fe79a91112d7ac041e63eda423e56e61c12855c1 Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Fri, 2 Oct 2015 12:26:46 +0100 Subject: [PATCH 087/211] add plugin to color shared chromosomal segments --- Makefile | 4 +- plugins/color-chrs.c | 559 ++++++++++++++++++++++++++++++++++++++++++ plugins/color-chrs.mk | 2 + plugins/color-chrs.pl | 509 ++++++++++++++++++++++++++++++++++++++ 4 files changed, 1073 insertions(+), 1 deletion(-) create mode 100644 plugins/color-chrs.c create mode 100644 plugins/color-chrs.mk create mode 100755 plugins/color-chrs.pl diff --git a/Makefile b/Makefile index 851e4ec89..ccc6563e2 100644 --- a/Makefile +++ b/Makefile @@ -77,6 +77,8 @@ INSTALL_PROGRAM = $(INSTALL) INSTALL_DATA = $(INSTALL) -m 644 INSTALL_DIR = $(MKDIR_P) -m 755 +MISC_PROGRAMS = \ + plot-vcfstats vcfutils.pl plugins/color-chrs.pl \ all:$(PROG) plugins @@ -190,7 +192,7 @@ docs: doc/bcftools.1 doc/bcftools.html # make docs can be run to update if asciidoc is available install: $(PROG) $(INSTALL_DIR) $(DESTDIR)$(bindir) $(DESTDIR)$(man1dir) $(DESTDIR)$(plugindir) - $(INSTALL_PROGRAM) $(PROG) plot-vcfstats vcfutils.pl $(DESTDIR)$(bindir) + $(INSTALL_PROGRAM) $(PROG) $(MISC_PROGRAMS) $(DESTDIR)$(bindir) $(INSTALL_DATA) doc/bcftools.1 $(DESTDIR)$(man1dir) $(INSTALL_PROGRAM) plugins/*.so $(DESTDIR)$(plugindir) diff --git a/plugins/color-chrs.c b/plugins/color-chrs.c new file mode 100644 index 000000000..6a9175e70 --- /dev/null +++ b/plugins/color-chrs.c @@ -0,0 +1,559 @@ +/* The MIT License + + Copyright (c) 2015 Genome Research Ltd. + + Author: Petr Danecek + + Permission is hereby granted, free of charge, to any person obtaining a copy + of this software and associated documentation files (the "Software"), to deal + in the Software without restriction, including without limitation the rights + to use, copy, modify, merge, publish, distribute, sublicense, and/or sell + copies of the Software, and to permit persons to whom the Software is + furnished to do so, subject to the following conditions: + + The above copyright notice and this permission notice shall be included in + all copies or substantial portions of the Software. + + THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS OR + IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF MERCHANTABILITY, + FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. IN NO EVENT SHALL THE + AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY CLAIM, DAMAGES OR OTHER + LIABILITY, WHETHER IN AN ACTION OF CONTRACT, TORT OR OTHERWISE, ARISING FROM, + OUT OF OR IN CONNECTION WITH THE SOFTWARE OR THE USE OR OTHER DEALINGS IN + THE SOFTWARE. + + */ + +/* + Trio haplotypes: mother (A,B), father (C,D), child (E,F) + Modeling the following states: + 01|23|02 + 01|23|03 + 01|23|12 + 01|23|13 + 01|23|20 + 01|23|30 + 01|23|21 + 01|23|31 + with the likelihoods of two haplotypes A,B segments sharing an allele: + P(01|A==B) .. e (P of error) + P(00|A==B) .. 1-e + and + P(ab,cd,ef|E=A,F=C) = P(ea|E=A)*P(fc|F=C) + + + Unrelated samples: (A,B) and (C,D) + Modeling the states: + xxxx .. A!=C,A!=D,B!=C,B!=D + 0x0x .. A=C,B!=D + 0xx0 .. A=D,B!=C + x00x .. B=C,A!=D + x0x0 .. B=D,A!=C + 0101 .. A=C,B=D + 0110 .. A=D,B=C + with the likelihoods + P(01|A!=B) .. f*(1-f) + P(00|A!=B) .. (1-f)*(1-f) + P(11|A!=B) .. f*f + + Assuming 2x30 crossovers, P=2e-8. + */ + +#include +#include +#include +#include +#include +#include +#include +#include "bcftools.h" +#include "HMM.h" + +#define C_TRIO 1 +#define C_UNRL 2 + +// states for unrelated samples +#define UNRL_xxxx 0 +#define UNRL_0x0x 1 +#define UNRL_0xx0 2 +#define UNRL_x00x 3 +#define UNRL_x0x0 4 +#define UNRL_0101 5 +#define UNRL_0110 6 + +// trio states +#define TRIO_AC 0 +#define TRIO_AD 1 +#define TRIO_BC 2 +#define TRIO_BD 3 +#define TRIO_CA 4 +#define TRIO_DA 5 +#define TRIO_CB 6 +#define TRIO_DB 7 + +typedef struct _args_t +{ + bcf_hdr_t *hdr; + hmm_t *hmm; + double *eprob, *tprob, pij, pgt_err; + uint32_t *sites; + int32_t *gt_arr; + int nsites, msites, ngt_arr, prev_rid; + int mode, nstates, nhet_father, nhet_mother; + int imother,ifather,ichild, isample,jsample; + void (*set_observed_prob) (bcf1_t *rec); + char *prefix; + FILE *fp; +} +args_t; + +static args_t args; + +#define SW_MOTHER 1 +#define SW_FATHER 2 +static int hap_switch[8][8]; + +static void set_observed_prob_trio(bcf1_t *rec); +static void set_observed_prob_unrelated(bcf1_t *rec); +static void init_hmm_trio(args_t *args); +static void init_hmm_unrelated(args_t *args); + + +const char *about(void) +{ + return "Color shared chromosomal segments, requires phased GTs.\n"; +} + +const char *usage(void) +{ + return + "\n" + "About: Color shared chromosomal segments, requires phased GTs.\n" + "Usage: bcftools +color-chrs [General Options] -- [Plugin Options]\n" + "Options:\n" + " run \"bcftools plugin\" for a list of common options\n" + "\n" + "Plugin options:\n" + " -p, --prefix output files prefix\n" + " -t, --trio names of mother, father and the child\n" + " -u, --unrelated names of two unrelated samples\n" + "\n" + "Example:\n" + " bcftools +color-chrs in.vcf --\n" + "\n"; +} + +int init(int argc, char **argv, bcf_hdr_t *in, bcf_hdr_t *out) +{ + char *trio_samples = NULL, *unrelated_samples = NULL; + memset(&args,0,sizeof(args_t)); + args.prev_rid = -1; + args.hdr = in; + args.pij = 2e-8; + args.pgt_err = 1e-9; + + static struct option loptions[] = + { + {"prefix",1,0,'p'}, + {"trio",1,0,'t'}, + {"unrelated",1,0,'u'}, + {0,0,0,0} + }; + char c; + while ((c = getopt_long(argc, argv, "?ht:u:p:",loptions,NULL)) >= 0) + { + switch (c) + { + case 'p': args.prefix = optarg; break; + case 't': trio_samples = optarg; break; + case 'u': unrelated_samples = optarg; break; + case 'h': + case '?': + default: error("%s", usage()); break; + } + } + if ( optind != argc ) error(usage()); + if ( trio_samples && unrelated_samples ) error("Expected only one of the -t/-u options\n"); + if ( !trio_samples && !unrelated_samples ) error("Expected one of the -t/-u options\n"); + if ( !args.prefix ) error("Expected the -p option\n"); + + int ret = bcf_hdr_set_samples(args.hdr, trio_samples ? trio_samples : unrelated_samples, 0); + if ( ret<0 ) error("Could not parse samples: %s\n", trio_samples ? trio_samples : unrelated_samples); + else if ( ret>0 ) error("%d-th sample not found: %s\n", ret,trio_samples ? trio_samples : unrelated_samples); + + if ( trio_samples ) + { + int i,n = 0; + char **list = hts_readlist(trio_samples, 0, &n); + if ( n!=3 ) error("Expected three sample names with -t\n"); + args.imother = bcf_hdr_id2int(args.hdr, BCF_DT_SAMPLE, list[0]); + args.ifather = bcf_hdr_id2int(args.hdr, BCF_DT_SAMPLE, list[1]); + args.ichild = bcf_hdr_id2int(args.hdr, BCF_DT_SAMPLE, list[2]); + for (i=0; instates = 8; + args->tprob = (double*) malloc(sizeof(double)*args->nstates*args->nstates); + + for (i=0; instates; i++) + for (j=0; jnstates; j++) hap_switch[i][j] = 0; + + hap_switch[TRIO_AD][TRIO_AC] = SW_FATHER; + hap_switch[TRIO_BC][TRIO_AC] = SW_MOTHER; + hap_switch[TRIO_BD][TRIO_AC] = SW_MOTHER | SW_FATHER; + hap_switch[TRIO_AC][TRIO_AD] = SW_FATHER; + hap_switch[TRIO_BC][TRIO_AD] = SW_MOTHER | SW_FATHER; + hap_switch[TRIO_BD][TRIO_AD] = SW_MOTHER; + hap_switch[TRIO_AC][TRIO_BC] = SW_MOTHER; + hap_switch[TRIO_AD][TRIO_BC] = SW_MOTHER | SW_FATHER; + hap_switch[TRIO_BD][TRIO_BC] = SW_FATHER; + hap_switch[TRIO_AC][TRIO_BD] = SW_MOTHER | SW_FATHER; + hap_switch[TRIO_AD][TRIO_BD] = SW_MOTHER; + hap_switch[TRIO_BC][TRIO_BD] = SW_FATHER; + + hap_switch[TRIO_DA][TRIO_CA] = SW_FATHER; + hap_switch[TRIO_CB][TRIO_CA] = SW_MOTHER; + hap_switch[TRIO_DB][TRIO_CA] = SW_MOTHER | SW_FATHER; + hap_switch[TRIO_CA][TRIO_DA] = SW_FATHER; + hap_switch[TRIO_CB][TRIO_DA] = SW_MOTHER | SW_FATHER; + hap_switch[TRIO_DB][TRIO_DA] = SW_MOTHER; + hap_switch[TRIO_CA][TRIO_CB] = SW_MOTHER; + hap_switch[TRIO_DA][TRIO_CB] = SW_MOTHER | SW_FATHER; + hap_switch[TRIO_DB][TRIO_CB] = SW_FATHER; + hap_switch[TRIO_CA][TRIO_DB] = SW_MOTHER | SW_FATHER; + hap_switch[TRIO_DA][TRIO_DB] = SW_MOTHER; + hap_switch[TRIO_CB][TRIO_DB] = SW_FATHER; + + for (i=0; instates; i++) + { + for (j=0; jnstates; j++) + { + if ( !hap_switch[i][j] ) MAT(args->tprob,args->nstates,i,j) = 0; + else + { + MAT(args->tprob,args->nstates,i,j) = 1; + if ( hap_switch[i][j] & SW_MOTHER ) MAT(args->tprob,args->nstates,i,j) *= args->pij; + if ( hap_switch[i][j] & SW_FATHER ) MAT(args->tprob,args->nstates,i,j) *= args->pij; + } + } + } + for (i=0; instates; i++) + { + double sum = 0; + for (j=0; jnstates; j++) + { + if ( i!=j ) sum += MAT(args->tprob,args->nstates,i,j); + } + MAT(args->tprob,args->nstates,i,i) = 1 - sum; + } + + #if 0 + for (i=0; instates; i++) + { + for (j=0; jnstates; j++) + fprintf(stderr,"\t%d",hap_switch[j][i]); + fprintf(stderr,"\n"); + } + for (i=0; instates; i++) + { + for (j=0; jnstates; j++) + fprintf(stderr,"\t%e",MAT(args->tprob,args->nstates,j,i)); + fprintf(stderr,"\n"); + } + #endif + + args->hmm = hmm_init(args->nstates, args->tprob, 10000); +} +static void init_hmm_unrelated(args_t *args) +{ + int i,j; + args->nstates = 7; + args->tprob = (double*) malloc(sizeof(double)*args->nstates*args->nstates); + + for (i=0; instates; i++) + { + for (j=0; jnstates; j++) + MAT(args->tprob,args->nstates,i,j) = args->pij; + } + MAT(args->tprob,args->nstates,UNRL_0101,UNRL_xxxx) = args->pij*args->pij; + MAT(args->tprob,args->nstates,UNRL_0110,UNRL_xxxx) = args->pij*args->pij; + MAT(args->tprob,args->nstates,UNRL_x0x0,UNRL_0x0x) = args->pij*args->pij; + MAT(args->tprob,args->nstates,UNRL_0110,UNRL_0x0x) = args->pij*args->pij; + MAT(args->tprob,args->nstates,UNRL_x00x,UNRL_0xx0) = args->pij*args->pij; + MAT(args->tprob,args->nstates,UNRL_0101,UNRL_0xx0) = args->pij*args->pij; + MAT(args->tprob,args->nstates,UNRL_0101,UNRL_x00x) = args->pij*args->pij; + MAT(args->tprob,args->nstates,UNRL_0110,UNRL_x0x0) = args->pij*args->pij; + MAT(args->tprob,args->nstates,UNRL_0110,UNRL_0101) = args->pij*args->pij; + + for (i=0; instates; i++) + { + for (j=i+1; jnstates; j++) + MAT(args->tprob,args->nstates,i,j) = MAT(args->tprob,args->nstates,j,i); + } + for (i=0; instates; i++) + { + double sum = 0; + for (j=0; jnstates; j++) + if ( i!=j ) sum += MAT(args->tprob,args->nstates,i,j); + MAT(args->tprob,args->nstates,i,i) = 1 - sum; + } + + #if 0 + for (i=0; instates; i++) + { + for (j=0; jnstates; j++) + fprintf(stderr,"\t%e",MAT(args->tprob,args->nstates,j,i)); + fprintf(stderr,"\n"); + } + #endif + + args->hmm = hmm_init(args->nstates, args->tprob, 10000); +} +static inline double prob_shared(float af, int a, int b) +{ + return a==b ? 1-args.pgt_err : args.pgt_err; +} +static inline double prob_not_shared(float af, int a, int b) +{ + if ( a!=b ) return af*(1-af); + else if ( a==0 ) return (1-af)*(1-af); + else return af*af; +} +static void set_observed_prob_unrelated(bcf1_t *rec) +{ + float af = 0.5; // alternate allele frequency + + int ngt = bcf_get_genotypes(args.hdr, rec, &args.gt_arr, &args.ngt_arr); + if ( ngt<0 ) return; + if ( ngt!=4 ) return; // chrX + + int32_t a,b,c,d; + a = args.gt_arr[2*args.isample]; + b = args.gt_arr[2*args.isample+1]; + c = args.gt_arr[2*args.jsample]; + d = args.gt_arr[2*args.jsample+1]; + if ( bcf_gt_is_missing(a) || bcf_gt_is_missing(b) ) return; + if ( bcf_gt_is_missing(c) || bcf_gt_is_missing(d) ) return; + if ( !bcf_gt_is_phased(a) && !bcf_gt_is_phased(b) ) return; // only the second allele should be set when phased + if ( !bcf_gt_is_phased(c) && !bcf_gt_is_phased(d) ) return; + a = bcf_gt_allele(a); + b = bcf_gt_allele(b); + c = bcf_gt_allele(c); + d = bcf_gt_allele(d); + + int m = args.msites; + args.nsites++; + hts_expand(uint32_t,args.nsites,args.msites,args.sites); + if ( m!=args.msites ) args.eprob = (double*) realloc(args.eprob, sizeof(double)*args.msites*args.nstates); + + args.sites[args.nsites-1] = rec->pos; + double *prob = args.eprob + args.nstates*(args.nsites-1); + prob[UNRL_xxxx] = prob_not_shared(af,a,c) * prob_not_shared(af,a,d) * prob_not_shared(af,b,c) * prob_not_shared(af,b,d); + prob[UNRL_0x0x] = prob_shared(af,a,c) * prob_not_shared(af,b,d); + prob[UNRL_0xx0] = prob_shared(af,a,d) * prob_not_shared(af,b,c); + prob[UNRL_x00x] = prob_shared(af,b,c) * prob_not_shared(af,a,d); + prob[UNRL_x0x0] = prob_shared(af,b,d) * prob_not_shared(af,a,c); + prob[UNRL_0101] = prob_shared(af,a,c) * prob_shared(af,b,d); + prob[UNRL_0110] = prob_shared(af,a,d) * prob_shared(af,b,c); + +#if 0 + static int x = 0; + if ( !x++) + { + printf("p(0==0) .. %f\n", prob_shared(af,0,0)); + printf("p(0!=0) .. %f\n", prob_not_shared(af,0,0)); + printf("p(0==1) .. %f\n", prob_shared(af,0,1)); + printf("p(0!=1) .. %f\n", prob_not_shared(af,0,1)); + } + printf("%d|%d %d|%d x:%f 11:%f 12:%f 21:%f 22:%f 11,22:%f 12,21:%f %d\n", a,b,c,d, + prob[UNRL_xxxx], prob[UNRL_0x0x], prob[UNRL_0xx0], prob[UNRL_x00x], prob[UNRL_x0x0], prob[UNRL_0101], prob[UNRL_0110], rec->pos+1); +#endif +} +static void set_observed_prob_trio(bcf1_t *rec) +{ + int ngt = bcf_get_genotypes(args.hdr, rec, &args.gt_arr, &args.ngt_arr); + if ( ngt<0 ) return; + if ( ngt!=6 ) return; // chrX + + int32_t a,b,c,d,e,f; + a = args.gt_arr[2*args.imother]; + b = args.gt_arr[2*args.imother+1]; + c = args.gt_arr[2*args.ifather]; + d = args.gt_arr[2*args.ifather+1]; + e = args.gt_arr[2*args.ichild]; + f = args.gt_arr[2*args.ichild+1]; + if ( bcf_gt_is_missing(a) || bcf_gt_is_missing(b) ) return; + if ( bcf_gt_is_missing(c) || bcf_gt_is_missing(d) ) return; + if ( bcf_gt_is_missing(e) || bcf_gt_is_missing(f) ) return; + if ( !bcf_gt_is_phased(a) && !bcf_gt_is_phased(b) ) return; // only the second allele should be set when phased + if ( !bcf_gt_is_phased(c) && !bcf_gt_is_phased(d) ) return; + if ( !bcf_gt_is_phased(e) && !bcf_gt_is_phased(f) ) return; + a = bcf_gt_allele(a); + b = bcf_gt_allele(b); + c = bcf_gt_allele(c); + d = bcf_gt_allele(d); + e = bcf_gt_allele(e); + f = bcf_gt_allele(f); + + int mother = (1<pos; + double *prob = args.eprob + args.nstates*(args.nsites-1); + prob[TRIO_AC] = prob_shared(0,e,a) * prob_shared(0,f,c); + prob[TRIO_AD] = prob_shared(0,e,a) * prob_shared(0,f,d); + prob[TRIO_BC] = prob_shared(0,e,b) * prob_shared(0,f,c); + prob[TRIO_BD] = prob_shared(0,e,b) * prob_shared(0,f,d); + prob[TRIO_CA] = prob_shared(0,e,c) * prob_shared(0,f,a); + prob[TRIO_DA] = prob_shared(0,e,d) * prob_shared(0,f,a); + prob[TRIO_CB] = prob_shared(0,e,c) * prob_shared(0,f,b); + prob[TRIO_DB] = prob_shared(0,e,d) * prob_shared(0,f,b); +} + +void flush_viterbi(args_t *args) +{ + const char *s1, *s2, *s3 = NULL; + if ( args->mode==C_UNRL ) + { + s1 = bcf_hdr_int2id(args->hdr,BCF_DT_SAMPLE,args->isample); + s2 = bcf_hdr_int2id(args->hdr,BCF_DT_SAMPLE,args->jsample); + } + else if ( args->mode==C_TRIO ) + { + s1 = bcf_hdr_int2id(args->hdr,BCF_DT_SAMPLE,args->imother); + s3 = bcf_hdr_int2id(args->hdr,BCF_DT_SAMPLE,args->ifather); + s2 = bcf_hdr_int2id(args->hdr,BCF_DT_SAMPLE,args->ichild); + } + + if ( !args->fp ) + { + kstring_t str = {0,0,0}; + kputs(args->prefix, &str); + kputs(".dat", &str); + args->fp = fopen(str.s,"w"); + if ( !args->fp ) error("%s: %s\n", str.s,strerror(errno)); + free(str.s); + fprintf(args->fp,"# SG, shared segment\t[2]Chromosome\t[3]Start\t[4]End\t[5]%s:1\t[6]%s:2\n",s2,s2); + fprintf(args->fp,"# SW, number of switches\t[3]Sample\t[4]Chromosome\t[5]nHets\t[5]nSwitches\t[6]switch rate\n"); + } + + hmm_run_viterbi(args->hmm,args->nsites,args->eprob,args->sites); + uint8_t *vpath = hmm_get_viterbi_path(args->hmm); + int i, iprev = -1, prev_state = -1, nstates = hmm_get_nstates(args->hmm); + int nswitch_mother = 0, nswitch_father = 0; + for (i=0; insites; i++) + { + int state = vpath[i*nstates]; + if ( state!=prev_state || i+1==args->nsites ) + { + uint32_t start = iprev>=0 ? args->sites[iprev]+1 : 1, end = i>0 ? args->sites[i-1] : 1; + const char *chr = bcf_hdr_id2name(args->hdr,args->prev_rid); + if ( args->mode==C_UNRL ) + { + switch (prev_state) + { + case UNRL_0x0x: + fprintf(args->fp,"SG\t%s\t%d\t%d\t%s:1\t-\n", chr,start,end,s1); break; + case UNRL_0xx0: + fprintf(args->fp,"SG\t%s\t%d\t%d\t-\t%s:1\n", chr,start,end,s1); break; + case UNRL_x00x: + fprintf(args->fp,"SG\t%s\t%d\t%d\t%s:2\t-\n", chr,start,end,s1); break; + case UNRL_x0x0: + fprintf(args->fp,"SG\t%s\t%d\t%d\t-\t%s:2\n", chr,start,end,s1); break; + case UNRL_0101: + fprintf(args->fp,"SG\t%s\t%d\t%d\t%s:1\t%s:2\n", chr,start,end,s1,s1); break; + case UNRL_0110: + fprintf(args->fp,"SG\t%s\t%d\t%d\t%s:2\t%s:1\n", chr,start,end,s1,s1); break; + } + } + else if ( args->mode==C_TRIO ) + { + switch (prev_state) + { + case TRIO_AC: + fprintf(args->fp,"SG\t%s\t%d\t%d\t%s:1\t%s:1\n", chr,start,end,s1,s3); break; + case TRIO_AD: + fprintf(args->fp,"SG\t%s\t%d\t%d\t%s:1\t%s:2\n", chr,start,end,s1,s3); break; + case TRIO_BC: + fprintf(args->fp,"SG\t%s\t%d\t%d\t%s:2\t%s:1\n", chr,start,end,s1,s3); break; + case TRIO_BD: + fprintf(args->fp,"SG\t%s\t%d\t%d\t%s:2\t%s:2\n", chr,start,end,s1,s3); break; + case TRIO_CA: + fprintf(args->fp,"SG\t%s\t%d\t%d\t%s:1\t%s:1\n", chr,start,end,s3,s1); break; + case TRIO_DA: + fprintf(args->fp,"SG\t%s\t%d\t%d\t%s:2\t%s:1\n", chr,start,end,s3,s1); break; + case TRIO_CB: + fprintf(args->fp,"SG\t%s\t%d\t%d\t%s:1\t%s:2\n", chr,start,end,s3,s1); break; + case TRIO_DB: + fprintf(args->fp,"SG\t%s\t%d\t%d\t%s:2\t%s:2\n", chr,start,end,s3,s1); break; + } + if ( hap_switch[state][prev_state] & SW_MOTHER ) nswitch_mother++; + if ( hap_switch[state][prev_state] & SW_FATHER ) nswitch_father++; + } + iprev = i-1; + } + prev_state = state; + } + float mrate = args->nhet_mother>1 ? (float)nswitch_mother/(args->nhet_mother-1) : 0; + float frate = args->nhet_father>1 ? (float)nswitch_father/(args->nhet_father-1) : 0; + fprintf(args->fp,"SW\t%s\t%s\t%d\t%d\t%f\n", s1,bcf_hdr_id2name(args->hdr,args->prev_rid),args->nhet_mother,nswitch_mother,mrate); + fprintf(args->fp,"SW\t%s\t%s\t%d\t%d\t%f\n", s3,bcf_hdr_id2name(args->hdr,args->prev_rid),args->nhet_father,nswitch_father,frate); + args->nsites = 0; + args->nhet_father = args->nhet_mother = 0; +} + +bcf1_t *process(bcf1_t *rec) +{ + if ( args.prev_rid==-1 ) args.prev_rid = rec->rid; + if ( args.prev_rid!=rec->rid ) flush_viterbi(&args); + args.prev_rid = rec->rid; + args.set_observed_prob(rec); + return NULL; +} + +void destroy(void) +{ + flush_viterbi(&args); + fclose(args.fp); + + free(args.gt_arr); + free(args.tprob); + free(args.sites); + free(args.eprob); + hmm_destroy(args.hmm); +} + + + diff --git a/plugins/color-chrs.mk b/plugins/color-chrs.mk new file mode 100644 index 000000000..ca7a8a408 --- /dev/null +++ b/plugins/color-chrs.mk @@ -0,0 +1,2 @@ +plugins/color-chrs.so: plugins/color-chrs.c version.h version.c HMM.h HMM.c $(HTSDIR)/libhts.so + $(CC) -fPIC -shared $(CFLAGS) $(EXTRA_CPPFLAGS) $(CPPFLAGS) -L$(HTSDIR) $(LDFLAGS) -o $@ HMM.c version.c $< -lhts $(LIBS) diff --git a/plugins/color-chrs.pl b/plugins/color-chrs.pl new file mode 100755 index 000000000..39c4b74c4 --- /dev/null +++ b/plugins/color-chrs.pl @@ -0,0 +1,509 @@ +#!/usr/bin/env perl +# +# Author: petr.danecek@sanger +# + +use strict; +use warnings; +use Carp; + +my $opts = parse_params(); +chr_dims($opts); +for my $file (@{$$opts{files}}) +{ + read_dat($opts,$file); +} +merge_regs($opts); +plot($opts); + +exit; + +#-------------------------------- + +sub error +{ + my (@msg) = @_; + if ( scalar @msg ) { confess @msg; } + print + "About: Plot output of \"bcftools +color-chrs\"\n", + "Usage: color-chrs.pl [OPTIONS] output.dat\n", + "Options:\n", + " -c, --colors File with list of \"chr hap color\".\n", + " -p, --prefix Prefix of output files.\n", + " -h, -?, --help This help message.\n", + "\n"; + exit -1; +} + +sub parse_params +{ + my $opts = + { + #colors => ['red','green','blue','yellow'], + colors => ['#ff0000','#008000','#0000ff','#ffff00'], + height => 350, + pad => 10, + dimL => 300, # arm length + dimD => 10, # arm width + dimE => 7, # arm pad + dimB => 5, # arm end curve + }; + $$opts{chr_width} = 2*$$opts{pad} + 2*$$opts{dimD} + $$opts{dimE}; + $$opts{width} = $$opts{chr_width}*23; + while (defined(my $arg=shift(@ARGV))) + { + if ( -e $arg ) { push @{$$opts{files}},$arg; next } + if ( $arg eq '-p' || $arg eq '--prefix' ) { $$opts{prefix}=shift(@ARGV); next } + if ( $arg eq '-c' || $arg eq '--colors' ) { read_colors($opts,shift(@ARGV)); next; } + if ( $arg eq '-?' || $arg eq '-h' || $arg eq '--help' ) { error(); } + error("Unknown parameter \"$arg\". Run -h for help.\n"); + } + if ( !exists($$opts{files}) ) { error("No files given?\n") } + if ( !exists($$opts{prefix}) ) { error("Expected -p option\n") } + return $opts; +} + +sub read_colors +{ + my ($opts,$fname) = @_; + open(my $fh,'<',$fname) or error("$fname: $!"); + while (my $line=<$fh>) + { + if ( $line=~/^\s*$/ ) { next; } + $line =~ s/^\s*//; + $line =~ s/\s*$//; + my ($chr,$hap,$col) = split(/\s+/,$line); + $$opts{hap_cols}{$chr}{$hap} = $col; + } + close($fh); +} + +sub plot +{ + my ($opts) = @_; + + my $width = $$opts{width}; + my $height = $$opts{height}; + my $pad = $$opts{pad}; + + my $svg = $$opts{svg} = []; + push @$svg, q[]; + push @$svg, q[]; + push @$svg, qq[]; + + my $xpos = $pad; + for my $chr (qw(1 2 3 4 5 6 7 8 9 10 11 12 13 14 15 16 17 18 19 20 21 22 X)) + { + draw_chr($opts,$chr,$xpos,$pad); + $xpos += $$opts{chr_width}; + } + $xpos = $pad + 10*$$opts{chr_width}; + for my $sample (keys %{$$opts{samples}}) + { + $$opts{chrs}{$sample} = { len=>59e6, acen=>[24e6,26e6,28e6] }; + my $chr = $$opts{chrs}{$sample}; + my $len1 = $$opts{dimL}*$$chr{acen}[0]/$$opts{max_chr_len}; + my $len2 = $$opts{dimL}*$$chr{acen}[2]/$$opts{max_chr_len}; + my $len3 = $$opts{dimL}*$$chr{len}/$$opts{max_chr_len}; + if ( exists($$opts{samples}{$sample}{1}) ) + { + my $col = $$opts{samples}{$sample}{1}; + $$chr{px1} = [[0,$len1,{$col=>1.0}],[$len2,$len3,{$col=>1.0}]]; + } + if ( exists($$opts{samples}{$sample}{2}) ) + { + my $col = $$opts{samples}{$sample}{2}; + $$chr{px2} = [[0,$len1,{$col=>1.0}],[$len2,$len3,{$col=>1.0}]]; + } + my $ypos = $$opts{dimL} - $len3 + $pad; + draw_chr($opts,$sample,$xpos,$ypos); + $xpos += 2*$$opts{chr_width}; + } + + push @$svg, q[]; + open(my $fh,'>',"$$opts{prefix}.svg"); + print $fh join("\n",@$svg); + close($fh); +} + +sub draw_chr +{ + my ($opts,$chr_name,$xpos,$ypos) = @_; + + my $svg = $$opts{svg}; + my $chr = $$opts{chrs}{$chr_name}; + my $dimL = $$opts{dimL}; + my $dimC = $dimL*($$chr{acen}[2]-$$chr{acen}[0])/$$opts{max_chr_len}; + my $dimL1 = $dimL*$$chr{acen}[0]/$$opts{max_chr_len}; + my $dimL2 = $dimL*($$chr{len} - $$chr{acen}[2])/$$opts{max_chr_len}; + my $dimD = $$opts{dimD}; # arm width + my $dimB = $$opts{dimB}; + my $dimE = $$opts{dimE}; # the gap width between arms + my $dimE05 = $dimE*0.5; + my $dimD05 = $dimD*0.5; + my $dimB05 = $dimB*0.5; + my $dimC05 = 0.5*$dimC; + + my $xtext = $xpos + $dimD + $dimE*0.5; + my $ytext = $ypos; + push @$svg, qq[$chr_name\n]; + + $ypos += $$opts{pad}; + + push @$svg, qq[ + ]; + + if ( $$chr{px1} ) { draw_regs($opts,$chr_name,$$chr{px1},$xpos,$ypos); } + if ( $$chr{px2} ) { draw_regs($opts,$chr_name,$$chr{px2},$xpos+$dimD+$dimE,$ypos); } +} + +sub parse_hex_color +{ + my ($color) = @_; + if ( !($color=~/^#/) ) { error("Could not parse: $color"); } + $color =~ s/^#//; + my @vals = split(//, $color); + my ($r,$g,$b); + if ( @vals==6 ) + { + $r = hex($vals[0].$vals[1]); + $g = hex($vals[2].$vals[3]); + $b = hex($vals[4].$vals[5]); + } + elsif ( @vals==3 ) + { + $r = hex($vals[0].$vals[0]); + $g = hex($vals[1].$vals[1]); + $b = hex($vals[2].$vals[2]); + } + else { error("Could not parse: $color\n"); } + return ($r,$g,$b); +} + +sub scale_color +{ + my ($color,$scale) = @_; + my ($r1,$g1,$b1) = parse_hex_color($color); + my ($r0,$g0,$b0) = parse_hex_color('#aaa'); + my $r = $scale*($r1-$r0) + $r0; + my $g = $scale*($g1-$g0) + $g0; + my $b = $scale*($b1-$b0) + $b0; + return sprintf("#%0.2x%0.2x%0.2x",$r,$g,$b); +} + +sub draw_regs +{ + my ($opts,$chr_name,$regs,$xpos,$ypos) = @_; + + my $svg = $$opts{svg}; + my $chr = $$opts{chrs}{$chr_name}; + my $dimL = $$opts{dimL}; + my $dimC = $dimL*($$chr{acen}[2]-$$chr{acen}[0])/$$opts{max_chr_len}; + my $dimL1 = $dimL*$$chr{acen}[0]/$$opts{max_chr_len}; + my $dimL2 = $$opts{dimL} - $dimL*$$chr{acen}[2]/$$opts{max_chr_len}; + my $dimD = $$opts{dimD}; # arm width + my $dimB = $$opts{dimB}; + my $dimE = $$opts{dimE}; + my $dimE05 = $dimE*0.5; + my $dimD05 = $dimD*0.5; + my $dimB05 = $dimB*0.5; + my $dimC05 = 0.5*$dimC; + + for my $reg (@$regs) + { + my $sum = 0; + my $cmax = undef; + for my $c (keys %{$$reg[2]}) + { + $sum += $$reg[2]{$c}; + if ( !defined $cmax or $$reg[2]{$cmax} < $$reg[2]{$c} ) { $cmax = $c; } + } + my $color = scale_color($cmax,$$reg[2]{$cmax}/$sum); + my $y = $ypos + $$reg[0]; + my $dy = $$reg[1] - $$reg[0] + 1; + push @$svg, qq[ + ]; + } + +} + +sub hap2color +{ + my ($opts,$chr,$hap) = @_; + if ( exists($$opts{hap_cols}{$chr}{$hap}) ) + { + if ( !exists($$opts{hap_cols}{'*'}{$hap}) ) + { + $$opts{hap_cols}{'*'}{$hap} = $$opts{hap_cols}{$chr}{$hap}; + } + return $$opts{hap_cols}{$chr}{$hap}; + } + elsif ( exists($$opts{hap_cols}{'*'}{$hap}) ) + { + return $$opts{hap_cols}{'*'}{$hap}; + } + if ( !exists($$opts{haps}) ) { $$opts{haps} = {}; } + if ( !exists($$opts{haps}{$hap}) ) + { + my $nhaps = scalar keys %{$$opts{haps}}; + my $color = $$opts{colors}[$nhaps]; + $$opts{haps}{$hap} = $color; + } + return $$opts{haps}{$hap}; +} + +sub read_dat +{ + my ($opts,$file) = @_; + open(my $fh,'<',$file) or error("$file: $!"); + while (my $line=<$fh>) + { + if ( !($line=~/^SG/) ) { next; } + my @items = split(/\s+/,$line); + my $chr = $items[1]; + my $start = $items[2]; + my $end = $items[3]; + my $hap1 = $items[4]; + my $hap2 = $items[5]; + my $col1 = hap2color($opts,$chr,$hap1); + my $col2 = hap2color($opts,$chr,$hap2); + push @{$$opts{chrs}{$chr}{regs1}},[$start,$end,$col1]; + push @{$$opts{chrs}{$chr}{regs2}},[$start,$end,$col2]; + my ($smpl,$hap); + ($smpl,$hap) = split(/:/,$hap1); $$opts{samples}{$smpl}{$hap} = $col1; + ($smpl,$hap) = split(/:/,$hap2); $$opts{samples}{$smpl}{$hap} = $col2; + } + close($fh); +} + +sub merge_regs +{ + my ($opts) = @_; + for my $chr (keys %{$$opts{chrs}}) + { + my $dat = $$opts{chrs}{$chr}; + if ( exists($$dat{regs1}) ) { $$dat{px1} = merge($opts,$dat,$$dat{regs1}); } + if ( exists($$dat{regs2}) ) { $$dat{px2} = merge($opts,$dat,$$dat{regs2}); } + } +} + +sub merge +{ + my ($opts,$chr_dat,$regs) = @_; + + # merge adjacent regions of the same color + for (my $i=1; $i<@$regs; $i++) + { + if ( $$regs[$i-1][2] eq $$regs[$i][2] ) + { + $$regs[$i-1][1] = $$regs[$i][1]; + splice(@$regs,$i,1); + $i--; + next; + } + } + for (my $i=0; $i<@$regs; $i++) + { + if ( $$regs[$i][1] < $$chr_dat{acen}[0] ) { next; } + if ( $$regs[$i][0] > $$chr_dat{acen}[2] ) { next; } + if ( $$regs[$i][0] >= $$chr_dat{acen}[0] && $$regs[$i][1] <= $$chr_dat{acen}[2] ) + { + splice(@$regs,$i,1); + $i--; + next; + } + if ( $$regs[$i][1] < $$chr_dat{acen}[2] ) + { + $$regs[$i][1] = $$chr_dat{acen}[0]; + next; + } + if ( $$regs[$i][0] > $$chr_dat{acen}[0] ) + { + $$regs[$i][0] = $$chr_dat{acen}[2]; + next; + } + my $start = $$chr_dat{acen}[2]; + my $end = $$regs[$i][1]; + my $color = $$regs[$i][2]; + $$regs[$i][1] = $$chr_dat{acen}[0]; + splice(@$regs,$i+1,0,[$start,$end,$color]); + } + + # pixelize + my @px = ([0,0,{}]); # start,end,hash of contributions from colors + my $dy = $$opts{max_chr_len}/$$opts{dimL}; # 1px covers $dy base pairs + for my $reg (@$regs) + { + my $px_start = int($$reg[0] / $dy); + my $px_end = int($$reg[1] / $dy); + my $color = $$reg[2]; + my $contrib = ($$reg[1] - $$reg[0])/$dy; + + if ( $px_start==$px_end ) + { + if ( $px_end<=$px[-1][1] ) { $px[-1][2]{$color} += $contrib; } + else { push @px, [$px_start,$px_end,{$color=>$contrib}]; } + next; + } + + my $rem_start = 1 - ($$reg[0]/$dy - $px_start); # fractional remainders + my $rem_end = $$reg[1]/$dy - $px_end; + + if ( $px_start==$px[-1][1] ) + { + $px[-1][2]{$color} += $rem_start; + } + + if ( $px_end==$px[-1][1] ) + { + $px[-1][2]{$color} += $rem_end; + if ( $px_start+1<$px_end ) { error("really?!\n"); } + } + elsif ( $px_end>$px[-1][1] ) + { + if ( $rem_start ) { $px_start++; $contrib -= $rem_start; } + push @px, [ $px_start, $px_end, { $color=>$contrib } ]; + } + else { error("really?!\n"); } + } + return \@px; +} + +sub chr_dims +{ + my ($opts) = @_; + + # http://hgdownload.cse.ucsc.edu/goldenPath/hg19/database/cytoBand.txt.gz + my $ktype = q[ + chr1 121500000 125000000 p11.1 acen + chr1 125000000 128900000 q11 acen + chr1 243700000 249250621 q44 gneg + chr10 38000000 40200000 p11.1 acen + chr10 40200000 42300000 q11.1 acen + chr10 130600000 135534747 q26.3 gneg + chr11 51600000 53700000 p11.11 acen + chr11 53700000 55700000 q11 acen + chr11 130800000 135006516 q25 gneg + chr12 33300000 35800000 p11.1 acen + chr12 35800000 38200000 q11 acen + chr12 129300000 133851895 q24.33 gneg + chr13 16300000 17900000 p11.1 acen + chr13 17900000 19500000 q11 acen + chr13 110300000 115169878 q34 gneg + chr14 16100000 17600000 p11.1 acen + chr14 17600000 19100000 q11.1 acen + chr14 104000000 107349540 q32.33 gneg + chr15 15800000 19000000 p11.1 acen + chr15 19000000 20700000 q11.1 acen + chr15 98500000 102531392 q26.3 gneg + chr16 34600000 36600000 p11.1 acen + chr16 36600000 38600000 q11.1 acen + chr16 88700000 90354753 q24.3 gneg + chr17 22200000 24000000 p11.1 acen + chr17 24000000 25800000 q11.1 acen + chr17 75300000 81195210 q25.3 gneg + chr18 15400000 17200000 p11.1 acen + chr18 17200000 19000000 q11.1 acen + chr18 73100000 78077248 q23 gneg + chr19 24400000 26500000 p11 acen + chr19 26500000 28600000 q11 acen + chr19 56300000 59128983 q13.43 gpos25 + chr2 90500000 93300000 p11.1 acen + chr2 93300000 96800000 q11.1 acen + chr2 237300000 243199373 q37.3 gneg + chr20 25600000 27500000 p11.1 acen + chr20 27500000 29400000 q11.1 acen + chr20 58400000 63025520 q13.33 gneg + chr21 10900000 13200000 p11.1 acen + chr21 13200000 14300000 q11.1 acen + chr21 42600000 48129895 q22.3 gneg + chr22 12200000 14700000 p11.1 acen + chr22 14700000 17900000 q11.1 acen + chr22 49400000 51304566 q13.33 gneg + chr3 87900000 91000000 p11.1 acen + chr3 91000000 93900000 q11.1 acen + chr3 192300000 198022430 q29 gneg + chr4 48200000 50400000 p11 acen + chr4 50400000 52700000 q11 acen + chr4 187100000 191154276 q35.2 gpos25 + chr5 46100000 48400000 p11 acen + chr5 48400000 50700000 q11.1 acen + chr5 176600000 180915260 q35.3 gneg + chr6 58700000 61000000 p11.1 acen + chr6 61000000 63300000 q11.1 acen + chr6 164500000 171115067 q27 gneg + chr7 58000000 59900000 p11.1 acen + chr7 59900000 61700000 q11.1 acen + chr7 155100000 159138663 q36.3 gneg + chr8 43100000 45600000 p11.1 acen + chr8 45600000 48100000 q11.1 acen + chr8 139900000 146364022 q24.3 gneg + chr9 47300000 49000000 p11.1 acen + chr9 49000000 50700000 q11 acen + chr9 137400000 141213431 q34.3 gneg + chrX 58100000 60600000 p11.1 acen + chrX 60600000 63000000 q11.1 acen + chrX 147100000 155270560 q28 gneg + ]; + my @lines = split(/\n/,$ktype); + my %chrs = (); + my $max_len = 0; + for my $line (@lines) + { + if ( $line =~ /^\s*$/ ) { next; } + $line =~ s/^\s*//; + $line =~ s/\s*$//; + my @items = split(/\s+/,$line); + my $chr = $items[0]; + my $start = $items[1]; + my $end = $items[2]; + $chr =~ s/^chr//; + if ( $items[-1] eq 'acen' ) + { + push @{$chrs{$chr}{acen}},$start; + push @{$chrs{$chr}{acen}},$end; + } + if ( !defined $chrs{$chr}{len} or $chrs{$chr}{len} < $end ) + { + $chrs{$chr}{len} = $end; + } + if ( $max_len < $end ) { $max_len = $end; } + } + for my $chr (keys %chrs) + { + splice(@{$chrs{$chr}{acen}},1,1); + } + $$opts{chrs} = \%chrs; + $$opts{max_chr_len} = $max_len; +} + + + + From 2f3bc55ccaee35f8a51c875eb067c1a271586888 Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Fri, 2 Oct 2015 12:27:35 +0100 Subject: [PATCH 088/211] tag2tag.c: minor fix to boilerplate header --- plugins/tag2tag.c | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/plugins/tag2tag.c b/plugins/tag2tag.c index 03a841613..ec8956582 100644 --- a/plugins/tag2tag.c +++ b/plugins/tag2tag.c @@ -1,4 +1,4 @@ -/* plugins/fill-AN-AC.c -- fills AN and AC INFO fields. +/* plugins/tag2tag.c -- Convert between similar tags, such as GL and GP. Copyright (C) 2014 Genome Research Ltd. From 2f3ab49e4784839680468d804e65d8a7fc0b71b3 Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Fri, 2 Oct 2015 14:00:06 +0100 Subject: [PATCH 089/211] color-chrs.pl: add copyright boilerplate --- plugins/color-chrs.pl | 21 ++++++++++++++++++++- 1 file changed, 20 insertions(+), 1 deletion(-) diff --git a/plugins/color-chrs.pl b/plugins/color-chrs.pl index 39c4b74c4..4afb9c709 100755 --- a/plugins/color-chrs.pl +++ b/plugins/color-chrs.pl @@ -1,7 +1,26 @@ #!/usr/bin/env perl # -# Author: petr.danecek@sanger +# Copyright (C) 2015 Genome Research Ltd. # +# Author: Petr Danecek +# +# Permission is hereby granted, free of charge, to any person obtaining a copy +# of this software and associated documentation files (the "Software"), to deal +# in the Software without restriction, including without limitation the rights +# to use, copy, modify, merge, publish, distribute, sublicense, and/or sell +# copies of the Software, and to permit persons to whom the Software is +# furnished to do so, subject to the following conditions: +# +# The above copyright notice and this permission notice shall be included in +# all copies or substantial portions of the Software. +# +# THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS OR +# IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF MERCHANTABILITY, +# FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. IN NO EVENT SHALL +# THE AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY CLAIM, DAMAGES OR OTHER +# LIABILITY, WHETHER IN AN ACTION OF CONTRACT, TORT OR OTHERWISE, ARISING +# FROM, OUT OF OR IN CONNECTION WITH THE SOFTWARE OR THE USE OR OTHER +# DEALINGS IN THE SOFTWARE. use strict; use warnings; From 4923227eb2761ef8dd60512ff3e7f12f4c24d619 Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Fri, 2 Oct 2015 14:00:52 +0100 Subject: [PATCH 090/211] Makefile: remove unnecessary "\" --- Makefile | 3 +-- 1 file changed, 1 insertion(+), 2 deletions(-) diff --git a/Makefile b/Makefile index ccc6563e2..d6f620f86 100644 --- a/Makefile +++ b/Makefile @@ -77,8 +77,7 @@ INSTALL_PROGRAM = $(INSTALL) INSTALL_DATA = $(INSTALL) -m 644 INSTALL_DIR = $(MKDIR_P) -m 755 -MISC_PROGRAMS = \ - plot-vcfstats vcfutils.pl plugins/color-chrs.pl \ +MISC_PROGRAMS = plot-vcfstats vcfutils.pl plugins/color-chrs.pl all:$(PROG) plugins From 735702053f2f88bf3ec1a7435603be640ee56fa9 Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Fri, 2 Oct 2015 16:06:04 +0100 Subject: [PATCH 091/211] rename plugin/info.c -> plugin/impute-info.c --- plugins/{info.c => impute-info.c} | 18 +++++++++--------- 1 file changed, 9 insertions(+), 9 deletions(-) rename plugins/{info.c => impute-info.c} (86%) diff --git a/plugins/info.c b/plugins/impute-info.c similarity index 86% rename from plugins/info.c rename to plugins/impute-info.c index 2252b3a8f..c3c74ecea 100644 --- a/plugins/info.c +++ b/plugins/impute-info.c @@ -1,4 +1,4 @@ -/* plugins/info.c -- adds info metrics to a VCF file. +/* plugins/impute-info.c -- adds info metrics to a VCF file. Copyright (C) 2015 Genome Research Ltd. @@ -66,17 +66,17 @@ The IMPUTE2 information measure is then: const char *about(void) { - return "Add information metrics to the INFO field based on selected FORMAT tags.\n"; + return "Add imputation information metrics to the INFO field based on selected FORMAT tags.\n"; } const char *usage(void) { return "\n" - "About: Add information metrics to the INFO field based on selected\n" - " FORMAT tags. Only the IMPUTE2 INFO metric from FORMAT/GP\n" - " tags is currently available.\n" - "Usage: bcftools +info [General Options] -- [Plugin Options]\n" + "About: Add imputation information metrics to the INFO field based\n" + " on selected FORMAT tags. Only the IMPUTE2 INFO metric from\n" + " FORMAT/GP tags is currently available.\n" + "Usage: bcftools +impute-info [General Options] -- [Plugin Options]\n" "Options:\n" " run \"bcftools plugin\" for a list of common options\n" "\n" @@ -85,7 +85,7 @@ const char *usage(void) // " -t, --tags VCF tags to determine the information from [GP]\n" // "\n" "Example:\n" - " bcftools +info in.vcf\n" + " bcftools +impute-info in.vcf\n" "\n"; } @@ -108,7 +108,7 @@ bcf1_t *process(bcf1_t *rec) int nval = 0, i, j, nret = bcf_get_format_values(in_hdr,rec,"GP",(void**)&buf,&nbuf,gp_type); if ( nret<0 ) { - if (!nskip_gp) fprintf(stderr, "[info.c] Warning: info tag not added to sites without GP tag\n"); + if (!nskip_gp) fprintf(stderr, "[impute-info.c] Warning: info tag not added to sites without GP tag\n"); nskip_gp++; return rec; // require FORMAT/GP tag, return site unchanged } @@ -116,7 +116,7 @@ bcf1_t *process(bcf1_t *rec) nret /= rec->n_sample; if ( nret != 3 ) { - if (!nskip_dip) fprintf(stderr, "[info.c] Warning: info tag not added to sites that are not biallelic diploid\n"); + if (!nskip_dip) fprintf(stderr, "[impute-info.c] Warning: info tag not added to sites that are not biallelic diploid\n"); nskip_dip++; return rec; // require biallelic diploid, return site unchanged } From 818cfbe8f6b2a75a9abb425a6035d83dea797427 Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Mon, 12 Oct 2015 16:55:08 +0100 Subject: [PATCH 092/211] add tests for trimming many alleles and dropping header+format add test cases for recently closed issues: * issue #319 closed via samtools/htslib@636d70436bc67ae234510caaaafc22a1339ce3fa * issue #332 closed via samtools/htslib@4c35976a90223302350cb6a8ebe2d2a400f74aff --- test/many.alleles.trim.out | 10 ++++++++++ test/many.alleles.vcf | 7 +++++++ test/test.pl | 2 ++ test/view.dropgenotypes.noheader.out | 5 +++++ 4 files changed, 24 insertions(+) create mode 100644 test/many.alleles.trim.out create mode 100644 test/many.alleles.vcf create mode 100644 test/view.dropgenotypes.noheader.out diff --git a/test/many.alleles.trim.out b/test/many.alleles.trim.out new file mode 100644 index 000000000..7b622e150 --- /dev/null +++ b/test/many.alleles.trim.out @@ -0,0 +1,10 @@ +##fileformat=VCFv4.1 +##FILTER= +##contig= +##FORMAT= +##INFO= +##INFO= +#CHROM POS ID REF ALT QUAL FILTER INFO FORMAT SRR1528791 +chr7 142459798 . CCATCTCTCTGCCCA CCATCTCTCTCCCCG . . AC=2;AN=2 GT 1/1 +chr7 142459798 . CCATCTCTCTGCCCA CCATCTCTCTCCCCG . . AC=2;AN=2 GT 1/1 +chr7 142459798 . CCATCTCTCTGCCCA CCATCTCTCTCCCCG . . AC=2;AN=2 GT 1/1 diff --git a/test/many.alleles.vcf b/test/many.alleles.vcf new file mode 100644 index 000000000..491bc89a4 --- /dev/null +++ b/test/many.alleles.vcf @@ -0,0 +1,7 @@ +##fileformat=VCFv4.1 +##contig= +##FORMAT= +#CHROM POS ID REF ALT QUAL FILTER INFO FORMAT SRR1528791 +chr7 142459798 . CCATCTCTCTGCCCA CCATCTCTCTCCCCC,CCATCTCTCTCCCCG,CCTTCTCTCTGCCCC,CCCTCTCTCTCCCCC,CCACCTCTCTGCCCC,CCACCCCTCTGCCCA,CCACCTCCCTCCCCC,CCACCTCCCTGCCCA,CCACCTCTCGGCCCC,CCACCTCTCGGCCCA,CCACCTCTCTCCCCC,CCACCTCTCTCCCCA,CCATCCCCCTCCCCC,CCATCCCCCTGCCCC,CCATCCCCCTGCCCA,CCATCCCTCGGCCCC,CCATCCCTCGGCCCA,CCATCCCTCTCCCCC,CCATCCCTCTCCCCA,CCATCCCTCTGCCCC,CCATCTCCCGGCCCC,CCATCTCCCGGCCCA,CCATCTCCCGCCCCC,CCATCTCCCTCCCCC,CCATCTCCCTCCCCA,CCATCTCCCTGCCCC,CCATCTCTCGGCCCC,CCATCTCTCCCCCCC,CCATCTCTCGCCCCC,CCATCTCTGGGCCCA,CCATCTCTCCCCCCA,CCATCTCTCGCCCCA,CCATCTCTCTCCCCA . . . GT 2/2 +chr7 142459798 . CCATCTCTCTGCCCA CCATCTCTCTCCCCC,CCATCTCTCTCCCCG,CCTTCTCTCTGCCCC,CCCTCTCTCTCCCCC,CCACCTCTCTGCCCC,CCACCCCTCTGCCCA,CCACCTCCCTCCCCC,CCACCTCCCTGCCCA,CCACCTCTCGGCCCC,CCACCTCTCGGCCCA,CCACCTCTCTCCCCC,CCACCTCTCTCCCCA,CCATCCCCCTCCCCC,CCATCCCCCTGCCCC,CCATCCCCCTGCCCA,CCATCCCTCGGCCCC,CCATCCCTCGGCCCA,CCATCCCTCTCCCCC,CCATCCCTCTCCCCA,CCATCCCTCTGCCCC,CCATCTCCCGGCCCC,CCATCTCCCGGCCCA,CCATCTCCCGCCCCC,CCATCTCCCTCCCCC,CCATCTCCCTCCCCA,CCATCTCCCTGCCCC,CCATCTCTCGGCCCC,CCATCTCTCCCCCCC,CCATCTCTCGCCCCC,CCATCTCTGGGCCCA,CCATCTCTCCCCCCA,CCATCTCTCGCCCCA,CCATCTCTCTCCCCA,CCTTCTCTCTGCCCC . . . GT 2/2 +chr7 142459798 . CCATCTCTCTGCCCA CCATCTCTCTCCCCC,CCATCTCTCTCCCCG,CCTTCTCTCTGCCCC,CCCTCTCTCTCCCCC,CCACCTCTCTGCCCC,CCACCCCTCTGCCCA,CCACCTCCCTCCCCC,CCACCTCTCGGCCCC,CCACCTCTCGGCCCA,CCACCTCTCTCCCCC,CCACCTCTCTCCCCA,CCATCCCCCTCCCCC,CCATCCCCCTGCCCC,CCATCCCCCTGCCCA,CCATCCCTCGGCCCC,CCATCCCTCGGCCCA,CCATCCCTCTCCCCC,CCATCCCTCTCCCCA,CCATCCCTCTGCCCC,CCATCTCCCGGCCCC,CCATCTCCCGGCCCA,CCATCTCCCGCCCCC,CCATCTCCCTCCCCC,CCATCTCCCTCCCCA,CCATCTCCCTGCCCC,CCATCTCTCGGCCCC,CCATCTCTCCCCCCC,CCATCTCTCGCCCCC,CCATCTCTGGGCCCA,CCATCTCTCCCCCCA,CCATCTCTCGCCCCA,CCATCTCTCTCCCCA,CCTTCTCTCTGCCCC,CCTTCTCTCTGCCCC,CCTTCTCTCTGCCCC,CCTTCTCTCTGCCCC,CCTTCTCTCTGCCCC,CCTTCTCTCTGCCCC,CCTTCTCTCTGCCCC,CCTTCTCTCTGCCCC,CCTTCTCTCTGCCCC,CCTTCTCTCTGCCCC,CCTTCTCTCTGCCCC,CCTTCTCTCTGCCCC,CCTTCTCTCTGCCCC,CCTTCTCTCTGCCCC,CCTTCTCTCTGCCCC,CCTTCTCTCTGCCCC,CCTTCTCTCTGCCCC,CCTTCTCTCTGCCCC,CCTTCTCTCTGCCCC,CCTTCTCTCTGCCCC,CCTTCTCTCTGCCCC,CCTTCTCTCTGCCCC,CCTTCTCTCTGCCCC,CCTTCTCTCTGCCCC,CCTTCTCTCTGCCCC,CCTTCTCTCTGCCCC,CCTTCTCTCTGCCCC,CCTTCTCTCTGCCCC,CCTTCTCTCTGCCCC,CCTTCTCTCTGCCCC,CCTTCTCTCTGCCCC . . . GT 2/2 diff --git a/test/test.pl b/test/test.pl index 176243e3f..4120a3c4e 100755 --- a/test/test.pl +++ b/test/test.pl @@ -111,6 +111,8 @@ test_vcf_view($opts,in=>'view',out=>'view.exclude.out',args=>'-s ^NA00003',reg=>''); test_vcf_view($opts,in=>'view.omitgenotypes',out=>'view.omitgenotypes.out',args=>'',reg=>''); test_vcf_view($opts,in=>'view.omitgenotypes',out=>'view.dropgenotypes.out',args=>'-G',reg=>''); +test_vcf_view($opts,in=>'view.omitgenotypes',out=>'view.dropgenotypes.noheader.out',args=>'-HG',reg=>''); +test_vcf_view($opts,in=>'many.alleles',out=>'many.alleles.trim.out',args=>'-a',reg=>''); test_vcf_view($opts,in=>'view.vectors',out=>'view.vectors.A.out',args=>'-asA',reg=>''); test_vcf_view($opts,in=>'view.vectors',out=>'view.vectors.B.out',args=>'-asB',reg=>''); test_vcf_view($opts,in=>'view.filter',out=>'view.filter.1.out',args=>q[-H -i'FMT/FGS[0]="AAAAAA"'],reg=>''); # test expressions diff --git a/test/view.dropgenotypes.noheader.out b/test/view.dropgenotypes.noheader.out new file mode 100644 index 000000000..7b5a3c809 --- /dev/null +++ b/test/view.dropgenotypes.noheader.out @@ -0,0 +1,5 @@ +20 14370 rs6054257 G A 29 PASS NS=3;DP=14 +20 17330 . T A 3 PASS NS=3;DP=11 +20 1110696 rs6040355 A G,T 67 PASS NS=2;DP=10 +20 1230237 . T . 47 PASS NS=3;DP=13 +20 1234567 microsat1 GTC G,GTCT 50 PASS NS=3;DP=9 From dacc705b8817a20dc2e909a9758d8b6e7fb80a0c Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Thu, 15 Oct 2015 09:27:21 +0100 Subject: [PATCH 093/211] genaralise mcall_trim_numberR beyond DPR to any Number=R/Type=Integer tag Fixes #338 --- mcall.c | 82 +++++++++++++++++++++++++++++++++++---------------------- 1 file changed, 51 insertions(+), 31 deletions(-) diff --git a/mcall.c b/mcall.c index e62fd4c47..67ae04482 100644 --- a/mcall.c +++ b/mcall.c @@ -1186,51 +1186,71 @@ void mcall_trim_numberR(call_t *call, bcf1_t *rec, int nals, int nout_als, int o { int i, ret; - // only DPR so far, we may generalize to arbitrary Number=R if necessary - ret = bcf_get_info_int32(call->hdr, rec, "DPR", &call->itmp, &call->n_itmp); - if ( ret>0 ) + // at the moment we have DPR,AD,ADF,ADR all Number=R,Type=Integer, + // so only dealing with these cases at the moment + for (i=0; in_info; i++) { - assert( ret==nals ); - if ( out_als==1 ) - bcf_update_info_int32(call->hdr, rec, "DPR", call->itmp, 1); - else + bcf_info_t *info = &rec->d.info[i]; + int vlen = bcf_hdr_id2length(call->hdr,BCF_HL_INFO,info->key); + if ( vlen!=BCF_VL_R ) continue; + int type = bcf_hdr_id2type(call->hdr,BCF_HL_INFO,info->key); + if ( type!=BCF_HT_INT ) continue; + + ret = bcf_get_info_int32(call->hdr, rec, bcf_hdr_int2id(call->hdr,BCF_DT_ID,info->key), &call->itmp, &call->n_itmp); + if ( ret>0 ) { - for (i=0; ihdr, rec, bcf_hdr_int2id(call->hdr,BCF_DT_ID,info->key), call->itmp, 1); + else { - if ( call->als_map[i]==-1 ) continue; // to be dropped - call->PLs[ call->als_map[i] ] = call->itmp[i]; // reusing PLs storage which is not used at this point + int j; + for (j=0; jals_map[j]==-1 ) continue; // to be dropped + call->PLs[ call->als_map[j] ] = call->itmp[j]; // reusing PLs storage which is not used at this point + } + bcf_update_info_int32(call->hdr, rec, bcf_hdr_int2id(call->hdr,BCF_DT_ID,info->key), call->PLs, nout_als); } - bcf_update_info_int32(call->hdr, rec, "DPR", call->PLs, nout_als); } } - ret = bcf_get_format_int32(call->hdr, rec, "DPR", &call->itmp, &call->n_itmp); - if ( ret>0 ) + for (i=0; in_fmt; i++) { - int nsmpl = bcf_hdr_nsamples(call->hdr); - int ndp = ret / nsmpl; - assert( ndp==nals ); - if ( out_als==1 ) + bcf_fmt_t *fmt = &rec->d.fmt[i]; + int vlen = bcf_hdr_id2length(call->hdr,BCF_HL_FMT,fmt->id); + if ( vlen!=BCF_VL_R ) continue; + int type = bcf_hdr_id2type(call->hdr,BCF_HL_FMT,fmt->id); + if ( type!=BCF_HT_INT ) continue; + + ret = bcf_get_format_int32(call->hdr, rec, bcf_hdr_int2id(call->hdr,BCF_DT_ID,fmt->id), &call->itmp, &call->n_itmp); + if ( ret>0 ) { - for (i=0; iPLs[i] = call->itmp[i*ndp]; + int j, nsmpl = bcf_hdr_nsamples(call->hdr); + int ndp = ret / nsmpl; + assert( ndp==nals ); + if ( out_als==1 ) + { + for (j=0; jPLs[j] = call->itmp[j*ndp]; - bcf_update_format_int32(call->hdr, rec, "DPR", call->PLs, nsmpl); - } - else - { - int j; - for (i=0; ihdr, rec, bcf_hdr_int2id(call->hdr,BCF_DT_ID,fmt->id), call->PLs, nsmpl); + } + else { - int32_t *dp_dst = call->PLs + i*nout_als; - int32_t *dp_src = call->itmp + i*ndp; - for (j=0; jals_map[j]==-1 ) continue; // to be dropped - dp_dst[ call->als_map[j] ] = dp_src[j]; // reusing PLs storage which is not used at this point + int32_t *dp_dst = call->PLs + j*nout_als; + int32_t *dp_src = call->itmp + j*ndp; + for (k=0; kals_map[k]==-1 ) continue; // to be dropped + dp_dst[ call->als_map[k] ] = dp_src[k]; // reusing PLs storage which is not used at this point + } } + bcf_update_format_int32(call->hdr, rec, bcf_hdr_int2id(call->hdr,BCF_DT_ID,fmt->id), call->PLs, nsmpl*nout_als); } - bcf_update_format_int32(call->hdr, rec, "DPR", call->PLs, nsmpl*nout_als); } } } From 9fc3364f44c5bee267442e5423995f15767a26ef Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Wed, 23 Sep 2015 08:33:52 +0100 Subject: [PATCH 094/211] Small polysomy improvements - fix in printout of peak centers with the -v option, constrained parameters were not updated - detect failed fits with peaks to narrow or too broad to contribute meaningfully - print the best function for all three states with the -v option - reversed the --cn-penalty to the expected meaning: larger is stricter --- peakfit.c | 30 +++++++++++++++------------ polysomy.c | 59 +++++++++++++++++++++++++++++++++++++++--------------- 2 files changed, 60 insertions(+), 29 deletions(-) diff --git a/peakfit.c b/peakfit.c index 89bdcb0c4..2bc849226 100644 --- a/peakfit.c +++ b/peakfit.c @@ -134,12 +134,12 @@ double bounded_gaussian_convert_set(peak_t *pk, int iparam, double value) } void bounded_gaussian_convert_get(peak_t *pk, double *params) { - params[0] = fabs(params[0]); - params[2] = fabs(params[2]); - double b = params[1]; - double d = params[3]; - double e = params[4]; - params[1] = 0.5*(cos(b)+1)*(e-d) + d; + params[0] = fabs(pk->params[0]); + params[2] = fabs(pk->params[2]); + double center = pk->params[1]; + double d = pk->params[3]; + double e = pk->params[4]; + params[1] = 0.5*(cos(center)+1)*(e-d) + d; } void peakfit_add_bounded_gaussian(peakfit_t *pkf, double a, double b, double c, double d, double e, int fit_mask) @@ -226,8 +226,9 @@ void gaussian_sprint_func(struct _peak_t *pk, kstring_t *str) } void gaussian_convert_get(peak_t *pk, double *params) { - params[0] = fabs(params[0]); - params[2] = fabs(params[2]); + params[0] = fabs(pk->params[0]); + params[1] = fabs(pk->params[1]); + params[2] = fabs(pk->params[2]); } @@ -306,9 +307,9 @@ void exp_sprint_func(struct _peak_t *pk, kstring_t *str) } void exp_convert_get(peak_t *pk, double *params) { - params[0] = fabs(params[0]); - params[1] = fabs(params[1]); - params[2] = fabs(params[2]); + params[0] = fabs(pk->params[0]); + params[1] = fabs(pk->params[1]); + params[2] = fabs(pk->params[2]); } void peakfit_add_exp(peakfit_t *pkf, double a, double b, double c, int fit_mask) @@ -352,9 +353,12 @@ void peakfit_set_params(peakfit_t *pkf, int ipk, double *params, int nparams) void peakfit_get_params(peakfit_t *pkf, int ipk, double *params, int nparams) { peak_t *pk = &pkf->peaks[ipk]; - int i; - for (i=0; iparams[i]; if ( pk->convert_get ) pk->convert_get(pk, params); + else + { + int i; + for (i=0; iparams[i]; + } } peakfit_t *peakfit_init(void) diff --git a/polysomy.c b/polysomy.c index 3962cf8a1..3d83a6d87 100644 --- a/polysomy.c +++ b/polysomy.c @@ -54,7 +54,7 @@ typedef struct double *xvals; dist_t *dist; char **argv, *output_dir; - double fit_th, peak_symmetry, cn_penalty, bump_size, min_fraction; + double fit_th, peak_symmetry, cn_penalty, min_peak_size, min_fraction; int argc, plot, verbose, regions_is_file, targets_is_file, include_aa, force_cn; char *dat_fname, *fname, *regions_list, *targets_list, *sample; FILE *dat_fp; @@ -425,6 +425,7 @@ static void fit_curves(args_t *args) peakfit_get_params(pkf,0,cn3rra_params,5); peakfit_get_params(pkf,1,cn3raa_params,5); double cn3_dx = (0.5-cn3rra_params[1] + cn3raa_params[1]-0.5)*0.5; + if ( cn3_dx > 0.5/3 ) cn3_dx = 0.5/3; // CN3 peaks should not be separated by more than 1/3 peakfit_reset(pkf); peakfit_add_gaussian(pkf, cn3rra_params[0],0.5-cn3_dx,cn3rra_params[2], 5); peakfit_add_gaussian(pkf, cn3raa_params[0],0.5+cn3_dx,cn3raa_params[2], 5); @@ -438,10 +439,13 @@ static void fit_curves(args_t *args) double cn3_dy = cn3rra_size > cn3raa_size ? cn3raa_size/cn3rra_size : cn3rra_size/cn3raa_size; double cn3_frac = (1 - 2*cn3rra_params[1]) / cn3rra_params[1]; double cn3_fit = cn3ra_fit + cn3aa_fit; + // A very reasonable heuristics: check if the peak's width converged, exclude far too broad or far too narrow peaks + if ( cn3rra_params[2]>0.3 || cn3raa_params[2]>0.3 ) cn3_fit = HUGE_VAL; + if ( cn3rra_params[2]<1e-2 || cn3raa_params[2]<1e-2 ) cn3_fit = HUGE_VAL; // CN4 (contaminations) - // - similarly to CN3, fit three peaks, then enforce the symmetry and fit again + // - first fit only the [0,0.5] part of the data, then enforce the symmetry and fit again // - min_frac=1 (resp. 0.5) is interpreted as 50:50% (rep. 75:25%) contamination double cn4AAaa_params[3] = {1,1,1} ,cn4AAra_params[3] = {1,1,1}, cn4RAra_params[3], cn4RArr_params[5], cn4RAaa_params[5]; double cn4aa_fit = 0, cn4ra_fit; @@ -460,18 +464,20 @@ static void fit_curves(args_t *args) peakfit_get_params(pkf,1,cn4AAra_params,5); } peakfit_reset(pkf); + // first fit only the [0,0.5] part of the data peakfit_add_gaussian(pkf, 1.0,0.5,0.03, 5); peakfit_add_bounded_gaussian(pkf, 0.6,0.3,0.03, xrr,xra-min_dx4, 7); peakfit_set_mc(pkf, xrr,xra-min_dx4,2,nmc); peakfit_run(pkf, nrr_ra , xrr_vals, yrr_vals); - // suggest symmetry around x=0.5 + // now forcet symmetry around x=0.5 peakfit_get_params(pkf,0,cn4RAra_params,3); peakfit_get_params(pkf,1,cn4RArr_params,5); double cn4_dx = 0.5-cn4RArr_params[1]; + if ( cn4_dx > 0.25 ) cn4_dx = 0.25; // CN4 peaks should not be separated by more than 0.5 peakfit_reset(pkf); peakfit_add_gaussian(pkf, cn4RAra_params[0],0.5,cn4RAra_params[2], 5); - peakfit_add_gaussian(pkf, cn4RArr_params[0],0.5-cn4_dx,cn4RArr_params[2], 7); - peakfit_add_gaussian(pkf, cn4RArr_params[0],0.5+cn4_dx,cn4RArr_params[2], 7); + peakfit_add_gaussian(pkf, cn4RArr_params[0],0.5-cn4_dx,cn4RArr_params[2], 5); + peakfit_add_gaussian(pkf, cn4RArr_params[0],0.5+cn4_dx,cn4RArr_params[2], 5); peakfit_set_mc(pkf, 0.1,cn4RAra_params[0],0,nmc); peakfit_set_mc(pkf, 0.01,0.1,2,nmc); cn4ra_fit = peakfit_run(pkf, nrr_aa , xrr_vals, yrr_vals); @@ -489,6 +495,9 @@ static void fit_curves(args_t *args) cn4_dx = (cn4RAaa_params[1]-0.5) - (0.5-cn4RArr_params[1]); double cn4_frac = cn4RAaa_params[1] - cn4RArr_params[1]; double cn4_fit = cn4ra_fit + cn4aa_fit; + // A very reasonable heuristics: check if the peak's width converged, exclude far too broad or far too narrow peaks + if ( cn4RAra_params[2]>0.3 || cn4RArr_params[2]>0.3 || cn4RAaa_params[2]>0.3 ) cn4_fit = HUGE_VAL; + if ( cn4RAra_params[2]<1e-2 || cn4RArr_params[2]<1e-2 || cn4RAaa_params[2]<1e-2 ) cn4_fit = HUGE_VAL; // Choose the best match @@ -499,7 +508,7 @@ static void fit_curves(args_t *args) else if ( cn3_dy < args->peak_symmetry ) cn3_fail = 'y'; // size difference is too big if ( cn4_fit > args->fit_th ) cn4_fail = 'f'; - else if ( cn4_ymin < args->bump_size ) cn4_fail = 'y'; // side peak is too small + else if ( cn4_ymin < args->min_peak_size ) cn4_fail = 'y'; // side peak is too small else if ( cn4_dy < args->peak_symmetry ) cn4_fail = 'Y'; // size difference is too big else if ( cn4_dx > 0.1 ) cn4_fail = 'x'; // side peaks placed assymetrically @@ -507,8 +516,8 @@ static void fit_curves(args_t *args) if ( cn2_fail == '*' ) { cn = 2; fit = cn2_fit; } if ( cn3_fail == '*' ) { - // use cn_penalty as a tiebreaker - if ( cn<0 || cn3_fit < args->cn_penalty * fit ) + // Use cn_penalty as a tiebreaker. If set to 0.3, cn3_fit must be 30% smaller than cn2_fit. + if ( cn<0 || cn3_fit < (1-args->cn_penalty) * fit ) { cn = 2 + cn3_frac; fit = cn3_fit; @@ -518,7 +527,7 @@ static void fit_curves(args_t *args) } if ( cn4_fail == '*' ) { - if ( cn<0 || cn4_fit < args->cn_penalty * fit ) + if ( cn<0 || cn4_fit < (1-args->cn_penalty) * fit ) { cn = 3 + cn4_frac; fit = cn4_fit; @@ -535,12 +544,20 @@ static void fit_curves(args_t *args) fprintf(stderr,"\t RA: %f %f %f\n", cn2ra_params[0],cn2ra_params[1],cn2ra_params[2]); fprintf(stderr,"\t .. %e\n", cn2aa_fit); fprintf(stderr,"\t AA: %f %f %f\n", cn2aa_params[0],cn2aa_params[1],cn2aa_params[2]); + fprintf(stderr,"\t func:\n"); + fprintf(stderr,"\t %s\n", cn2ra_func); + fprintf(stderr,"\t %s\n", cn2aa_func); + fprintf(stderr,"\n"); fprintf(stderr,"\tcn3 %c fit=%e frac=%f symmetry=%f\n", cn3_fail, cn3_fit, cn3_frac, cn3_dy); fprintf(stderr,"\t .. %e\n", cn3ra_fit); fprintf(stderr,"\t RRA: %f %f %f\n", cn3rra_params[0],cn3rra_params[1],cn3rra_params[2]); fprintf(stderr,"\t RAA: %f %f %f\n", cn3raa_params[0],cn3raa_params[1],cn3raa_params[2]); fprintf(stderr,"\t .. %e\n", cn3aa_fit); fprintf(stderr,"\t AAA: %f %f %f\n", cn3aa_params[0],cn3aa_params[1],cn3aa_params[2]); + fprintf(stderr,"\t func:\n"); + fprintf(stderr,"\t %s\n", cn3ra_func); + fprintf(stderr,"\t %s\n", cn3aa_func); + fprintf(stderr,"\n"); fprintf(stderr,"\tcn4 %c fit=%e frac=%f symmetry=%f ymin=%f\n", cn4_fail, cn4_fit, cn4_frac, cn4_dy, cn4_ymin); fprintf(stderr,"\t .. %e\n", cn4ra_fit); fprintf(stderr,"\t RArr: %f %f %f\n", cn4RArr_params[0],cn4RArr_params[1],cn4RArr_params[2]); @@ -548,6 +565,10 @@ static void fit_curves(args_t *args) fprintf(stderr,"\t RAaa: %f %f %f\n", cn4RAaa_params[0],cn4RAaa_params[1],cn4RAaa_params[2]); fprintf(stderr,"\t .. %e\n", cn4aa_fit); fprintf(stderr,"\t AAaa: %f %f %f\n", cn4AAaa_params[0],cn4AAaa_params[1],cn4AAaa_params[2]); + fprintf(stderr,"\t func:\n"); + fprintf(stderr,"\t %s\n", cn4ra_func); + fprintf(stderr,"\t %s\n", cn4aa_func); + fprintf(stderr,"\n"); } if ( args->force_cn==2 || cn2_fail == '*' ) @@ -593,12 +614,12 @@ static void usage(args_t *args) fprintf(stderr, " -v, --verbose \n"); fprintf(stderr, "\n"); fprintf(stderr, "Algorithm options:\n"); - fprintf(stderr, " -b, --bump-size minimum bump size (larger is stricter) [0.1]\n"); - fprintf(stderr, " -c, --cn-penalty penalty for increasing CN (smaller is stricter) [0.3]\n"); - fprintf(stderr, " -f, --fit-th goodness of fit threshold (smaller is stricter) [3.3]\n"); + fprintf(stderr, " -b, --peak-size minimum peak size (0-1, larger is stricter) [0.1]\n"); + fprintf(stderr, " -c, --cn-penalty penalty for increasing CN (0-1, larger is stricter) [0.7]\n"); + fprintf(stderr, " -f, --fit-th goodness of fit threshold (>0, smaller is stricter) [3.3]\n"); fprintf(stderr, " -i, --include-aa include the AA peak in CN2 and CN3 evaluation\n"); fprintf(stderr, " -m, --min-fraction minimum distinguishable fraction of aberrant cells [0.1]\n"); - fprintf(stderr, " -p, --peak-symmetry peak symmetry threshold (larger is stricter) [0.5]\n"); + fprintf(stderr, " -p, --peak-symmetry peak symmetry threshold (0-1, larger is stricter) [0.5]\n"); fprintf(stderr, "\n"); exit(1); } @@ -609,9 +630,9 @@ int main_polysomy(int argc, char *argv[]) args->argc = argc; args->argv = argv; args->nbins = 150; args->fit_th = 3.3; - args->cn_penalty = 0.3; + args->cn_penalty = 0.7; args->peak_symmetry = 0.5; - args->bump_size = 0.1; + args->min_peak_size = 0.1; args->ra_rr_scaling = 1; args->min_fraction = 0.1; @@ -620,6 +641,7 @@ int main_polysomy(int argc, char *argv[]) {"ra-rr-scaling",0,0,1}, // hidden option {"force-cn",1,0,2}, // hidden option {"include-aa",0,0,'i'}, + {"peak-size",1,0,'b'}, {"min-fraction",1,0,'m'}, {"verbose",0,0,'v'}, {"fit-th",1,0,'f'}, @@ -634,13 +656,18 @@ int main_polysomy(int argc, char *argv[]) {0,0,0,0} }; char c, *tmp; - while ((c = getopt_long(argc, argv, "h?o:vt:T:r:R:s:f:p:c:im:",loptions,NULL)) >= 0) + while ((c = getopt_long(argc, argv, "h?o:vt:T:r:R:s:f:p:c:im:b:",loptions,NULL)) >= 0) { switch (c) { case 1 : args->ra_rr_scaling = 0; break; case 2 : args->force_cn = atoi(optarg); break; case 'i': args->include_aa = 1; break; + case 'b': + args->min_peak_size = strtod(optarg,&tmp); + if ( *tmp ) error("Could not parse: -b %s\n", optarg); + if ( args->min_peak_size<0 || args->min_peak_size>1 ) error("Range error: -b %s\n", optarg); + break; case 'm': args->min_fraction = strtod(optarg,&tmp); if ( *tmp ) error("Could not parse: -n %s\n", optarg); From f0889c4802aa5a87632cf792d5e9d8f2efe41585 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Wed, 23 Sep 2015 13:47:36 +0100 Subject: [PATCH 095/211] New hidden -n and -S options to polysomy --- polysomy.c | 40 +++++++++++++++++++++++++++++++--------- 1 file changed, 31 insertions(+), 9 deletions(-) diff --git a/polysomy.c b/polysomy.c index 3d83a6d87..c5a5394e1 100644 --- a/polysomy.c +++ b/polysomy.c @@ -50,7 +50,7 @@ dist_t; typedef struct { - int ndist, nbins, ra_rr_scaling; + int ndist, nbins, ra_rr_scaling, smooth; double *xvals; dist_t *dist; char **argv, *output_dir; @@ -70,15 +70,31 @@ static void init_dist(args_t *args, dist_t *dist, int verbose) // smooth the distribution, this is just to find the peaks double *tmp = (double*) malloc(sizeof(double)*n); - int win = 0.04*n < 1 ? 1 : 0.04*n; - double avg = 0; - for (i=0; iyvals[i]; - for (i=0; ismooth ? fabs(args->smooth)*2 + 1 : 7; // must be an odd number + int hwin = win/2; + double avg = tmp[0] = dist->yvals[0]; + for (i=1; iyvals[i] + dist->yvals[i+win]; + avg += dist->yvals[2*i-1]; + tmp[i] = avg/(2*i+1); + } + avg = 0; + for (i=0; iyvals[i]; + if ( i>=win-1 ) + { + tmp[i-hwin] = avg/win; + avg -= dist->yvals[i-win+1]; + } + } + for (i=n-hwin; iyvals[i-hwin]; + hwin--; + tmp[i] = avg/(2*hwin+1); + avg -= dist->yvals[i-hwin]; } - for (; i=n ) iaa = n-1; if ( irr>=iaa ) error("FIXME: oops, dist normalization failed for %s: %d vs %d\n", dist->chr,irr,iaa); // we may need to be smarter + if ( args->smooth>0 ) for (i=0; iyvals[i] = tmp[i]; free(tmp); // clean the data: the AA peak is occasionally not centered at 1.0 but is closer to the center, chop off @@ -635,11 +652,14 @@ int main_polysomy(int argc, char *argv[]) args->min_peak_size = 0.1; args->ra_rr_scaling = 1; args->min_fraction = 0.1; + args->smooth = -3; static struct option loptions[] = { {"ra-rr-scaling",0,0,1}, // hidden option {"force-cn",1,0,2}, // hidden option + {"smooth",1,0,'S'}, // hidden option + {"nbins",1,0,'n'}, // hidden option {"include-aa",0,0,'i'}, {"peak-size",1,0,'b'}, {"min-fraction",1,0,'m'}, @@ -656,12 +676,14 @@ int main_polysomy(int argc, char *argv[]) {0,0,0,0} }; char c, *tmp; - while ((c = getopt_long(argc, argv, "h?o:vt:T:r:R:s:f:p:c:im:b:",loptions,NULL)) >= 0) + while ((c = getopt_long(argc, argv, "h?o:vt:T:r:R:s:f:p:c:im:b:n:S:",loptions,NULL)) >= 0) { switch (c) { case 1 : args->ra_rr_scaling = 0; break; case 2 : args->force_cn = atoi(optarg); break; + case 'n': args->nbins = atoi(optarg); break; + case 'S': args->smooth = atoi(optarg); break; case 'i': args->include_aa = 1; break; case 'b': args->min_peak_size = strtod(optarg,&tmp); From 83c9593f7a6c45d35f5bf16ca0df298500629ec8 Mon Sep 17 00:00:00 2001 From: Adam Spargo Date: Wed, 14 Oct 2015 16:32:32 +0100 Subject: [PATCH 096/211] change to filter.c:filters_init() Search all elements of INFO tag arrays UNLESS an array index has been detected. Fix indentation. Add 3 tests to test/test.pl. This closes #320. --- filter.c | 28 +++++++++--------- test/test.pl | 3 ++ test/view.filter.annovar.1.out | 2 ++ test/view.filter.annovar.2.out | 1 + test/view.filter.annovar.3.out | 1 + test/view.filter.annovar.vcf | 52 ++++++++++++++++++++++++++++++++++ 6 files changed, 73 insertions(+), 14 deletions(-) create mode 100644 test/view.filter.annovar.1.out create mode 100644 test/view.filter.annovar.2.out create mode 100644 test/view.filter.annovar.3.out create mode 100644 test/view.filter.annovar.vcf diff --git a/filter.c b/filter.c index 9ae263b44..82d19f2a2 100644 --- a/filter.c +++ b/filter.c @@ -1282,25 +1282,25 @@ static int filters_init1(filter_t *filter, char *str, int len, token_t *tok) { if ( bcf_hdr_id2type(filter->hdr,BCF_HL_INFO,tok->hdr_id) == BCF_HT_STR ) tok->is_str = 1; if ( bcf_hdr_id2number(filter->hdr,BCF_HL_INFO,tok->hdr_id)==1 ) - tok->setter = filters_set_info; - else - { - switch ( bcf_hdr_id2type(filter->hdr,BCF_HL_INFO,tok->hdr_id) ) + tok->setter = filters_set_info; + else { - case BCF_HT_INT: tok->setter = &filters_set_info_int; break; - case BCF_HT_REAL: tok->setter = &filters_set_info_float; break; - case BCF_HT_STR: tok->setter = &filters_set_info_string; tok->is_str = 1; break; - default: error("[%s:%d %s] FIXME\n", __FILE__,__LINE__,__FUNCTION__); + switch ( bcf_hdr_id2type(filter->hdr,BCF_HL_INFO,tok->hdr_id) ) + { + case BCF_HT_INT: tok->setter = &filters_set_info_int; break; + case BCF_HT_REAL: tok->setter = &filters_set_info_float; break; + case BCF_HT_STR: tok->setter = &filters_set_info_string; tok->is_str = 1; break; + default: error("[%s:%d %s] FIXME\n", __FILE__,__LINE__,__FUNCTION__); + } + if(!is_array) tok->idx = -2; } - //tok->idx = -2; - } } filter->max_unpack |= BCF_UN_INFO; - } - tok->tag = strdup(tmp.s); - if ( tmp.s ) free(tmp.s); - return 0; } + tok->tag = strdup(tmp.s); + if ( tmp.s ) free(tmp.s); + return 0; + } else if ( !strcasecmp(tmp.s,"ALT") ) { tok->setter = &filters_set_alt_string; diff --git a/test/test.pl b/test/test.pl index 4120a3c4e..c3819fd58 100755 --- a/test/test.pl +++ b/test/test.pl @@ -130,6 +130,9 @@ test_vcf_view($opts,in=>'view.minmaxac',out=>'view.minmaxac.1.out',args=>q[-H -C5:nonmajor],reg=>''); test_vcf_view($opts,in=>'view.minmaxac',out=>'view.minmaxac.2.out',args=>q[-H -c6:nonmajor],reg=>''); test_vcf_view($opts,in=>'view.minmaxac',out=>'view.minmaxac.1.out',args=>q[-H -q0.3:major],reg=>''); +test_vcf_view($opts,in=>'view.filter.annovar',out=>'view.filter.annovar.1.out',args=>q[-H -i 'Gene.refGene=="RAD21L1"'],reg=>''); +test_vcf_view($opts,in=>'view.filter.annovar',out=>'view.filter.annovar.2.out',args=>q[-H -i 'Gene.refGene~"NOD"'],reg=>''); +test_vcf_view($opts,in=>'view.filter.annovar',out=>'view.filter.annovar.3.out',args=>q[-H -i 'LJB2_MutationTaster=="0.291000"'],reg=>''); test_vcf_call($opts,in=>'mpileup',out=>'mpileup.1.out',args=>'-mv'); test_vcf_call($opts,in=>'mpileup',out=>'mpileup.2.out',args=>'-mg0'); test_vcf_call($opts,in=>'mpileup.X',out=>'mpileup.X.out',args=>'-mv --ploidy-file {PATH}/mpileup.ploidy -S {PATH}/mpileup.samples'); diff --git a/test/view.filter.annovar.1.out b/test/view.filter.annovar.1.out new file mode 100644 index 000000000..e71068c15 --- /dev/null +++ b/test/view.filter.annovar.1.out @@ -0,0 +1,2 @@ +20 1230237 . T G 47 PASS NS=3;DP=13;AA=T;ANNOVAR_DATE=2015-06-17;Func.refGene=intronic;Gene.refGene=RAD21L1;GeneDetail.refGene=.;ExonicFunc.refGene=.;AAChange.refGene=.;Func.ensGene=intronic;Gene.ensGene=ENSG00000244588;GeneDetail.ensGene=.;ExonicFunc.ensGene=.;AAChange.ensGene=.;esp6500si_ea=.;esp6500si_all=.;1000g2012apr_eur=.;1000g2012apr_all=.;snp138=.;LJB2_SIFT=.;LJB2_PolyPhen2_HDIV=.;LJB2_PP2_HDIV_Pred=.;LJB2_PolyPhen2_HVAR=.;LJB2_PolyPhen2_HVAR_Pred=.;LJB2_LRT=.;LJB2_LRT_Pred=.;LJB2_MutationTaster=.;LJB2_MutationTaster_Pred=.;LJB_MutationAssessor=.;LJB_MutationAssessor_Pred=.;LJB2_FATHMM=.;LJB2_GERP++=.;LJB2_PhyloP=.;LJB2_SiPhy=.;ALLELE_END GT:GQ:DP:HQ 0|0:54:7:56,60 0|0:48:4:51,51 0/0:61:2:. +20 1230288 . T . 50 PASS NS=3;DP=13;AA=T;ANNOVAR_DATE=2015-06-17;Func.refGene=intronic;Gene.refGene=RAD21L1;GeneDetail.refGene=.;ExonicFunc.refGene=.;AAChange.refGene=.;Func.ensGene=intronic;Gene.ensGene=ENSG00000244588;GeneDetail.ensGene=.;ExonicFunc.ensGene=.;AAChange.ensGene=.;esp6500si_ea=.;esp6500si_all=.;1000g2012apr_eur=.;1000g2012apr_all=.;snp138=.;LJB2_SIFT=.;LJB2_PolyPhen2_HDIV=.;LJB2_PP2_HDIV_Pred=.;LJB2_PolyPhen2_HVAR=.;LJB2_PolyPhen2_HVAR_Pred=.;LJB2_LRT=.;LJB2_LRT_Pred=.;LJB2_MutationTaster=.;LJB2_MutationTaster_Pred=.;LJB_MutationAssessor=.;LJB_MutationAssessor_Pred=.;LJB2_FATHMM=.;LJB2_GERP++=.;LJB2_PhyloP=.;LJB2_SiPhy=.;ALLELE_END GT:GQ:DP:HQ 0|0:54:7:56,60 0|0:48:4:51,51 0/0:61:2:. diff --git a/test/view.filter.annovar.2.out b/test/view.filter.annovar.2.out new file mode 100644 index 000000000..6ac94a101 --- /dev/null +++ b/test/view.filter.annovar.2.out @@ -0,0 +1 @@ +16 50745926 rs2066844 C T 80 PASS NS=3;DP=14;AF=0.5;DB;H2;ANNOVAR_DATE=2015-06-17;Func.refGene=exonic;Gene.refGene=NOD2;GeneDetail.refGene=.;ExonicFunc.refGene=nonsynonymous_SNV;AAChange.refGene=NOD2:NM_001293557:exon3:c.C2023T:p.R675W,NOD2:NM_022162:exon4:c.C2104T:p.R702W;Func.ensGene=exonic;Gene.ensGene=ENSG00000167207;GeneDetail.ensGene=.;ExonicFunc.ensGene=nonsynonymous_SNV;AAChange.ensGene=ENSG00000167207:ENST00000300589:exon4:c.C2104T:p.R702W;esp6500si_ea=0.043488;esp6500si_all=0.031558;1000g2012apr_eur=0.05;1000g2012apr_all=0.02;snp138=rs2066844;LJB2_SIFT=0.010000;LJB2_PolyPhen2_HDIV=0.999;LJB2_PP2_HDIV_Pred=D;LJB2_PolyPhen2_HVAR=0.901;LJB2_PolyPhen2_HVAR_Pred=P;LJB2_LRT=0.993490;LJB2_LRT_Pred=N;LJB2_MutationTaster=0.291000;LJB2_MutationTaster_Pred=N;LJB_MutationAssessor=2.32;LJB_MutationAssessor_Pred=medium;LJB2_FATHMM=-0.5;LJB2_GERP++=3.66;LJB2_PhyloP=1.421000;LJB2_SiPhy=6.9139;ALLELE_END GT:GQ:DP:HQ 0|0:48:1:51,51 1|0:48:8:51,51 1/1:43:5:.,. diff --git a/test/view.filter.annovar.3.out b/test/view.filter.annovar.3.out new file mode 100644 index 000000000..6ac94a101 --- /dev/null +++ b/test/view.filter.annovar.3.out @@ -0,0 +1 @@ +16 50745926 rs2066844 C T 80 PASS NS=3;DP=14;AF=0.5;DB;H2;ANNOVAR_DATE=2015-06-17;Func.refGene=exonic;Gene.refGene=NOD2;GeneDetail.refGene=.;ExonicFunc.refGene=nonsynonymous_SNV;AAChange.refGene=NOD2:NM_001293557:exon3:c.C2023T:p.R675W,NOD2:NM_022162:exon4:c.C2104T:p.R702W;Func.ensGene=exonic;Gene.ensGene=ENSG00000167207;GeneDetail.ensGene=.;ExonicFunc.ensGene=nonsynonymous_SNV;AAChange.ensGene=ENSG00000167207:ENST00000300589:exon4:c.C2104T:p.R702W;esp6500si_ea=0.043488;esp6500si_all=0.031558;1000g2012apr_eur=0.05;1000g2012apr_all=0.02;snp138=rs2066844;LJB2_SIFT=0.010000;LJB2_PolyPhen2_HDIV=0.999;LJB2_PP2_HDIV_Pred=D;LJB2_PolyPhen2_HVAR=0.901;LJB2_PolyPhen2_HVAR_Pred=P;LJB2_LRT=0.993490;LJB2_LRT_Pred=N;LJB2_MutationTaster=0.291000;LJB2_MutationTaster_Pred=N;LJB_MutationAssessor=2.32;LJB_MutationAssessor_Pred=medium;LJB2_FATHMM=-0.5;LJB2_GERP++=3.66;LJB2_PhyloP=1.421000;LJB2_SiPhy=6.9139;ALLELE_END GT:GQ:DP:HQ 0|0:48:1:51,51 1|0:48:8:51,51 1/1:43:5:.,. diff --git a/test/view.filter.annovar.vcf b/test/view.filter.annovar.vcf new file mode 100644 index 000000000..7613667ad --- /dev/null +++ b/test/view.filter.annovar.vcf @@ -0,0 +1,52 @@ +##fileformat=VCFv4.0 +##fileDate=20090805 +##source=myImputationProgramV3.1 +##reference=1000GenomesPilot-NCBI36 +##phasing=partial +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##FILTER= +##FILTER= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +#CHROM POS ID REF ALT QUAL FILTER INFO FORMAT NA00001 NA00002 NA00003 +16 50745926 rs2066844 C T 80 PASS NS=3;DP=14;AF=0.5;DB;H2;ANNOVAR_DATE=2015-06-17;Func.refGene=exonic;Gene.refGene=NOD2;GeneDetail.refGene=.;ExonicFunc.refGene=nonsynonymous_SNV;AAChange.refGene=NOD2:NM_001293557:exon3:c.C2023T:p.R675W,NOD2:NM_022162:exon4:c.C2104T:p.R702W;Func.ensGene=exonic;Gene.ensGene=ENSG00000167207;GeneDetail.ensGene=.;ExonicFunc.ensGene=nonsynonymous_SNV;AAChange.ensGene=ENSG00000167207:ENST00000300589:exon4:c.C2104T:p.R702W;esp6500si_ea=0.043488;esp6500si_all=0.031558;1000g2012apr_eur=0.05;1000g2012apr_all=0.02;snp138=rs2066844;LJB2_SIFT=0.010000;LJB2_PolyPhen2_HDIV=0.999;LJB2_PP2_HDIV_Pred=D;LJB2_PolyPhen2_HVAR=0.901;LJB2_PolyPhen2_HVAR_Pred=P;LJB2_LRT=0.993490;LJB2_LRT_Pred=N;LJB2_MutationTaster=0.291000;LJB2_MutationTaster_Pred=N;LJB_MutationAssessor=2.32;LJB_MutationAssessor_Pred=medium;LJB2_FATHMM=-0.5;LJB2_GERP++=3.66;LJB2_PhyloP=1.421000;LJB2_SiPhy=6.9139;ALLELE_END GT:GQ:DP:HQ 0|0:48:1:51,51 1|0:48:8:51,51 1/1:43:5:.,. +20 1230237 . T G 47 PASS NS=3;DP=13;AA=T;ANNOVAR_DATE=2015-06-17;Func.refGene=intronic;Gene.refGene=RAD21L1;GeneDetail.refGene=.;ExonicFunc.refGene=.;AAChange.refGene=.;Func.ensGene=intronic;Gene.ensGene=ENSG00000244588;GeneDetail.ensGene=.;ExonicFunc.ensGene=.;AAChange.ensGene=.;esp6500si_ea=.;esp6500si_all=.;1000g2012apr_eur=.;1000g2012apr_all=.;snp138=.;LJB2_SIFT=.;LJB2_PolyPhen2_HDIV=.;LJB2_PP2_HDIV_Pred=.;LJB2_PolyPhen2_HVAR=.;LJB2_PolyPhen2_HVAR_Pred=.;LJB2_LRT=.;LJB2_LRT_Pred=.;LJB2_MutationTaster=.;LJB2_MutationTaster_Pred=.;LJB_MutationAssessor=.;LJB_MutationAssessor_Pred=.;LJB2_FATHMM=.;LJB2_GERP++=.;LJB2_PhyloP=.;LJB2_SiPhy=.;ALLELE_END GT:GQ:DP:HQ 0|0:54:7:56,60 0|0:48:4:51,51 0/0:61:2 +20 1230288 . T . 50 PASS NS=3;DP=13;AA=T;ANNOVAR_DATE=2015-06-17;Func.refGene=intronic;Gene.refGene=RAD21L1;GeneDetail.refGene=.;ExonicFunc.refGene=.;AAChange.refGene=.;Func.ensGene=intronic;Gene.ensGene=ENSG00000244588;GeneDetail.ensGene=.;ExonicFunc.ensGene=.;AAChange.ensGene=.;esp6500si_ea=.;esp6500si_all=.;1000g2012apr_eur=.;1000g2012apr_all=.;snp138=.;LJB2_SIFT=.;LJB2_PolyPhen2_HDIV=.;LJB2_PP2_HDIV_Pred=.;LJB2_PolyPhen2_HVAR=.;LJB2_PolyPhen2_HVAR_Pred=.;LJB2_LRT=.;LJB2_LRT_Pred=.;LJB2_MutationTaster=.;LJB2_MutationTaster_Pred=.;LJB_MutationAssessor=.;LJB_MutationAssessor_Pred=.;LJB2_FATHMM=.;LJB2_GERP++=.;LJB2_PhyloP=.;LJB2_SiPhy=.;ALLELE_END GT:GQ:DP:HQ 0|0:54:7:56,60 0|0:48:4:51,51 0/0:61:2 From aa6bc176a7abfbabb1d16b9b7aae06dd9445124c Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Thu, 22 Oct 2015 09:55:45 +0100 Subject: [PATCH 097/211] add test for consensus on empty vcf file this is a test for #339 that was resolved in samtools/htslib@df3fcad84004434a9092c599aa0b1fe44c9e731a --- test/consensus.5.out | 20 ++++++++++++++++++++ test/test.pl | 1 + 2 files changed, 21 insertions(+) create mode 100644 test/consensus.5.out diff --git a/test/consensus.5.out b/test/consensus.5.out new file mode 100644 index 000000000..4631ebee2 --- /dev/null +++ b/test/consensus.5.out @@ -0,0 +1,20 @@ +>1:2-501 +TACCATATGTGACATATAAAAAAGAACATAACCTACGTATCAACTAAAGTGGTTGTTTGC +AGAAAAGGAAGACTTAAAAAGAGTCAGTACTAACCTACATAATATATACAATGTTCATTA +AATAATAAAATGAGCTCATCATACTTAGGTCATCATAAATATATCTGAAATTCACAAATA +TTGATCAAATGGTAAAATAGACAAGTAGATTTTAATAGGTTAAACAATTACTGATTCTCT +TGAAAGAATAAATTTAATATGAGACCTATTTCATTATAATGAACTCACAAATTAGAAACT +TCACACTGGGGGCTGGAGAGATGGCTCAGTAGTTAAGAACACTGACTGCTCTTCTGAAGG +TCCTGAGTTCAAATCCCAGCAACCACATGGTGACTTACAACCATCTGTAATGACATCTGA +TGCCCTCTGGTGTGTCTGAAGACAGCTACAGTGTACTTACATAAAATAATAAATAAATCT +TTAAAAACAAAAAAAAAGAA +>2 +GAAGATCTTTTCCTTATTAAGGATCTGAAGCTCTGTAGATTTGTATTCTATTAAACATGG +AGAGATTAGTGATTTTCCATATTCTTTAAGTCATTTTAGAGTAATGTGTTCTTAAGATAA +ATCAGAAAAACAAAAACTTGTGCTTTCCTGTTTGAAAAACAAACAGCTGTGGGGAATGGT +GTCGGGACAGCCTTTTTATAAAATTTTTCTAAATAATGTTGAGGCTTTGATACGTCAAAG +TTATATTTCAAATGGAATCACTTAGACCTCGTTTCTGAGTGTCAATGGCCATATTGGGGA +TTTGCTGCTGCCAATGACAGCACACCCTGGGAATGCCCCAACTACTTACTACAAAGCAGT +GTTACATGGAGAAGATCTTCAAGAGTCTTTTTGCTAGATCTTTCCTTGGCTTTTGATGTG +ACTCCTCTCAATAAAATCCACAGTAATATAGTGAGTGGTCTCCTGCTCCAAACCAGTATT +TCAGACACAGTTAATCCAGAC diff --git a/test/test.pl b/test/test.pl index c3819fd58..a845bf47b 100755 --- a/test/test.pl +++ b/test/test.pl @@ -221,6 +221,7 @@ test_vcf_consensus_chain($opts,in=>'consensus',out=>'consensus.4.chain',chain=>'consensus.4.chain',fa=>'consensus.fa',args=>'-H 1'); test_vcf_consensus($opts,in=>'consensus2',out=>'consensus2.1.out',fa=>'consensus2.fa',args=>'-H 1'); test_vcf_consensus($opts,in=>'consensus2',out=>'consensus2.2.out',fa=>'consensus2.fa',args=>'-H 2'); +test_vcf_consensus($opts,in=>'empty',out=>'consensus.5.out',fa=>'consensus.fa',args=>''); print "\nNumber of tests:\n"; printf " total .. %d\n", $$opts{nok}+$$opts{nfailed}; From f6831b591a1abdfa09e28341041efd4e1862bad3 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Wed, 21 Oct 2015 14:05:49 +0100 Subject: [PATCH 098/211] norm: Expand round buffer if needed. Fixes #336 add test thanks to @wangyugui and @wkretzsch --- test/norm.split.2.out | 107 ++++++++++++++++++++++++++++++++++++++++++ test/norm.split.2.vcf | 85 +++++++++++++++++++++++++++++++++ test/test.pl | 1 + vcfnorm.c | 6 ++- 4 files changed, 197 insertions(+), 2 deletions(-) create mode 100644 test/norm.split.2.out create mode 100644 test/norm.split.2.vcf diff --git a/test/norm.split.2.out b/test/norm.split.2.out new file mode 100644 index 000000000..52fcecde0 --- /dev/null +++ b/test/norm.split.2.out @@ -0,0 +1,107 @@ +##fileformat=VCFv4.2 +##FILTER= +##samtoolsVersion=1.2-216-gdffc67f-dirty+htslib-1.2.1-216-gd2ed7e6-dirty +##reference=file:///usr/bio-ref/GRCh38.81/GRCh38.fa +##contig= +#CHROM POS ID REF ALT QUAL FILTER INFO +1 789241 . C G 41.4503 . . +1 789262 . G A 36.0809 . . +1 789280 . T C 40.0265 . . +1 789334 . A T 67 . . +1 789348 . T A 44.5622 . . +1 789368 . A T 18.5381 . . +1 789369 . C T 30.0396 . . +1 789396 . A C 35.7056 . . +1 789402 . G T 35.0554 . . +1 789403 . T A 35.0681 . . +1 789417 . T G 35.0681 . . +1 789420 . T A 35.0681 . . +1 789429 . A C 39.1119 . . +1 789435 . C T 35.1179 . . +1 789481 . G A 94 . . +1 789489 . C A 89 . . +1 789491 . C G 100 . . +1 789568 . TATGGAATGGAATGGAATGGAATG TATGGAATGGAATGGAATG 295 . . +1 789631 . G A 3.18972 . . +1 789642 . T G 3.66362 . . +1 789660 . C T 35.0294 . . +1 789666 . T G 16.1313 . . +1 789673 . A T 52 . . +1 789675 . T G 20.7408 . . +1 789676 . C T 26.6621 . . +1 789680 . A T 21.5713 . . +1 789680 . AGGAATGGAATGGAATGGAATGGAATGGAATGGAATGGAATGGACTCGAATGGAATGGAATGGAATG AGGAATGGAATGGAATGGAATGGAATGGAATGGAATGGAATGGAATGGAATGGACTCGAATGGAATGGAATGGAATG 23.495 . . +1 789685 . T G 6.53871 . . +1 789690 . T G 16.2287 . . +1 789690 . T C 16.2287 . . +1 789691 . G T 21.8633 . . +1 789691 . G C 21.8633 . . +1 789692 . G A 31.8203 . . +1 789695 . T A 7.03922 . . +1 789696 . G A 64 . . +1 789696 . G T 64 . . +1 789696 . G C 64 . . +1 789697 . G A 116 . . +1 789700 . T A 27.3447 . . +1 789700 . T G 27.3447 . . +1 789704 . A C 12.9378 . . +1 789704 . A T 12.9378 . . +1 789704 . A G 12.9378 . . +1 789706 . G C 4.49441 . . +1 789706 . G A 4.49441 . . +1 789707 . G C 6.28796 . . +1 789707 . G A 6.28796 . . +1 789710 . T G 59 . . +1 789710 . T A 59 . . +1 789711 . G T 15.1544 . . +1 789713 . A C 6.69714 . . +1 789717 . G A 82 . . +1 789720 . T G 26.241 . . +1 789721 . G A 99 . . +1 789721 . G T 99 . . +1 789727 . G A 5.18898 . . +1 789727 . G C 5.18898 . . +1 789730 . T A 73 . . +1 789730 . T C 73 . . +1 789731 . G T 111 . . +1 789732 . G T 24.8095 . . +1 789735 . T G 61 . . +1 789737 . G T 69 . . +1 789737 . G A 69 . . +1 789739 . A T 48.5355 . . +1 789740 . T A 29.8166 . . +1 789747 . A G 187 . . +1 789747 . A C 187 . . +1 789747 . A T 187 . . +1 789749 . C G 19.1565 . . +1 789750 . T A 12.5086 . . +1 789750 . T C 12.5086 . . +1 789752 . C G 284 . . +1 789757 . G A 7.13117 . . +1 789765 . T A 191 . . +1 789767 . G A 16.2222 . . +1 789769 . C T 17.4827 . . +1 789770 . T G 64 . . +1 789770 . T A 64 . . +1 789772 . G A 31.6793 . . +1 789772 . G C 31.6793 . . +1 789775 . T A 125 . . +1 789775 . T G 125 . . +1 789776 . A G 151 . . +1 789777 . G C 22.9639 . . +1 789781 . G A 89 . . +1 789795 . A T 11.555 . . +1 789816 . G A 29.3537 . . +1 789957 . C G 19.4796 . . +1 790009 . C T 55 . . +1 790136 . A G 85 . . +1 790156 . G A 19.4198 . . +1 790176 . A G 86 . . +1 790179 . C T 4.20807 . . +1 790181 . C T 12.5149 . . +1 790186 . G A 86 . . +1 790189 . T A 76 . . +1 790202 . G A 86 . . +1 790202 . G C 86 . . +1 790206 . C A 18.4041 . . +1 790206 . C T 18.4041 . . diff --git a/test/norm.split.2.vcf b/test/norm.split.2.vcf new file mode 100644 index 000000000..b8147fc8e --- /dev/null +++ b/test/norm.split.2.vcf @@ -0,0 +1,85 @@ +##fileformat=VCFv4.2 +##FILTER= +##samtoolsVersion=1.2-216-gdffc67f-dirty+htslib-1.2.1-216-gd2ed7e6-dirty +##reference=file:///usr/bio-ref/GRCh38.81/GRCh38.fa +##contig= +#CHROM POS ID REF ALT QUAL FILTER +1 789241 . C G 41.4503 . +1 789262 . G A 36.0809 . +1 789280 . T C 40.0265 . +1 789334 . A T 67 . +1 789348 . T A 44.5622 . +1 789368 . A T 18.5381 . +1 789369 . C T 30.0396 . +1 789396 . A C 35.7056 . +1 789402 . G T 35.0554 . +1 789403 . T A 35.0681 . +1 789417 . T G 35.0681 . +1 789420 . T A 35.0681 . +1 789429 . A C 39.1119 . +1 789435 . C T 35.1179 . +1 789481 . G A 94 . +1 789489 . C A 89 . +1 789491 . C G 100 . +1 789568 . TATGGAATGGAATGGAATGGAATG TATGGAATGGAATGGAATG 295 . +1 789631 . G A 3.18972 . +1 789642 . T G 3.66362 . +1 789660 . C T 35.0294 . +1 789666 . T G 16.1313 . +1 789673 . A T 52 . +1 789675 . T G 20.7408 . +1 789676 . C T 26.6621 . +1 789680 . A T 21.5713 . +1 789680 . AGGAATGGAATGGAATGGAATGGAATGGAATGGAATGGAATGGACTCGAATGGAATGGAATGGAATG AGGAATGGAATGGAATGGAATGGAATGGAATGGAATGGAATGGAATGGAATGGACTCGAATGGAATGGAATGGAATG 23.495 . +1 789685 . T G 6.53871 . +1 789690 . T G,C 16.2287 . +1 789691 . G T,C 21.8633 . +1 789692 . G A 31.8203 . +1 789695 . T A 7.03922 . +1 789696 . G A,T,C 64 . +1 789697 . G A 116 . +1 789700 . T A,G 27.3447 . +1 789704 . A C,T,G 12.9378 . +1 789706 . G C,A 4.49441 . +1 789707 . G C,A 6.28796 . +1 789710 . T G,A 59 . +1 789711 . G T 15.1544 . +1 789713 . A C 6.69714 . +1 789717 . G A 82 . +1 789720 . T G 26.241 . +1 789721 . G A,T 99 . +1 789727 . G A,C 5.18898 . +1 789730 . T A,C 73 . +1 789731 . G T 111 . +1 789732 . G T 24.8095 . +1 789735 . T G 61 . +1 789737 . G T,A 69 . +1 789739 . A T 48.5355 . +1 789740 . T A 29.8166 . +1 789747 . A G,C,T 187 . +1 789749 . C G 19.1565 . +1 789750 . T A,C 12.5086 . +1 789752 . C G 284 . +1 789757 . G A 7.13117 . +1 789765 . T A 191 . +1 789767 . G A 16.2222 . +1 789769 . C T 17.4827 . +1 789770 . T G,A 64 . +1 789772 . G A,C 31.6793 . +1 789775 . T A,G 125 . +1 789776 . A G 151 . +1 789777 . G C 22.9639 . +1 789781 . G A 89 . +1 789795 . A T 11.555 . +1 789816 . G A 29.3537 . +1 789957 . C G 19.4796 . +1 790009 . C T 55 . +1 790136 . A G 85 . +1 790156 . G A 19.4198 . +1 790176 . A G 86 . +1 790179 . C T 4.20807 . +1 790181 . C T 12.5149 . +1 790186 . G A 86 . +1 790189 . T A 76 . +1 790202 . G A,C 86 . +1 790206 . C A,T 18.4041 . \ No newline at end of file diff --git a/test/test.pl b/test/test.pl index a845bf47b..2c56e0aea 100755 --- a/test/test.pl +++ b/test/test.pl @@ -92,6 +92,7 @@ test_vcf_query($opts,in=>'annotate2',out=>'query.21.out',args=>q[-e'IFLT="."' -f'%POS %IFLT\\n']); test_vcf_norm($opts,in=>'norm',out=>'norm.out',fai=>'norm'); test_vcf_norm($opts,in=>'norm.split',out=>'norm.split.out',args=>'-m-'); +test_vcf_norm($opts,in=>'norm.split.2',out=>'norm.split.2.out',args=>'-m-'); test_vcf_norm($opts,in=>'norm.split',fai=>'norm',out=>'norm.split.and.norm.out',args=>'-m-'); test_vcf_norm($opts,in=>'norm.merge',out=>'norm.merge.out',args=>'-m+'); test_vcf_norm($opts,in=>'norm.merge.2',out=>'norm.merge.2.out',args=>'-m+'); diff --git a/vcfnorm.c b/vcfnorm.c index 9135430f5..9bffddbb3 100644 --- a/vcfnorm.c +++ b/vcfnorm.c @@ -75,7 +75,7 @@ typedef struct struct { int tot, set, swap; } nref; char **argv, *output_fname, *ref_fname, *vcf_fname, *region, *targets; int argc, rmdup, output_type, check_ref, strict_filter, do_indels; - int nchanged, nskipped, ntotal, mrows_op, mrows_collapse, parsimonious; + int nchanged, nskipped, nsplit, ntotal, mrows_op, mrows_collapse, parsimonious; } args_t; @@ -1564,6 +1564,7 @@ static void normalize_line(args_t *args, bcf1_t **line_ptr) } // insert into sorted buffer + rbuf_expand0(&args->rbuf,bcf1_t*,args->rbuf.n+1,args->lines); int i,j; i = j = rbuf_append(&args->rbuf); if ( !args->lines[i] ) args->lines[i] = bcf_init1(); @@ -1620,6 +1621,7 @@ static void normalize_vcf(args_t *args) } if ( split && line->n_allele>2 ) { + args->nsplit++; split_multiallelic_to_biallelics(args, line); for (j=0; jntmp_lines; j++) normalize_line(args, &args->tmp_lines[j]); @@ -1644,7 +1646,7 @@ static void normalize_vcf(args_t *args) flush_buffer(args, out, args->rbuf.n); hts_close(out); - fprintf(stderr,"Lines total/modified/skipped:\t%d/%d/%d\n", args->ntotal,args->nchanged,args->nskipped); + fprintf(stderr,"Lines total/split/realigned/skipped:\t%d/%d/%d/%d\n", args->ntotal,args->nsplit,args->nchanged,args->nskipped); if ( args->check_ref & CHECK_REF_FIX ) fprintf(stderr,"REF/ALT total/modified/added: \t%d/%d/%d\n", args->nref.tot,args->nref.swap,args->nref.set); } From 983067a2646d82baeb4f869e8014f6ca63fd477e Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Tue, 6 Oct 2015 09:42:34 +0100 Subject: [PATCH 099/211] cnv: New -k option, fixed non-functional parsing of -dfloat,float --- main.c | 2 +- vcfcnv.c | 56 +++++++++++++++++++++++++++++++++++++++----------------- 2 files changed, 40 insertions(+), 18 deletions(-) diff --git a/main.c b/main.c index 599503323..f08b5c7e1 100644 --- a/main.c +++ b/main.c @@ -138,7 +138,7 @@ static cmd_t cmds[] = }, { .func = main_vcfcnv, .alias = "cnv", - .help = "-HMM CNV calling" // do not advertise yet + .help = "HMM CNV calling" }, { .func = main_vcffilter, .alias = "filter", diff --git a/vcfcnv.c b/vcfcnv.c index a9dfb7fb0..c286d4744 100644 --- a/vcfcnv.c +++ b/vcfcnv.c @@ -61,7 +61,7 @@ typedef struct { char *name; int idx; // VCF sample index - float *lrr,*baf, baf_dev2, baf_dev2_dflt; + float *lrr,*baf, baf_dev2, baf_dev2_dflt, lrr_dev2; float cell_frac, cell_frac_dflt; gauss_param_t gauss_param[18]; double pobs[N_STATES]; @@ -78,7 +78,6 @@ typedef struct _args_t sample_t query_sample, control_sample; int nstates; // number of states: N_STATES for one sample, N_STATES^2 for two samples - double lrr_dev2; // squared std dev of LRR distribution double lrr_bias, baf_bias; // LRR/BAF weights double same_prob, ij_prob; // prior of both samples being the same and the transition probability P(i|j) double err_prob; // constant probability of erroneous measurement @@ -608,7 +607,7 @@ static inline double norm_prob(double baf, gauss_param_t *param) static int set_observed_prob(args_t *args, sample_t *smpl, int isite) { float baf = smpl->baf[isite]; - float lrr = smpl->lrr[isite]; + float lrr = args->lrr_bias>0 ? smpl->lrr[isite] : 0; float fRR = args->fRR; float fRA = args->fRA; @@ -645,9 +644,9 @@ static int set_observed_prob(args_t *args, sample_t *smpl, int isite) if ( args->verbose ) fprintf(stderr,"%f\t%f %f %f\n", baf,cn1_baf,cn2_baf,cn3_baf); #endif - double cn1_lrr = exp(-(lrr + 0.45)*(lrr + 0.45)/args->lrr_dev2); - double cn2_lrr = exp(-(lrr - 0.00)*(lrr - 0.00)/args->lrr_dev2); - double cn3_lrr = exp(-(lrr - 0.30)*(lrr - 0.30)/args->lrr_dev2); + double cn1_lrr = exp(-(lrr + 0.45)*(lrr + 0.45)/smpl->lrr_dev2); + double cn2_lrr = exp(-(lrr - 0.00)*(lrr - 0.00)/smpl->lrr_dev2); + double cn3_lrr = exp(-(lrr - 0.30)*(lrr - 0.30)/smpl->lrr_dev2); smpl->pobs[CN0] = 0; smpl->pobs[CN1] = args->err_prob + (1 - args->baf_bias + args->baf_bias*cn1_baf)*(1 - args->lrr_bias + args->lrr_bias*cn1_lrr); @@ -915,8 +914,11 @@ static void cnv_flush_viterbi(args_t *args) hmm_set_tprob(args->hmm, args->tprob, 10000); // Smooth LRR values to reduce noise - smooth_data(args->query_sample.lrr,args->nsites, args->lrr_smooth_win); - if ( args->control_sample.name ) smooth_data(args->control_sample.lrr,args->nsites, args->lrr_smooth_win); + if ( args->lrr_bias > 0 ) + { + smooth_data(args->query_sample.lrr,args->nsites, args->lrr_smooth_win); + if ( args->control_sample.name ) smooth_data(args->control_sample.lrr,args->nsites, args->lrr_smooth_win); + } // Set the BAF peak likelihoods, such as P(RRR|CN3), taking account the // estimated fraction of aberrant cells in the mixture. With the new chromosome, @@ -1063,8 +1065,13 @@ static int parse_lrr_baf(sample_t *smpl, bcf_fmt_t *baf_fmt, bcf_fmt_t *lrr_fmt, *baf = ((float*)(baf_fmt->p + baf_fmt->size*smpl->idx))[0]; if ( bcf_float_is_missing(*baf) || isnan(*baf) ) *baf = -0.1; // arbitrary negative value == missing value - *lrr = ((float*)(lrr_fmt->p + lrr_fmt->size*smpl->idx))[0]; - if ( bcf_float_is_missing(*lrr) || isnan(*lrr) ) { *lrr = 0; *baf = -0.1; } + if ( lrr_fmt ) + { + *lrr = ((float*)(lrr_fmt->p + lrr_fmt->size*smpl->idx))[0]; + if ( bcf_float_is_missing(*lrr) || isnan(*lrr) ) { *lrr = 0; *baf = -0.1; } + } + else + *lrr = 0; return *baf<0 ? 0 : 1; } @@ -1092,9 +1099,9 @@ static void cnv_next_line(args_t *args, bcf1_t *line) // Process line args->ntot++; - bcf_fmt_t *baf_fmt, *lrr_fmt; + bcf_fmt_t *baf_fmt, *lrr_fmt = NULL; if ( !(baf_fmt = bcf_get_fmt(args->hdr, line, "BAF")) ) return; - if ( !(lrr_fmt = bcf_get_fmt(args->hdr, line, "LRR")) ) return; + if ( args->lrr_bias>0 && !(lrr_fmt = bcf_get_fmt(args->hdr, line, "LRR")) ) return; float baf1,lrr1,baf2,lrr2; int ret = 0; @@ -1168,6 +1175,7 @@ static void usage(args_t *args) fprintf(stderr, " -b, --BAF-weight relative contribution from BAF [1]\n"); fprintf(stderr, " -d, --BAF-dev expected BAF deviation in query and control [0.04,0.04]\n"); // experimental fprintf(stderr, " -e, --err-prob uniform error probability [1e-4]\n"); + fprintf(stderr, " -k, --LRR-dev expected LRR deviation [0.2,0.2]\n"); // experimental fprintf(stderr, " -l, --LRR-weight relative contribution from LRR [0.2]\n"); fprintf(stderr, " -L, --LRR-smooth-win window of LRR moving average smoothing [10]\n"); fprintf(stderr, " -O, --optimize estimate fraction of aberrant cells down to [1.0]\n"); @@ -1201,12 +1209,13 @@ int main_vcfcnv(int argc, char *argv[]) // Squared std dev of BAF and LRR values (gaussian noise), estimated from real data (hets, one sample, one chr) args->query_sample.baf_dev2_dflt = args->control_sample.baf_dev2_dflt = 0.04*0.04; // illumina: 0.03 - args->lrr_dev2 = 0.1*0.1; //0.20*0.20; // illumina: 0.18 + args->query_sample.lrr_dev2 = args->control_sample.lrr_dev2 = 0.2*0.2; //0.20*0.20; // illumina: 0.18 int regions_is_file = 0, targets_is_file = 0; static struct option loptions[] = { {"BAF-dev",1,0,'d'}, + {"LRR-dev",1,0,'k'}, {"LRR-smooth-win",1,0,'L'}, {"AF-file",1,0,'f'}, {"baum-welch",1,0,'W'}, // hidden @@ -1228,7 +1237,7 @@ int main_vcfcnv(int argc, char *argv[]) {0,0,0,0} }; char *tmp = NULL; - while ((c = getopt_long(argc, argv, "h?r:R:t:T:s:o:p:l:T:c:b:P:x:e:O:W:f:a:L:d:",loptions,NULL)) >= 0) { + while ((c = getopt_long(argc, argv, "h?r:R:t:T:s:o:p:l:T:c:b:P:x:e:O:W:f:a:L:d:k:",loptions,NULL)) >= 0) { switch (c) { case 'L': args->lrr_smooth_win = strtol(optarg,&tmp,10); @@ -1244,20 +1253,33 @@ int main_vcfcnv(int argc, char *argv[]) if ( *tmp ) { if ( *tmp!=',') error("Could not parse: -d %s\n", optarg); - args->control_sample.baf_dev2_dflt = strtod(optarg,&tmp); - if ( *tmp ) error("Could not parse: -a %s\n", optarg); + args->control_sample.baf_dev2_dflt = strtod(tmp+1,&tmp); + if ( *tmp ) error("Could not parse: -d %s\n", optarg); } else args->control_sample.baf_dev2_dflt = args->query_sample.baf_dev2_dflt; args->query_sample.baf_dev2_dflt *= args->query_sample.baf_dev2_dflt; args->control_sample.baf_dev2_dflt *= args->control_sample.baf_dev2_dflt; break; + case 'k': + args->query_sample.lrr_dev2 = strtod(optarg,&tmp); + if ( *tmp ) + { + if ( *tmp!=',') error("Could not parse: -k %s\n", optarg); + args->control_sample.lrr_dev2 = strtod(tmp+1,&tmp); + if ( *tmp ) error("Could not parse: -d %s\n", optarg); + } + else + args->control_sample.lrr_dev2 = args->query_sample.lrr_dev2; + args->query_sample.lrr_dev2 *= args->query_sample.lrr_dev2; + args->control_sample.lrr_dev2 *= args->control_sample.lrr_dev2; + break; case 'a': args->query_sample.cell_frac_dflt = strtod(optarg,&tmp); if ( *tmp ) { if ( *tmp!=',') error("Could not parse: -a %s\n", optarg); - args->control_sample.cell_frac_dflt = strtod(optarg,&tmp); + args->control_sample.cell_frac_dflt = strtod(tmp+1,&tmp); if ( *tmp ) error("Could not parse: -a %s\n", optarg); } break; From 2fc54de889a241372f26ff41ee7b58989484ab6f Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Fri, 9 Oct 2015 08:29:01 +0100 Subject: [PATCH 100/211] CNV output include number of sites/hets in regions --- vcfcnv.c | 40 +++++++++++++++++++++++++++++++--------- 1 file changed, 31 insertions(+), 9 deletions(-) diff --git a/vcfcnv.c b/vcfcnv.c index c286d4744..5fbdf2a6b 100644 --- a/vcfcnv.c +++ b/vcfcnv.c @@ -216,7 +216,7 @@ static void init_sample_files(sample_t *smpl, char *dir) smpl->summary_fh = open_file(&smpl->summary_fname,"w","%s/summary.%s.tab",dir,smpl->name); fprintf(smpl->dat_fh,"# [1]Chromosome\t[2]Position\t[3]BAF\t[4]LRR\n"); fprintf(smpl->cn_fh,"# [1]Chromosome\t[2]Position\t[3]CN\t[4]P(CN0)\t[5]P(CN1)\t[6]P(CN2)\t[7]P(CN3)\n"); - fprintf(smpl->summary_fh,"# RG, Regions [2]Chromosome\t[3]Start\t[4]End\t[5]Copy Number state\t[6]Quality\n"); + fprintf(smpl->summary_fh,"# RG, Regions [2]Chromosome\t[3]Start\t[4]End\t[5]Copy Number state\t[6]Quality\t[7]nSites\t[8]nHETs\n"); } static void close_sample_files(sample_t *smpl) { @@ -286,12 +286,13 @@ static void init_data(args_t *args) for (i=1; iargc; i++) fprintf(fh, " %s",args->argv[i]); if ( args->control_sample.name ) fprintf(fh, "\n#\n" - "# RG, Regions\t[2]Chromosome\t[3]Start\t[4]End\t[5]Copy number:%s\t[6]Copy number:%s\t[7]Quality\n", + "# RG, Regions\t[2]Chromosome\t[3]Start\t[4]End\t[5]Copy number:%s\t[6]Copy number:%s\t[7]Quality" + "\t[8]nSites in (5)\t[9]nHETs in (5)\t[10]nSites in (6)\t[11]nHETs in(6)\n", args->query_sample.name,args->control_sample.name ); else fprintf(fh, "\n#\n" - "# RG, Regions\t[2]Chromosome\t[3]Start\t[4]End\t[5]Copy number:%s\t[6]Quality\n", + "# RG, Regions\t[2]Chromosome\t[3]Start\t[4]End\t[5]Copy number:%s\t[6]Quality\t[7]nSites\t[8]nHETs\n", args->query_sample.name ); } @@ -903,6 +904,9 @@ static int update_args(args_t *args) return converged ? 0 : 1; } +// for an approximate estimate of the number of het genotypes in a region +#define BAF_LIKELY_HET(val) (val)>0.25 && (val)<0.75 + static void cnv_flush_viterbi(args_t *args) { if ( !args->nsites ) return; @@ -995,6 +999,7 @@ static void cnv_flush_viterbi(args_t *args) uint8_t *vpath = hmm_get_viterbi_path(hmm); double qual = 0, *fwd = hmm_get_fwd_bwd_prob(hmm); int i,j, isite, start_cn = vpath[0], start_pos = args->sites[0], istart_pos = 0; + int ctrl_ntot = 0, smpl_ntot = 0, ctrl_nhet = 0, smpl_nhet = 0; for (isite=0; isitensites; isite++) { int state = vpath[args->nstates*isite]; @@ -1016,6 +1021,11 @@ static void cnv_flush_viterbi(args_t *args) fprintf(args->query_sample.cn_fh, "\t%f", sum); } fprintf(args->query_sample.cn_fh, "\n"); + if ( args->query_sample.baf[isite]>=0 ) // if non-missing + { + if ( BAF_LIKELY_HET(args->query_sample.baf[isite]) ) smpl_nhet++; + smpl_ntot++; + } } if ( args->control_sample.cn_fh ) { @@ -1027,36 +1037,48 @@ static void cnv_flush_viterbi(args_t *args) fprintf(args->control_sample.cn_fh, "\t%f", sum); } fprintf(args->control_sample.cn_fh, "\n"); + if ( args->control_sample.baf[isite]>=0 ) // if non-missing + { + if ( BAF_LIKELY_HET(args->control_sample.baf[isite]) ) ctrl_nhet++; + ctrl_ntot++; + } } if ( start_cn != state ) { char start_cn_query = copy_number_state(args,start_cn,0); qual = phred_score(1 - qual/(isite - istart_pos)); - fprintf(args->query_sample.summary_fh,"RG\t%s\t%d\t%d\t%c\t%.1f\n",bcf_hdr_id2name(args->hdr,args->prev_rid), start_pos+1, args->sites[isite],start_cn_query,qual); + fprintf(args->query_sample.summary_fh,"RG\t%s\t%d\t%d\t%c\t%.1f\t%d\t%d\n", + bcf_hdr_id2name(args->hdr,args->prev_rid), start_pos+1, args->sites[isite],start_cn_query,qual,smpl_ntot,smpl_nhet); if ( args->control_sample.name ) { // regions 0-based, half-open char start_cn_ctrl = copy_number_state(args,start_cn,1); - fprintf(args->control_sample.summary_fh,"RG\t%s\t%d\t%d\t%c\t%.1f\n",bcf_hdr_id2name(args->hdr,args->prev_rid), start_pos+1, args->sites[isite],start_cn_ctrl,qual); - fprintf(args->summary_fh,"RG\t%s\t%d\t%d\t%c\t%c\t%.1f\n",bcf_hdr_id2name(args->hdr,args->prev_rid), start_pos+1, args->sites[isite],start_cn_query,start_cn_ctrl,qual); + fprintf(args->control_sample.summary_fh,"RG\t%s\t%d\t%d\t%c\t%.1f\t%d\t%d\n", + bcf_hdr_id2name(args->hdr,args->prev_rid), start_pos+1, args->sites[isite],start_cn_ctrl,qual,ctrl_ntot,ctrl_nhet); + fprintf(args->summary_fh,"RG\t%s\t%d\t%d\t%c\t%c\t%.1f\t%d\t%d\t%d\t%d\n", + bcf_hdr_id2name(args->hdr,args->prev_rid), start_pos+1, args->sites[isite],start_cn_query,start_cn_ctrl,qual,smpl_ntot,smpl_nhet,ctrl_ntot,ctrl_nhet); } istart_pos = isite; start_pos = args->sites[isite]; start_cn = state; qual = 0; + smpl_ntot = smpl_nhet = ctrl_ntot = ctrl_nhet = 0; } } qual = phred_score(1 - qual/(isite - istart_pos)); char start_cn_query = copy_number_state(args,start_cn,0); - fprintf(args->query_sample.summary_fh,"RG\t%s\t%d\t%d\t%c\t%.1f\n",bcf_hdr_id2name(args->hdr,args->prev_rid), start_pos+1, args->sites[isite-1]+1,start_cn_query,qual); + fprintf(args->query_sample.summary_fh,"RG\t%s\t%d\t%d\t%c\t%.1f\t%d\t%d\n", + bcf_hdr_id2name(args->hdr,args->prev_rid), start_pos+1, args->sites[isite-1]+1,start_cn_query,qual,smpl_ntot,smpl_nhet); if ( args->control_sample.name ) { char start_cn_ctrl = copy_number_state(args,start_cn,1); - fprintf(args->control_sample.summary_fh,"RG\t%s\t%d\t%d\t%c\t%.1f\n",bcf_hdr_id2name(args->hdr,args->prev_rid), start_pos+1, args->sites[isite-1]+1,start_cn_ctrl,qual); - fprintf(args->summary_fh,"RG\t%s\t%d\t%d\t%c\t%c\t%.1f\n",bcf_hdr_id2name(args->hdr,args->prev_rid), start_pos+1, args->sites[isite-1]+1,start_cn_query,start_cn_ctrl,qual); + fprintf(args->control_sample.summary_fh,"RG\t%s\t%d\t%d\t%c\t%.1f\t%d\t%d\n", + bcf_hdr_id2name(args->hdr,args->prev_rid), start_pos+1, args->sites[isite-1]+1,start_cn_ctrl,qual,ctrl_ntot,ctrl_nhet); + fprintf(args->summary_fh,"RG\t%s\t%d\t%d\t%c\t%c\t%.1f\t%d\t%d\t%d\t%d\n", + bcf_hdr_id2name(args->hdr,args->prev_rid), start_pos+1, args->sites[isite-1]+1,start_cn_query,start_cn_ctrl,qual,smpl_ntot,smpl_nhet,ctrl_ntot,ctrl_nhet); } } From e325cd0e46d3219bf556e0392c83bde8e7ffa1ef Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Wed, 21 Oct 2015 09:51:39 +0100 Subject: [PATCH 101/211] Reduce memory consumption in cnv plotting script --- vcfcnv.c | 47 ++++++++++++++++++++++------------------------- 1 file changed, 22 insertions(+), 25 deletions(-) diff --git a/vcfcnv.c b/vcfcnv.c index 5fbdf2a6b..e4b9372c9 100644 --- a/vcfcnv.c +++ b/vcfcnv.c @@ -433,24 +433,21 @@ static void create_plots(args_t *args) "else:\n" " plot_chroms = chroms_to_plot(args.plot_threshold)\n" "\n" - "def read_dat(file,dat):\n" + "def read_dat(file,dat,plot_chr):\n" " with open(file, 'rb') as f:\n" " reader = csv.reader(f, 'tab')\n" " for row in reader:\n" " chr = row[0]\n" - " if chr[0]=='#': continue\n" - " if chr not in plot_chroms: continue\n" - " if chr not in dat: dat[chr] = []\n" - " dat[chr].append([row[1], float(row[2]), float(row[3])])\n" - "def read_cnv(file,cnv):\n" + " if chr != plot_chr: continue\n" + " dat.append([row[1], float(row[2]), float(row[3])])\n" + "def read_cnv(file,cnv,plot_chr):\n" " with open(file, 'rb') as f:\n" " reader = csv.reader(f, 'tab')\n" " for row in reader:\n" " chr = row[0]\n" - " if chr[0]=='#': continue\n" - " if chr not in cnv: cnv[chr] = []\n" + " if chr != plot_chr: continue\n" " row[2] = int(row[2]) + 0.5\n" - " cnv[chr].append(row[1:])\n" + " cnv.append(row[1:])\n" "def find_diffs(a,b):\n" " out = []\n" " diff = []\n" @@ -465,20 +462,20 @@ static void create_plots(args_t *args) " if len(diff): out.append(diff)\n" " return out\n" "\n" - "control_dat = {}\n" - "control_cnv = {}\n" - "query_dat = {}\n" - "query_cnv = {}\n" - "read_dat('%s',control_dat)\n" - "read_dat('%s',query_dat)\n" - "read_cnv('%s',control_cnv)\n" - "read_cnv('%s',query_cnv)\n" + "for chr in sorted(plot_chroms.keys()):\n" + " control_dat = []\n" + " control_cnv = []\n" + " query_dat = []\n" + " query_cnv = []\n" + " read_dat('%s',control_dat,chr)\n" + " read_dat('%s',query_dat,chr)\n" + " read_cnv('%s',control_cnv,chr)\n" + " read_cnv('%s',query_cnv,chr)\n" "\n" - "for chr in query_dat:\n" " fig,(ax1,ax2,ax3,ax4,ax5,ax6) = plt.subplots(6,1,figsize=(10,8),sharex=True)\n" - " ax1.plot([x[0] for x in control_dat[chr]],[x[2] for x in control_dat[chr]], '.', ms=3,color='red')\n" - " ax2.plot([x[0] for x in control_dat[chr]],[x[1] for x in control_dat[chr]], '.', ms=3,color='red')\n" - " cn_dat = control_cnv[chr]\n" + " ax1.plot([x[0] for x in control_dat],[x[2] for x in control_dat], '.', ms=3,color='red')\n" + " ax2.plot([x[0] for x in control_dat],[x[1] for x in control_dat], '.', ms=3,color='red')\n" + " cn_dat = control_cnv\n" " xgrid = [float(x[0]) for x in cn_dat]\n" " ygrid = np.linspace(0,5,6)\n" " xgrid, ygrid = np.meshgrid(xgrid, ygrid)\n" @@ -492,9 +489,9 @@ static void create_plots(args_t *args) " mesh.set_clim(vmin=-1,vmax=1)\n" " ax3.plot([x[0] for x in cn_dat],[x[1] for x in cn_dat],'-',ms=3,color='black',lw=1.7)\n" "\n" - " ax6.plot([x[0] for x in query_dat[chr]],[x[2] for x in query_dat[chr]], '.', ms=3)\n" - " ax5.plot([x[0] for x in query_dat[chr]],[x[1] for x in query_dat[chr]], '.', ms=3)\n" - " cn_dat = query_cnv[chr]\n" + " ax6.plot([x[0] for x in query_dat],[x[2] for x in query_dat], '.', ms=3)\n" + " ax5.plot([x[0] for x in query_dat],[x[1] for x in query_dat], '.', ms=3)\n" + " cn_dat = query_cnv\n" " xgrid = [float(x[0]) for x in cn_dat]\n" " ygrid = np.linspace(0,5,6)\n" " xgrid, ygrid = np.meshgrid(xgrid, ygrid)\n" @@ -510,7 +507,7 @@ static void create_plots(args_t *args) " ax3.annotate(control_sample, xy=(0.02,0.1), xycoords='axes fraction', color='red',fontsize=12, va='bottom',ha='left')\n" " ax4.annotate(query_sample, xy=(0.02,0.9), xycoords='axes fraction', color='blue',fontsize=12, va='top',ha='left')\n" "\n" - " diffs = find_diffs(control_cnv[chr],query_cnv[chr])\n" + " diffs = find_diffs(control_cnv,query_cnv)\n" " for diff in diffs:\n" " ax3.plot([x[0] for x in diff],[x[1] for x in diff],'-',ms=3,color='blue',lw=1.7)\n" " ax4.plot([x[0] for x in diff],[x[2] for x in diff],'-',ms=3,color='red',lw=1.7)\n" From 3c4ddc79d6c8c5d99d5ef02c8d6d747692ef7fe9 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Thu, 22 Oct 2015 10:10:28 +0100 Subject: [PATCH 102/211] Added cnv and polysomy commands to the docs --- doc/bcftools.txt | 148 +++++++++++++++++++++++++++++++++++++++++++++++ 1 file changed, 148 insertions(+) diff --git a/doc/bcftools.txt b/doc/bcftools.txt index f485507f6..5fa963b1b 100644 --- a/doc/bcftools.txt +++ b/doc/bcftools.txt @@ -75,6 +75,7 @@ list of available options, run *bcftools* 'COMMAND' without arguments. - *<>* .. edit VCF files, add or remove annotations - *<>* .. SNP/indel calling (former "view") +- *<>* .. Copy Number Variation caller - *<>* .. concatenate VCF/BCF files from the same set of samples - *<>* .. create consensus sequence by applying VCF variants - *<>* .. convert VCF/BCF to other formats and back @@ -85,6 +86,7 @@ list of available options, run *bcftools* 'COMMAND' without arguments. - *<>* .. merge VCF/BCF files files from non-overlapping sample sets - *<>* .. normalize indels - *<>* .. run user-defined plugin +- *<>* .. detect contaminations and whole-chromosome aberrations - *<>* .. transform VCF/BCF into user-defined formats - *<>* .. modify VCF/BCF header, change sample names - *<>* .. identify runs of homo/auto-zygosity @@ -380,6 +382,91 @@ This command allows to add or remove annotations. bcftools annotate -a annots.bed.gz -h annots.hdr -c CHROM,FROM,TO,TAG input.vcf ---- +[[cnv]] +=== bcftools cnv '[OPTIONS]' 'FILE' + +Copy number variation caller, requires a VCF annotated with the Illumina's +B-allele frequency (BAF) and Log R Ratio intensity (LRR) values. The HMM +considers the following copy number states: CN 2 (normal), 1 (single-copy +loss), 0 (complete loss), 3 (single-copy gain). + + +==== General Options: + +*-c, --control-sample* 'string':: + optional control sample name. If given, pairwise calling is performed + and the *-P* option can be used + +*-f, --AF-file* 'file':: + read allele frequencies from a tab-delimited file with the columns CHR,POS,REF,ALT,AF + +*-o, --output-dir 'path':: + output directory + +*-p, --plot-threshold 'float':: + call *matplotlib* to produce plots for chromosomes with quality at least 'float', + useful for visual inspection of the calls. With *-p 0*, plots for all chromosomes will be + generated. If not given, a *matplotlib* script will be created but not called. + +*-r, --regions* 'chr'|'chr:pos'|'chr:from-to'|'chr:from-'[,...]:: + see *<>* + +*-R, --regions-file* 'file':: + see *<>* + +*-s, --query-sample* 'string':: + query samply name + +*-t, --targets* 'LIST':: + see *<>* + +*-T, --targets-file* 'FILE':: + see *<>* + +==== HMM Options: + +*-a, --aberrant* 'float'[,'float']:: + fraction of aberrant cells in query and control. The hallmark of + duplications and contaminations is the BAF value of heterozygous markers + which is dependent on the fraction of aberrant cells. Sensitivity to + smaller fractions of cells can be increased by setting *-a* to a lower value. Note + however, that this comes at the cost of increased false discovery rate. + +*-b, --BAF-weight* 'float':: + relative contribution from BAF + +*d, --BAF-dev* 'float'[,'float']:: + expected BAF deviation in query and control, i.e. the noise observed + in the data. + +*-e, --err-prob* 'float':: + uniform error probability + +*-l, --LRR-weight* 'float':: + relative contribution from LRR. With noisy data, this option can have big effect + on the number of calls produced. In truly random noise (such as in simulated data), + the value should be set high (1.0), but in the presence of systematic noise + when LRR are not informative, lower values result in cleaner calls (0.2). + +*-L, --LRR-smooth-win* 'int':: + reduce LRR noise by applying moving average given this window size + +*-O, --optimize* 'float':: + iteratively estimate the fraction of aberrant cells, down to the given fraction. + Lowering this value from the default 1.0 to say, 0.3, can help discover more + events but also increases noise + +*-P, --same-prob* 'float':: + the prior probability of the query and the control sample being the same. + Setting to 0 calls both independently, setting to 1 forces the same copy + number state in both. + +*-x, --xy-prob* 'float':: + the HMM probability of transition to another copy number state. Increasing this + values leads to smaller and more frequent calls. + + + [[call]] === bcftools call '[OPTIONS]' 'FILE' @@ -1290,6 +1377,67 @@ void destroy(void); ---- + +[[polysomy]] +=== bcftools polysomy ['OPTIONS'] 'file.vcf.gz' +Detect number of chromosomal copies in VCFs annotates with the Illumina's +B-allele frequency (BAF) values. Note that this command is not compiled +in by default, see the section *Optional Compilation with GSL* in the INSTALL +file for help. + +==== General options: + +*-o, --output-dir* 'path':: + output directory + +*-r, --regions* 'chr'|'chr:pos'|'chr:from-to'|'chr:from-'[,...]:: + see *<>* + +*-R, --regions-file* 'file':: + see *<>* + +*-s, --sample* 'string':: + samply name + +*-t, --targets* 'LIST':: + see *<>* + +*-T, --targets-file* 'FILE':: + see *<>* + +*-v, --verbose*:: + verbose debugging output which gives hints about the thresholds and decisions made + by the program. Note that the exact output can change between versions. + +==== Algorithm options: + +*-b, --peak-size* 'float':: + the minimum peak size considered as a good match can be from the interval [0,1] + where larger is stricter + +*-c, --cn-penalty* 'float':: + a penalty for increasing copy number state. How this works: multiple peaks + are always a better fit than a single peak, therefore the program prefers + a single peak (normal copy number) unless the absolute deviation of the + multiple peaks fit is significantly smaller. Here the meaning of + "significant" is given by the 'float' from the interval [0,1] where + larger is stricter. + +*-f, --fit-th* 'float':: + threshold for goodness of fit (normalized absolute deviation), smaller is stricter + +*-i, --include-aa*:: + include also the AA peak in CN2 and CN3 evaluation. This usually requires increasing *-f*. + +*-m, --min-fraction* 'float':: + minimum distinguishable fraction of aberrant cells. The experience shows that trustworthy + are estimates of 20% and more. + +*-p, --peak-symmetry* 'float':: + a heuristics to filter failed fits where the expected peak symmetry is violated. + The 'float' is from the interval [0,1] and larger is stricter + + [[query]] === bcftools query ['OPTIONS'] 'file.vcf.gz' ['file.vcf.gz' [...]] Extracts fields from VCF or BCF files and outputs them in user-defined format. From 649f1e23946f7a23caeb30a9b8ec0ef6ef4f3c06 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Mon, 2 Nov 2015 10:42:12 +0000 Subject: [PATCH 103/211] Expanded docs to prevent errors reported in #346 and #239 --- doc/bcftools.txt | 5 +++-- 1 file changed, 3 insertions(+), 2 deletions(-) diff --git a/doc/bcftools.txt b/doc/bcftools.txt index f485507f6..22f014628 100644 --- a/doc/bcftools.txt +++ b/doc/bcftools.txt @@ -235,10 +235,11 @@ specific commands to see if they apply. :: With the *call -C* 'alleles' command, third column of the targets file must - be comma-separated list of alleles, starting with the reference allele. + be comma-separated list of alleles, starting with the reference allele. + Note that the file must be compressed and index. Such a file can be easily created from a VCF using: ---- - bcftools query -f'%CHROM\t%POS\t%REF,%ALT\n' file.vcf + bcftools query -f'%CHROM\t%POS\t%REF,%ALT\n' file.vcf | bgzip -c > als.tsv.gz && tabix -s1 -b2 -e2 als.tsv.gz ---- [[annotate]] From bca77784a8935f0fb999029d065985d58b4fb073 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Thu, 5 Nov 2015 08:57:07 +0000 Subject: [PATCH 104/211] Support for --guess GL in vcf2sex --- plugins/vcf2sex.c | 11 ++++++++--- 1 file changed, 8 insertions(+), 3 deletions(-) diff --git a/plugins/vcf2sex.c b/plugins/vcf2sex.c index 6a9a626cf..735eddd3e 100644 --- a/plugins/vcf2sex.c +++ b/plugins/vcf2sex.c @@ -37,6 +37,7 @@ #define GUESS_GT 1 #define GUESS_PL 2 +#define GUESS_GL 3 typedef struct { @@ -90,7 +91,7 @@ const char *usage(void) "Usage: bcftools +vcf2sex -- [Plugin Options]\n" "Plugin options:\n" " -b, --background diploid region to determine normal hom/hets counts [X:60001-2699520]\n" - " -g, --guess determine ploidy by counting hom/hets (GT) or most likely genotypes (PL)\n" + " -g, --guess determine ploidy by counting hom/hets (GT) or most likely genotypes (PL or GL)\n" " -m, --min-hets minimum fraction of hets in diploid regions [0.3]\n" " -n, --nsites number of sites to check per region (ignored with -g) [10]\n" " -p, --ploidy space/tab-delimited list of CHROM,FROM,TO,SEX,PLOIDY\n" @@ -251,7 +252,8 @@ int process_region_guess(args_t *args, char *seq, regitr_t *itr) } else // use PLs to guess the ploidy { - int npl = bcf_get_format_int32(args->hdr,rec,"PL",&args->pls,&args->npls); + int gl2pl = args->guess & GUESS_PL ? 1 : -1; + int npl = bcf_get_format_int32(args->hdr,rec,args->guess&GUESS_PL?"PL":"GL",&args->pls,&args->npls); if ( npl<=0 ) continue; npl /= args->nsample; for (ismpl=0; ismplnsample; ismpl++) @@ -261,11 +263,13 @@ int process_region_guess(args_t *args, char *seq, regitr_t *itr) for (ial=0; ialn_allele; ial++) { if ( ptr[k] == bcf_int32_missing || ptr[k] == bcf_int32_vector_end ) break; + ptr[k] *= gl2pl; if ( phom > ptr[k] ) phom = ptr[k]; k++; for (jal=0; jal ptr[k] ) phet = ptr[k]; k++; } @@ -377,7 +381,8 @@ int run(int argc, char **argv) case 'g': if ( !strcasecmp(optarg,"GT") ) args->guess = GUESS_GT; else if ( !strcasecmp(optarg,"PL") ) args->guess = GUESS_PL; - else error("The argument not recognised, expected --guess GT or --guess PL: %s\n", optarg); + else if ( !strcasecmp(optarg,"GL") ) args->guess = GUESS_GL; + else error("The argument not recognised, expected --guess GT, --guess PL or --guess GL: %s\n", optarg); break; case 'm': args->min_hets = strtod(optarg,&tmp); From c30fb5fe604fc9c8ca1f083a9758c22a972e6b03 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Thu, 5 Nov 2015 10:14:32 +0000 Subject: [PATCH 105/211] Fixes in vcf2sex - use per-sample counts to contrast haploid/diploid regions rather than cumulative numbers - limit the background counts to the intended region rather than sweeping the whole chromosome --- plugins/vcf2sex.c | 60 +++++++++++++++++++++++++++++++++-------------- 1 file changed, 42 insertions(+), 18 deletions(-) diff --git a/plugins/vcf2sex.c b/plugins/vcf2sex.c index 735eddd3e..85be9626e 100644 --- a/plugins/vcf2sex.c +++ b/plugins/vcf2sex.c @@ -57,7 +57,7 @@ reg_stats_t; typedef struct { int nsites, nsex, *sex2ploidy, dflt_ploidy, max_ploidy, guess; - count_t bg_counts; // background het/hom counts for regions with the same ploidy in all sexes + count_t *bg_counts; // background het/hom counts for regions with the same ploidy in all sexes reg_stats_t *reg_stats; // counts for all regions, used with -g int nreg_stats, nsample, verbose; int *counts, ncounts; // number of observed GTs with given ploidy, used when -g is not given @@ -202,10 +202,13 @@ int process_region_guess(args_t *args, char *seq, regitr_t *itr) uint32_t start = 0, end = INT_MAX; reg_stats_t *stats = NULL; + // set the start and the end position if ( itr ) { start = itr->reg[itr->i].start; end = itr->reg[itr->i].end; + + // flush all records with the same coordinates while ( itr->i+kitrn && start==itr->reg[itr->i+kitr].start && end==itr->reg[itr->i+kitr].end ) kitr++; int min,max,ret = ploidy_query(args->ploidy, seq, start, args->sex2ploidy, &min, &max); @@ -222,6 +225,8 @@ int process_region_guess(args_t *args, char *seq, regitr_t *itr) seq = (char*) malloc(ptr - args->background + 1); memcpy(seq,args->background,ptr-args->background); seq[ptr-args->background] = 0; + start = spos; + end = epos; } if ( bcf_sr_seek(args->sr,seq,start)!=0 ) @@ -230,6 +235,7 @@ int process_region_guess(args_t *args, char *seq, regitr_t *itr) if ( !itr ) free(seq); return kitr; } + int ismpl, rid = bcf_hdr_name2id(args->hdr,seq); if ( !itr ) free(seq); @@ -243,7 +249,7 @@ int process_region_guess(args_t *args, char *seq, regitr_t *itr) bcf_fmt_t * fmt = bcf_get_fmt(args->hdr, rec, "GT"); for (ismpl=0; ismplnsample; ismpl++) { - count_t *counts = stats ? &stats->counts[ismpl] : &args->bg_counts; + count_t *counts = stats ? &stats->counts[ismpl] : &args->bg_counts[ismpl]; int gt = bcf_gt_type(fmt, ismpl, NULL,NULL); if ( gt==GT_UNKN ) counts->nmiss++; else if ( gt==GT_HET_RA || gt==GT_HET_AA ) counts->nhet++; @@ -274,7 +280,7 @@ int process_region_guess(args_t *args, char *seq, regitr_t *itr) k++; } } - count_t *counts = stats ? &stats->counts[ismpl] : &args->bg_counts; + count_t *counts = stats ? &stats->counts[ismpl] : &args->bg_counts[ismpl]; if ( k == rec->n_allele ) counts->nhom++; // haploid else if ( k != rec->n_allele*(rec->n_allele+1)/2 ) counts->nmiss++; else if ( phet < phom ) counts->nhet++; @@ -288,21 +294,26 @@ int process_region_guess(args_t *args, char *seq, regitr_t *itr) void sex2prob_guess(args_t *args) { int ismpl, ireg; - uint64_t nhom,nhet,nmiss; - float bg_het = -1; + // get numbers from the background region if ( args->background ) { process_region_guess(args, NULL, NULL); - nhom = args->bg_counts.nhom; - nhet = args->bg_counts.nhet; - nmiss = args->bg_counts.nmiss; - bg_het = nhom+nhet ? (float)nhet/(nhom+nhet) : 0; if ( args->verbose ) + printf("# [1]BGR\t[2]Region\t[3]Sample\t[4]Het fraction\t[5]nHet\t[6]nHom\t[7]nMissing\n"); + + for (ismpl=0; ismplnsample; ismpl++) { - printf("# [1]BGR\t[2]Region\t[3]Het fraction\t[4]nHet\t[5]nHom\t[6]nMissing\n"); - printf("BGR\t%s\t%f\t%"PRId64"\t%"PRId64"\t%"PRId64"\n", args->background,bg_het,nhet,nhom,nmiss); + uint64_t nhom = args->bg_counts[ismpl].nhom; + uint64_t nhet = args->bg_counts[ismpl].nhet; + uint64_t nmiss = args->bg_counts[ismpl].nmiss; + if ( nhom+nhet==0 ) + fprintf(stderr,"Warning: The sample %s has no variants in the background region %s\n", args->hdr->samples[ismpl],args->background); + + float bg_het = (float)nhet/(nhom+nhet); + if ( args->verbose ) + printf("BGR\t%s\t%s\t%f\t%"PRId64"\t%"PRId64"\t%"PRId64"\n", args->background,args->hdr->samples[ismpl],bg_het,nhet,nhom,nmiss); } } @@ -315,10 +326,18 @@ void sex2prob_guess(args_t *args) uint64_t nhom = stats->counts[ismpl].nhom; uint64_t nhet = stats->counts[ismpl].nhet; uint64_t nmiss = stats->counts[ismpl].nmiss; - float fhet = nhom+nhet ? (float)nhet/(nhom+nhet) : 0; + float fhet = nhom+nhet ? (float)nhet/(nhom+nhet) : 0; + + float bg_fhet = -1; + if ( args->background ) + { + uint64_t bg_nhom = args->bg_counts[ismpl].nhom; + uint64_t bg_nhet = args->bg_counts[ismpl].nhet; + bg_fhet = bg_nhom+bg_nhet ? (float)bg_nhet/(bg_nhom+bg_nhet) : 0; + } if ( args->verbose ) - printf("DBG\t%s:%d-%d\t%s\t%f\t%"PRId64"\t%"PRId64"\t%"PRId64"\n", stats->chr,stats->start+1,stats->end+1,args->hdr->samples[ismpl],fhet,nhet,nhom,nmiss); + printf("REG\t%s:%d-%d\t%s\t%f\t%"PRId64"\t%"PRId64"\t%"PRId64"\n", stats->chr,stats->start+1,stats->end+1,args->hdr->samples[ismpl],fhet,nhet,nhom,nmiss); int i, ntot = nhom + nhet + nmiss; if ( !ntot ) continue; @@ -333,18 +352,18 @@ void sex2prob_guess(args_t *args) else if ( ploidy==1 ) { // NB: these numbers (0.1,0.9) are made up, to be improved - if ( bg_het<0 ) + if ( bg_fhet<0 ) prob = fhet > args->min_hets ? 0.1 : 0.9; else - prob = fhet > args->min_hets*bg_het ? 0.1 : 0.9; + prob = fhet > args->min_hets*bg_fhet ? 0.1 : 0.9; prob *= 1 - (float)nmiss / ntot; } else { - if ( bg_het<0 ) + if ( bg_fhet<0 ) prob = fhet > args->min_hets ? 0.9 : 0.1; else - prob = fhet > args->min_hets*bg_het ? 0.9 : 0.1; + prob = fhet > args->min_hets*bg_fhet ? 0.9 : 0.1; prob *= 1 - (float)nmiss / ntot; } probs[i] *= prob; @@ -425,14 +444,16 @@ int run(int argc, char **argv) if ( args->guess && args->max_ploidy > 2 ) error("Sorry, ploidy %d not supported with -g\n", args->max_ploidy); args->ncounts = args->nsample * ((args->max_ploidy>2 ? args->max_ploidy : 2)+1); args->counts = (int*) malloc(sizeof(int)*args->ncounts); + args->bg_counts = (count_t*) calloc(args->nsample,sizeof(count_t)); args->sex2prob = (float*) calloc(args->nsample*args->nsex,sizeof(float)); int i, nseq; for (i=0; insample*args->nsex; i++) args->sex2prob[i] = 1; if ( args->verbose && args->guess ) - printf("# [1]DBG\t[2]Region\t[3]Sample\t[4]HET fraction\t[5]nHet\t[6]nHom\t[7]nMissing\n"); + printf("# [1]REG\t[2]Region\t[3]Sample\t[4]Het fraction\t[5]nHet\t[6]nHom\t[7]nMissing\n"); + // First get the counts from expected haploid regions regidx_t *idx = ploidy_regions(args->ploidy); char **seqs = regidx_seq_names(idx, &nseq); for (i=0; iguess ) sex2prob_guess(args); for (i=0; insample; i++) @@ -473,6 +496,7 @@ int run(int argc, char **argv) destroy_regs(args); free(args->sex2ploidy); free(args->counts); + free(args->bg_counts); free(args->gts); free(args->pls); free(args->sex2prob); From b12ca089e6778801f4e687d6814df920dd907829 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Mon, 2 Nov 2015 08:49:02 +0000 Subject: [PATCH 106/211] More informative error msg in fill-tags plugin --- plugins/fill-tags.c | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/plugins/fill-tags.c b/plugins/fill-tags.c index c7bd7fd24..96f5e3391 100644 --- a/plugins/fill-tags.c +++ b/plugins/fill-tags.c @@ -91,7 +91,7 @@ int parse_tags(args_t *args, const char *str) else if ( !strcasecmp(tags[i],"AC_Hemi") ) flag |= SET_AC_Hemi; else { - fprintf(stderr,"Unknown tag \"%s\" in \"%s\"\n", tags[i], str); + fprintf(stderr,"Error parsing \"--tags %s\": the tag \"%s\" is not supported\n", str,tags[i]); exit(1); } free(tags[i]); From edca051a92a37da6444f4f84a84efc9e3ab545a4 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Mon, 2 Nov 2015 08:45:11 +0000 Subject: [PATCH 107/211] Expanded plugin docs: explain "+pname" vs "plugin name" --- doc/bcftools.txt | 8 ++++++-- 1 file changed, 6 insertions(+), 2 deletions(-) diff --git a/doc/bcftools.txt b/doc/bcftools.txt index 22f014628..570f317be 100644 --- a/doc/bcftools.txt +++ b/doc/bcftools.txt @@ -1151,7 +1151,7 @@ the *<>* option is supplied. [[plugin]] -=== bcftools plugin 'NAME' '[OPTIONS]' 'FILE' -- '[PLUGIN OPTIONS]' +=== bcftools [plugin 'NAME'|+'NAME'] '[OPTIONS]' 'FILE' -- '[PLUGIN OPTIONS]' ==== VCF input options: @@ -1241,9 +1241,13 @@ bcftools plugin # List available plugins bcftools plugin -l -# One can run plugins in several ways +# Run a plugin bcftools plugin counts in.vcf + +# Run a plugin using the abbreviated "+" notation bcftools +counts in.vcf + +# The input VCF can be streamed just like in other commands cat in.vcf | bcftools +counts # Print usage information of plugin "dosage" From 7564362a16a18c89fbe305611713137d3c0a012d Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Fri, 30 Oct 2015 09:41:31 +0000 Subject: [PATCH 108/211] vcfmerge: Fix error message, correct chr name must be printed See https://github.com/samtools/bcftools/issues/284#issuecomment-152362026 --- vcfmerge.c | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/vcfmerge.c b/vcfmerge.c index bf2de2bc2..e876cca69 100644 --- a/vcfmerge.c +++ b/vcfmerge.c @@ -1774,7 +1774,7 @@ void merge_buffer(args_t *args) // normalize alleles maux->als = merge_alleles(line->d.allele, line->n_allele, maux->d[i][j].map, maux->als, &maux->nals, &maux->mals); - if ( !maux->als ) error("Failed to merge alleles at %s:%d in %s\n",bcf_seqname(args->out_hdr,line),line->pos+1,reader->fname); + if ( !maux->als ) error("Failed to merge alleles at %s:%d in %s\n",bcf_seqname(bcf_sr_get_header(args->files,j),line),line->pos+1,reader->fname); hts_expand0(int, maux->nals, maux->ncnt, maux->cnt); for (k=1; kn_allele; k++) maux->cnt[ maux->d[i][j].map[k] ]++; // how many times an allele appears in the files From 6d12391e3d7a351ace6f5fe1b27d4ef73ad9d781 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Sat, 31 Oct 2015 09:58:20 +0000 Subject: [PATCH 109/211] gtcheck: Use also sites without DP for GT checking; Plot discordance in the reverse order --- vcfgtcheck.c | 14 +++++++++----- 1 file changed, 9 insertions(+), 5 deletions(-) diff --git a/vcfgtcheck.c b/vcfgtcheck.c index cbfba2510..b741ef6be 100644 --- a/vcfgtcheck.c +++ b/vcfgtcheck.c @@ -88,7 +88,7 @@ static void plot_check(args_t *args, char *target_sample, char *query_sample) " if row[4]=='%s': tgt = 1\n" " dat.append([float(row[1]), float(row[2]), float(row[3]), tgt, row[4]])\n" "\n" - "dat = sorted(dat, reverse=True)\n" + "dat = sorted(dat)\n" "\n" "iq = -1; dp = 0\n" "for i in range(len(dat)):\n" @@ -107,6 +107,9 @@ static void plot_check(args_t *args, char *target_sample, char *query_sample) " ax1.plot([iq],[dat[iq][1]],'^',color='red', ms=5)\n" "for tl in ax1.get_yticklabels(): tl.set_color('g')\n" "for tl in ax2.get_yticklabels(): tl.set_color('k'); tl.set_fontsize(9)\n" + "min_dp = min([x[2] for x in dat])\n" + "max_dp = max([x[2] for x in dat])\n" + "ax2.set_ylim(min_dp-1,max_dp+1)\n" "ax1.set_title('Discordance with %s')\n" "ax1.set_xlim(-0.05*len(dat),1.05*(len(dat)-1))\n" "ax1.set_xlabel('Sample ID')\n" @@ -574,7 +577,8 @@ static void cross_check_gts(args_t *args) } else npl = fake_PLs(args, args->sm_hdr, line); - if ( !ignore_dp && bcf_get_format_int32(args->sm_hdr, line, "DP", &dp_arr, &ndp_arr) <= 0 ) { dp_warned++; continue; } + int mdp = 0; + if ( !ignore_dp && (mdp=bcf_get_format_int32(args->sm_hdr, line, "DP", &dp_arr, &ndp_arr)) <= 0 ) dp_warned++; if ( args->hom_only ) { @@ -588,14 +592,14 @@ static void cross_check_gts(args_t *args) { int *ipl = &args->pl_arr[i*npl]; if ( *ipl==-1 ) { idx += i; continue; } // missing genotype - if ( !ignore_dp && (dp_arr[i]==bcf_int32_missing || !dp_arr[i]) ) { idx += i; continue; } + if ( mdp>0 && (dp_arr[i]==bcf_int32_missing || !dp_arr[i]) ) { idx += i; continue; } if ( args->hom_only && !is_hom[i] ) { idx += i; continue; } for (j=0; jpl_arr[j*npl]; if ( *jpl==-1 ) { idx++; continue; } // missing genotype - if ( !ignore_dp && (dp_arr[j]==bcf_int32_missing || !dp_arr[j]) ) { idx++; continue; } + if ( mdp>0 && (dp_arr[j]==bcf_int32_missing || !dp_arr[j]) ) { idx++; continue; } if ( args->hom_only && !is_hom[j] ) { idx++; continue; } int min_pl = INT_MAX; @@ -611,7 +615,7 @@ static void cross_check_gts(args_t *args) args->lks[idx] += min_pl; args->cnts[idx]++; - if ( !ignore_dp ) + if ( mdp>0 ) { args->dps[idx] += dp_arr[i] < dp_arr[j] ? dp_arr[i] : dp_arr[j]; dp[i] += dp_arr[i]; ndp[i]++; From 6ff1c214d91c12cf9dee505ab209939cd904e636 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Tue, 27 Oct 2015 14:17:53 +0000 Subject: [PATCH 110/211] Distinguish between & and && in -i/-e FMT filtering --- doc/bcftools.txt | 4 ++++ filter.c | 29 ++++++++++++++++++++++++----- 2 files changed, 28 insertions(+), 5 deletions(-) diff --git a/doc/bcftools.txt b/doc/bcftools.txt index 570f317be..d61739900 100644 --- a/doc/bcftools.txt +++ b/doc/bcftools.txt @@ -1804,6 +1804,10 @@ not "dp" instead of "DP". MIN(DP)>10 & MIN(DV)>3 + FMT/DP>10 & FMT/GQ>10 .. both conditions must be satisfied within one sample + + FMT/DP>10 && FMT/GQ>10 .. the conditions can be satisfied in different samples + QUAL>10 | FMT/GQ>10 .. selects only GQ>10 samples QUAL>10 || FMT/GQ>10 .. selects all samples at QUAL>10 sites diff --git a/filter.c b/filter.c index 82d19f2a2..6ac4868ba 100644 --- a/filter.c +++ b/filter.c @@ -845,7 +845,7 @@ static void set_strlen(filter_t *flt, bcf1_t *line, token_t *tok) if ( !has_values ) { (atok)->nvalues = 0; (atok)->nsamples = 0; } \ } -static int vector_logic_and(token_t *atok, token_t *btok) +static int vector_logic_and(token_t *atok, token_t *btok, int and_type) { // We are comparing either two scalars (result of INFO tag vs a threshold), two vectors (two FORMAT fields), // or a vector and a scalar (FORMAT field vs threshold) @@ -858,10 +858,29 @@ static int vector_logic_and(token_t *atok, token_t *btok) if ( !atok->nsamples && !btok->nsamples ) return atok->pass_site && btok->pass_site; if ( atok->nsamples && btok->nsamples ) { - for (i=0; insamples; i++) + if ( and_type==TOK_AND ) { - atok->pass_samples[i] = atok->pass_samples[i] && btok->pass_samples[i]; - if ( !pass_site && atok->pass_samples[i] ) pass_site = 1; + // perform AND within a sample + for (i=0; insamples; i++) + { + atok->pass_samples[i] = atok->pass_samples[i] && btok->pass_samples[i]; + if ( !pass_site && atok->pass_samples[i] ) pass_site = 1; + } + } + else + { + // perform AND across samples + int pass_a = 0, pass_b = 0; + for (i=0; insamples; i++) + { + if ( atok->pass_samples[i] ) pass_a = 1; + atok->pass_samples[i] = atok->pass_samples[i] && btok->pass_samples[i]; + } + for (i=0; insamples; i++) + { + if ( btok->pass_samples[i] ) { pass_b = 1; break; } + } + pass_site = pass_a && pass_b; } return pass_site; } @@ -1646,7 +1665,7 @@ int filter_test(filter_t *filter, bcf1_t *line, const uint8_t **samples) { if ( filter->flt_stack[nstack-1]->pass_site<0 || filter->flt_stack[nstack-2]->pass_site<0 ) error("Error occurred while processing the filter \"%s\" (%d %d AND)\n", filter->str,filter->flt_stack[nstack-2]->pass_site,filter->flt_stack[nstack-1]->pass_site); - filter->flt_stack[nstack-2]->pass_site = vector_logic_and(filter->flt_stack[nstack-2],filter->flt_stack[nstack-1]); + filter->flt_stack[nstack-2]->pass_site = vector_logic_and(filter->flt_stack[nstack-2],filter->flt_stack[nstack-1], filter->filters[i].tok_type); nstack--; continue; } From 74cc328d1b9f93dc4d82cf8d4d535fdda70afc48 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Tue, 27 Oct 2015 15:44:23 +0000 Subject: [PATCH 111/211] Fix in filtering of missing values. * previously -i'INFO/INT!="."' did not work * values like INFO/INT=1 could sneak through due to uninitialized memory * added more tests for missing values --- filter.c | 10 +++------- test/missing.vcf | 18 ++++++++++++++++++ test/query.19.out | 1 + test/query.21.out | 1 + test/query.22.out | 2 ++ test/query.23.out | 3 +++ test/test.pl | 20 ++++++++++++-------- 7 files changed, 40 insertions(+), 15 deletions(-) create mode 100644 test/missing.vcf create mode 100644 test/query.22.out create mode 100644 test/query.23.out diff --git a/filter.c b/filter.c index 6ac4868ba..924a095eb 100644 --- a/filter.c +++ b/filter.c @@ -1035,11 +1035,7 @@ static int vector_logic_or(token_t *atok, token_t *btok, int or_type) } \ else \ { \ - if ( bcf_float_is_missing((atok)->values[0]) || bcf_float_is_missing((btok)->values[0]) ) \ - { \ - (atok)->nvalues = 0; (atok)->nsamples = 0; (ret) = 0; \ - } \ - else if ( (atok)->values[0] CMP_OP (btok)->values[0] ) { pass_site = 1; } \ + if ( (atok)->values[0] CMP_OP (btok)->values[0] ) { pass_site = 1; } \ } \ /*fprintf(stderr,"pass=%d\n", pass_site);*/ \ (ret) = pass_site; \ @@ -1506,8 +1502,8 @@ filter_t *filter_init(bcf_hdr_t *hdr, const char *str) if ( out[k].hdr_id>0 && out[j].is_str && !strcmp(".",out[j].key) ) { int type = bcf_hdr_id2type(filter->hdr,out[k].type,out[k].hdr_id); - if ( type==BCF_HT_INT ) { out[j].is_str = 0; out[j].is_missing = 1; } - if ( type==BCF_HT_REAL ) { out[j].is_str = 0; out[j].is_missing = 1; } + if ( type==BCF_HT_INT ) { out[j].is_str = 0; out[j].is_missing = 1; bcf_float_set_missing(out[j].values[0]); } + if ( type==BCF_HT_REAL ) { out[j].is_str = 0; out[j].is_missing = 1; bcf_float_set_missing(out[j].values[0]); } } } if ( out[i].tok_type==TOK_LIKE || out[i].tok_type==TOK_NLIKE ) diff --git a/test/missing.vcf b/test/missing.vcf new file mode 100644 index 000000000..b6ca53d26 --- /dev/null +++ b/test/missing.vcf @@ -0,0 +1,18 @@ +##fileformat=VCFv4.1 +##contig= +##reference=file:///lustre/scratch105/projects/g1k/ref/main_project/human_g1k_v37.fasta +##INFO= +##INFO= +##INFO= +##INFO= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##FILTER= +#CHROM POS ID REF ALT QUAL FILTER INFO FORMAT A B C +1 3000001 xx C T 11 PASS FLAG;IINT=11;IFLT=1.1;ISTR=xxx GT:FINT:FFLT:FSTR 0/0:11:1.1:xxx 0/0:11:1.1:x 0/0:11:1.1:x +1 3000002 . C T . . . GT . . . +1 3000003 xx C T 11 q11 FLAG;IINT=.;IFLT=.;ISTR=. GT:FINT:FFLT:FSTR 0/0:.:.:. 0/0:.:.:. 0/0:.:.:. +1 3000004 xx C T 11 q11 FLAG;IINT=11;IFLT=1.1;ISTR=xxx GT:FINT:FFLT:FSTR 0/0:11:1.1:x 0/0:11:1.1:xxx 0/0:11:1.1:xxx +1 3000005 xx C T 11 q11 FLAG;IINT=1;IFLT=1;ISTR=.. GT:FINT:FFLT:FSTR 0/0:11:1.1:x 0/0:11:1.1:xxx 0/0:11:1.1:xxx diff --git a/test/query.19.out b/test/query.19.out index ec7168b33..f16b4abcd 100644 --- a/test/query.19.out +++ b/test/query.19.out @@ -1,2 +1,3 @@ 3000001 11 3000004 11 +3000005 1 diff --git a/test/query.21.out b/test/query.21.out index 960fc0027..ead31a1f7 100644 --- a/test/query.21.out +++ b/test/query.21.out @@ -1,2 +1,3 @@ 3000001 1.1 3000004 1.1 +3000005 1 diff --git a/test/query.22.out b/test/query.22.out new file mode 100644 index 000000000..961849857 --- /dev/null +++ b/test/query.22.out @@ -0,0 +1,2 @@ +3000002 . +3000003 . diff --git a/test/query.23.out b/test/query.23.out new file mode 100644 index 000000000..3594a8477 --- /dev/null +++ b/test/query.23.out @@ -0,0 +1,3 @@ +3000001 xxx +3000004 xxx +3000005 .. diff --git a/test/test.pl b/test/test.pl index 2c56e0aea..b23296725 100755 --- a/test/test.pl +++ b/test/test.pl @@ -82,14 +82,18 @@ test_vcf_query($opts,in=>'query.filter',out=>'query.15.out',args=>q[-f'%POS[ %GT]\\n' -e'GT ="1"']); test_vcf_query($opts,in=>'query.filter',out=>'query.16.out',args=>q[-f'%POS[ %GT]\\n' -e'GT!="1"']); test_vcf_query($opts,in=>'query.2',out=>'query.17.out',args=>q[-f'%XX_A %XX.A %XX.A0 %xx.a0\\n']); -test_vcf_query($opts,in=>'annotate2',out=>'query.18.out',args=>q[-i'IINT="."' -f'%POS %IINT\\n']); -test_vcf_query($opts,in=>'annotate2',out=>'query.19.out',args=>q[-i'IINT!="."' -f'%POS %IINT\\n']); -test_vcf_query($opts,in=>'annotate2',out=>'query.18.out',args=>q[-e'IINT!="."' -f'%POS %IINT\\n']); -test_vcf_query($opts,in=>'annotate2',out=>'query.19.out',args=>q[-e'IINT="."' -f'%POS %IINT\\n']); -test_vcf_query($opts,in=>'annotate2',out=>'query.20.out',args=>q[-i'IFLT="."' -f'%POS %IFLT\\n']); -test_vcf_query($opts,in=>'annotate2',out=>'query.21.out',args=>q[-i'IFLT!="."' -f'%POS %IFLT\\n']); -test_vcf_query($opts,in=>'annotate2',out=>'query.20.out',args=>q[-e'IFLT!="."' -f'%POS %IFLT\\n']); -test_vcf_query($opts,in=>'annotate2',out=>'query.21.out',args=>q[-e'IFLT="."' -f'%POS %IFLT\\n']); +test_vcf_query($opts,in=>'missing',out=>'query.18.out',args=>q[-i'IINT="."' -f'%POS %IINT\\n']); +test_vcf_query($opts,in=>'missing',out=>'query.19.out',args=>q[-i'IINT!="."' -f'%POS %IINT\\n']); +test_vcf_query($opts,in=>'missing',out=>'query.18.out',args=>q[-e'IINT!="."' -f'%POS %IINT\\n']); +test_vcf_query($opts,in=>'missing',out=>'query.19.out',args=>q[-e'IINT="."' -f'%POS %IINT\\n']); +test_vcf_query($opts,in=>'missing',out=>'query.20.out',args=>q[-i'IFLT="."' -f'%POS %IFLT\\n']); +test_vcf_query($opts,in=>'missing',out=>'query.21.out',args=>q[-i'IFLT!="."' -f'%POS %IFLT\\n']); +test_vcf_query($opts,in=>'missing',out=>'query.20.out',args=>q[-e'IFLT!="."' -f'%POS %IFLT\\n']); +test_vcf_query($opts,in=>'missing',out=>'query.21.out',args=>q[-e'IFLT="."' -f'%POS %IFLT\\n']); +test_vcf_query($opts,in=>'missing',out=>'query.22.out',args=>q[-i'ISTR="."' -f'%POS %ISTR\\n']); +test_vcf_query($opts,in=>'missing',out=>'query.23.out',args=>q[-i'ISTR!="."' -f'%POS %ISTR\\n']); +test_vcf_query($opts,in=>'missing',out=>'query.23.out',args=>q[-e'ISTR="."' -f'%POS %ISTR\\n']); +test_vcf_query($opts,in=>'missing',out=>'query.22.out',args=>q[-e'ISTR!="."' -f'%POS %ISTR\\n']); test_vcf_norm($opts,in=>'norm',out=>'norm.out',fai=>'norm'); test_vcf_norm($opts,in=>'norm.split',out=>'norm.split.out',args=>'-m-'); test_vcf_norm($opts,in=>'norm.split.2',out=>'norm.split.2.out',args=>'-m-'); From c43c235883b2f9514a9b88133d79cd5cc14a7ecf Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Fri, 6 Nov 2015 14:46:03 +0000 Subject: [PATCH 112/211] Document requirement of compressed/indexed files when reading multiple VCFs simultaneously Closes #340 --- doc/bcftools.txt | 3 ++- 1 file changed, 2 insertions(+), 1 deletion(-) diff --git a/doc/bcftools.txt b/doc/bcftools.txt index d61739900..c54ec0d25 100644 --- a/doc/bcftools.txt +++ b/doc/bcftools.txt @@ -38,7 +38,8 @@ transparently with both VCFs and BCFs, both uncompressed and BGZF-compressed. Most commands accept VCF, bgzipped VCF and BCF with filetype detected automatically even when streaming from a pipe. Indexed VCF and BCF will work in all situations. Un-indexed VCF and BCF and streams will -work in most, but not all situations. +work in most, but not all situations. In general, whenever multiple VCFs are +read simultaneously, they must be indexed and therefore also compressed. BCFtools is designed to work on a stream. It regards an input file "-" as the standard input (stdin) and outputs to the standard output (stdout). Several From 0b9ad1a3dfa6449f926b79386a43f1c7a391e83e Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Fri, 6 Nov 2015 15:20:24 +0000 Subject: [PATCH 113/211] document subset behaviour with regard to sample dependent tags Closes #331 --- doc/bcftools.txt | 12 +++++++++++- 1 file changed, 11 insertions(+), 1 deletion(-) diff --git a/doc/bcftools.txt b/doc/bcftools.txt index c54ec0d25..b04893de2 100644 --- a/doc/bcftools.txt +++ b/doc/bcftools.txt @@ -190,10 +190,20 @@ specific commands to see if they apply. *-s, --samples* \[^]'LIST':: Comma-separated list of samples to include or exclude if prefixed with "^". + Note that in general tags such as INFO/AC, INFO/AN, etc are not updated + to correspond to the subset samples. *<>* is the + exception where some tags will be updated (unless the *-I, --no-update* + option is used; see *<>* documentation). To use updated + tags for the subset in another command one can pipe from *view* into + that command. For example: +---- + bcftools view -Ou -s sample1,sample2 file.vcf | bcftools query -f %INFO/AC\t%INFO/AN\n +---- *-S, --samples-file* [^]'FILE'[[samples_file]]:: File of sample names to include or exclude if prefixed with "^". - One sample per line. + One sample per line. See also the note above for the *-s, --samples* + option. The command *<>* accepts an optional second column indicating ploidy (0, 1 or 2) or sex (as defined by *<>*, for example "F" or "M"), and can parse also PED From 08cc3f203bee8f8eaf8baec7200905881c25037d Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Fri, 6 Nov 2015 16:13:26 +0000 Subject: [PATCH 114/211] add some missing documentation --- doc/bcftools.txt | 45 ++++++++++++++++++++++++++++++++++++++++++--- 1 file changed, 42 insertions(+), 3 deletions(-) diff --git a/doc/bcftools.txt b/doc/bcftools.txt index b04893de2..72357d2fb 100644 --- a/doc/bcftools.txt +++ b/doc/bcftools.txt @@ -462,6 +462,9 @@ demand. The original calling model can be invoked with the *-c* option. minimum per-sample depth required to include a site in the non-variant block. +*-i, --insert-missed* 'INT':: + output also sites missed by mpileup but present in *-T, --targets-file*. + *-M, --keep-masked-ref*:: output sites where REF allele is N @@ -684,14 +687,31 @@ Create consensus sequence by applying VCF variants to a reference fasta file. convert from haps/sample format to VCF. The columns of .haps file are similar to .gen file above, but there are only two haplotype columns per sample. Note that the first column of the haps file is expected to be in - the form "CHR:POS_REF_ALT", for example: + the form "CHR:POS_REF_ALT(_END)?", with the _END being optional for + defining the INFO/END tag when ALT is a symbolic allele, for example: ---- .haps ---- 1:111485207_G_A rsID1 111485207 G A 0 1 0 0 1:111494194_C_T rsID2 111494194 C T 0 1 0 0 + 1:111495231_A__111495784 rsID3 111495231 A 0 0 1 0 ---- +*--hapsample* 'prefix' or 'haps-file','sample-file':: + convert from VCF to haps/sample format used by IMPUTE2 and SHAPEIT. + The columns of .haps file begin with ID,RSID,POS,REF,ALT. In order to + prevent strand swaps, the program uses IDs of the form + "CHROM:POS_REF_ALT". + +*--haploid2diploid*:: + with *-h* option converts haploid genotypes to homozygous diploid + genotypes. For example, the program will print '0 0' instead of the + default '0 -'. This is useful for programs which do not handle haploid + genotypes correctly. + +*--vcf-ids*:: + output VCF IDs instead of "CHROM:POS_REF_ALT" IDs + ==== HAPS/LEGEND/SAMPLE conversion: *-H, --haplegendsample2vcf* 'prefix' or 'haps-file','legend-file','sample-file':: convert from haps/legend/sample format used by IMPUTE2 to VCF, see @@ -1113,8 +1133,14 @@ the *<>* option is supplied. can swap alleles and will update genotypes (GT) and AC counts, but will not attempt to fix PL or other fields. +*-d, --rm-dup* 'snps'|'indels'|'both'|'all'|'none':: + If a record is present in multiple files, output only the first instance, + see *--collapse* in *<>*. + Requires *-a, --allow-overlaps*. + *-D, --remove-duplicates*:: - remove duplicate lines of the same type + If a record is present in multiple files, output only the first instance. + Alias for *-d none*. Requires *-a, --allow-overlaps*. *-f, --fasta-ref* 'FILE'[[fasta_ref]]:: reference sequence. Supplying this option will turn on left-alignment @@ -1216,6 +1242,9 @@ If htslib is not installed systemwide, set the environment variable *-v, --verbose*:: print debugging information to debug plugin failure +*-V, --version*:: + print version string and exit + ==== List of plugins coming with the distribution: *counts*:: @@ -1466,6 +1495,9 @@ Transition probabilities: be a single file or a file mask, where string "{CHROM}" is replaced with chromosome name. +*-M, --rec-rate* 'FLOAT':: + constant recombination rate per bp + *-r, --regions* 'chr'|'chr:pos'|'chr:from-to'|'chr:from-'[,...]:: see *<>* @@ -1503,7 +1535,7 @@ default only sites are compared, *-s*/*-S* must given to include also sample columns. *-1, --1st-allele-only*:: - consider only 1st allele at multiallelic sites + consider only the 1st alternate allele at multiallelic sites *-c, --collapse* 'snps'|'indels'|'both'|'all'|'some'|'none':: see *<>* @@ -1558,7 +1590,11 @@ columns. *-T, --targets-file* 'file':: see *<>* +*-u, --user-tstv* '':: + collect Ts/Tv stats for any tag using the given binning [0:1:100] +*-v, --verbose*:: + produce verbose per-site and per-sample output [[view]] @@ -1604,6 +1640,9 @@ Convert between VCF and BCF. Former *bcftools subset*. *-a, --trim-alt-alleles*:: trim alternate alleles not seen in subset. Type A, G and R INFO and FORMAT fields will also be trimmed +*--force-samples*:: + only warn about unknown subset samples + *-I, --no-update*:: do not (re)calculate INFO fields for the subset (currently INFO/AC and INFO/AN) From 06ce5a11d4b3f5bf522533f43149d12c6138fbac Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Fri, 6 Nov 2015 16:14:15 +0000 Subject: [PATCH 115/211] update man and html doc from the asciidoc --- doc/bcftools.1 | 137 +++++++++++++++++++++++++++++++++++++++++----- doc/bcftools.html | 98 ++++++++++++++++++++++++++++----- 2 files changed, 206 insertions(+), 29 deletions(-) diff --git a/doc/bcftools.1 b/doc/bcftools.1 index d0e609ed1..37fbd21e0 100644 --- a/doc/bcftools.1 +++ b/doc/bcftools.1 @@ -2,12 +2,12 @@ .\" Title: bcftools .\" Author: [see the "AUTHORS" section] .\" Generator: DocBook XSL Stylesheets v1.76.1 -.\" Date: 2015-09-15 11:42 BST +.\" Date: 2015-11-06 16:12 GMT .\" Manual: \ \& .\" Source: \ \& .\" Language: English .\" -.TH "BCFTOOLS" "1" "2015\-09\-15 11:42 BST" "\ \&" "\ \&" +.TH "BCFTOOLS" "1" "2015\-11\-06 16:12 GMT" "\ \&" "\ \&" .\" ----------------------------------------------------------------- .\" * Define some portability stuff .\" ----------------------------------------------------------------- @@ -36,12 +36,12 @@ bcftools \- utilities for variant calling and manipulating VCFs and BCFs\&. .sp BCFtools is a set of utilities that manipulate variant calls in the Variant Call Format (VCF) and its binary counterpart BCF\&. All commands work transparently with both VCFs and BCFs, both uncompressed and BGZF\-compressed\&. .sp -Most commands accept VCF, bgzipped VCF and BCF with filetype detected automatically even when streaming from a pipe\&. Indexed VCF and BCF will work in all situations\&. Un\-indexed VCF and BCF and streams will work in most, but not all situations\&. +Most commands accept VCF, bgzipped VCF and BCF with filetype detected automatically even when streaming from a pipe\&. Indexed VCF and BCF will work in all situations\&. Un\-indexed VCF and BCF and streams will work in most, but not all situations\&. In general, whenever multiple VCFs are read simultaneously, they must be indexed and therefore also compressed\&. .sp BCFtools is designed to work on a stream\&. It regards an input file "\-" as the standard input (stdin) and outputs to the standard output (stdout)\&. Several commands can thus be combined with Unix pipes\&. .SS "VERSION" .sp -This manual page was last updated \fB2015\-09\-15 11:42 BST\fR and refers to bcftools git version \fB1\&.2\-127\-g5940dc0+\fR\&. +This manual page was last updated \fB2015\-11\-06 16:12 GMT\fR and refers to bcftools git version \fB1\&.2\-170\-g0b9ad1a+\fR\&. .SS "BCF1" .sp The BCF1 format output by versions of samtools <= 0\&.1\&.19 is \fBnot\fR compatible with this version of bcftools\&. To read BCF1 files one can use the view command from old versions of bcftools packaged with samtools versions <= 0\&.1\&.19 to convert to VCF, which can then be read by this version of bcftools\&. @@ -404,12 +404,32 @@ cannot be used in combination with .PP \fB\-s, \-\-samples\fR [^]\fILIST\fR .RS 4 -Comma\-separated list of samples to include or exclude if prefixed with "^"\&. +Comma\-separated list of samples to include or exclude if prefixed with "^"\&. Note that in general tags such as INFO/AC, INFO/AN, etc are not updated to correspond to the subset samples\&. +\fBbcftools view\fR +is the exception where some tags will be updated (unless the +\fB\-I, \-\-no\-update\fR +option is used; see +\fBbcftools view\fR +documentation)\&. To use updated tags for the subset in another command one can pipe from +\fBview\fR +into that command\&. For example: +.RE +.sp +.if n \{\ +.RS 4 +.\} +.nf + bcftools view \-Ou \-s sample1,sample2 file\&.vcf | bcftools query \-f %INFO/AC\et%INFO/AN\en +.fi +.if n \{\ .RE +.\} .PP \fB\-S, \-\-samples\-file\fR \fIFILE\fR .RS 4 -File of sample names to include or exclude if prefixed with "^"\&. One sample per line\&. The command +File of sample names to include or exclude if prefixed with "^"\&. One sample per line\&. See also the note above for the +\fB\-s, \-\-samples\fR +option\&. The command \fBbcftools call\fR accepts an optional second column indicating ploidy (0, 1 or 2) or sex (as defined by \fB\-\-ploidy\fR, for example "F" or "M"), and can parse also PED files\&. If the second column is not present, the sex "F" is assumed\&. With @@ -476,14 +496,14 @@ cannot be used in combination with With the \fBcall \-C\fR \fIalleles\fR -command, third column of the targets file must be comma\-separated list of alleles, starting with the reference allele\&. Such a file can be easily created from a VCF using: +command, third column of the targets file must be comma\-separated list of alleles, starting with the reference allele\&. Note that the file must be compressed and index\&. Such a file can be easily created from a VCF using: .RE .sp .if n \{\ .RS 4 .\} .nf - bcftools query \-f\*(Aq%CHROM\et%POS\et%REF,%ALT\en\*(Aq file\&.vcf + bcftools query \-f\*(Aq%CHROM\et%POS\et%REF,%ALT\en\*(Aq file\&.vcf | bgzip \-c > als\&.tsv\&.gz && tabix \-s1 \-b2 \-e2 als\&.tsv\&.gz .fi .if n \{\ .RE @@ -773,6 +793,12 @@ output also gVCF blocks of homozygous REF calls\&. The parameter is the minimum per\-sample depth required to include a site in the non\-variant block\&. .RE .PP +\fB\-i, \-\-insert\-missed\fR \fIINT\fR +.RS 4 +output also sites missed by mpileup but present in +\fB\-T, \-\-targets\-file\fR\&. +.RE +.PP \fB\-M, \-\-keep\-masked\-ref\fR .RS 4 output sites where REF allele is N @@ -1156,7 +1182,7 @@ reference sequence in fasta format\&. Must be indexed with samtools faidx .PP \fB\-\-hapsample2vcf\fR \fIprefix\fR or \fIhaps\-file\fR,\fIsample\-file\fR .RS 4 -convert from haps/sample format to VCF\&. The columns of \&.haps file are similar to \&.gen file above, but there are only two haplotype columns per sample\&. Note that the first column of the haps file is expected to be in the form "CHR:POS_REF_ALT", for example: +convert from haps/sample format to VCF\&. The columns of \&.haps file are similar to \&.gen file above, but there are only two haplotype columns per sample\&. Note that the first column of the haps file is expected to be in the form "CHR:POS_REF_ALT(_END)?", with the _END being optional for defining the INFO/END tag when ALT is a symbolic allele, for example: .RE .sp .if n \{\ @@ -1167,10 +1193,31 @@ convert from haps/sample format to VCF\&. The columns of \&.haps file are simila \-\-\-\- 1:111485207_G_A rsID1 111485207 G A 0 1 0 0 1:111494194_C_T rsID2 111494194 C T 0 1 0 0 + 1:111495231_A__111495784 rsID3 111495231 A 0 0 1 0 .fi .if n \{\ .RE .\} +.PP +\fB\-\-hapsample\fR \fIprefix\fR or \fIhaps\-file\fR,\fIsample\-file\fR +.RS 4 +convert from VCF to haps/sample format used by IMPUTE2 and SHAPEIT\&. The columns of \&.haps file begin with ID,RSID,POS,REF,ALT\&. In order to prevent strand swaps, the program uses IDs of the form "CHROM:POS_REF_ALT"\&. +.RE +.PP +\fB\-\-haploid2diploid\fR +.RS 4 +with +\fB\-h\fR +option converts haploid genotypes to homozygous diploid genotypes\&. For example, the program will print +\fI0 0\fR +instead of the default +\fI0 \-\fR\&. This is useful for programs which do not handle haploid genotypes correctly\&. +.RE +.PP +\fB\-\-vcf\-ids\fR +.RS 4 +output VCF IDs instead of "CHROM:POS_REF_ALT" IDs +.RE .RE .sp .it 1 an-trap @@ -1803,7 +1850,9 @@ is one of \fIavg\fR, \fImin\fR, \fImax\fR, -\fIjoin\fR\&. +\fIjoin\fR\&. Default is +\fIDP:sum,DP4:sum\fR +if these fields exist in the input files\&. Fields with no specified rule will take the value from the first input file\&. The merged QUAL value is currently set to the maximum\&. This behaviour is not user controllable at the moment\&. .RE .PP \fB\-l, \-\-file\-list\fR \fIFILE\fR @@ -1871,9 +1920,20 @@ and can swap alleles and will update genotypes (GT) and AC counts, but will not attempt to fix PL or other fields\&. .RE .PP +\fB\-d, \-\-rm\-dup\fR \fIsnps\fR|\fIindels\fR|\fIboth\fR|\fIall\fR|\fInone\fR +.RS 4 +If a record is present in multiple files, output only the first instance, see +\fB\-\-collapse\fR +in +\fBCommon Options\fR\&. Requires +\fB\-a, \-\-allow\-overlaps\fR\&. +.RE +.PP \fB\-D, \-\-remove\-duplicates\fR .RS 4 -remove duplicate lines of the same type +If a record is present in multiple files, output only the first instance\&. Alias for +\fB\-d none\fR\&. Requires +\fB\-a, \-\-allow\-overlaps\fR\&. .RE .PP \fB\-f, \-\-fasta\-ref\fR \fIFILE\fR @@ -1948,7 +2008,7 @@ see .RS 4 maximum distance between two records to consider when locally sorting variants which changed position during the realignment .RE -.SS "bcftools plugin \fINAME\fR \fI[OPTIONS]\fR \fIFILE\fR \(em \fI[PLUGIN OPTIONS]\fR" +.SS "bcftools [plugin \fINAME\fR|+\fINAME\fR] \fI[OPTIONS]\fR \fIFILE\fR \(em \fI[PLUGIN OPTIONS]\fR" .sp .it 1 an-trap .nr an-no-space-flag 1 @@ -2048,6 +2108,11 @@ is located\&. .RS 4 print debugging information to debug plugin failure .RE +.PP +\fB\-V, \-\-version\fR +.RS 4 +print version string and exit +.RE .RE .sp .it 1 an-trap @@ -2117,9 +2182,13 @@ bcftools plugin # List available plugins bcftools plugin \-l -# One can run plugins in several ways +# Run a plugin bcftools plugin counts in\&.vcf + +# Run a plugin using the abbreviated "+" notation bcftools +counts in\&.vcf + +# The input VCF can be streamed just like in other commands cat in\&.vcf | bcftools +counts # Print usage information of plugin "dosage" @@ -2522,6 +2591,11 @@ genetic map in the format required also by IMPUTE2\&. Only the first and third c can chromosome name\&. .RE .PP +\fB\-M, \-\-rec\-rate\fR \fIFLOAT\fR +.RS 4 +constant recombination rate per bp +.RE +.PP \fB\-r, \-\-regions\fR \fIchr\fR|\fIchr:pos\fR|\fIchr:from\-to\fR|\fIchr:from\-\fR[,\&...] .RS 4 see @@ -2581,7 +2655,7 @@ Parses VCF or BCF and produces text file stats which is suitable for machine pro .PP \fB\-1, \-\-1st\-allele\-only\fR .RS 4 -consider only 1st allele at multiallelic sites +consider only the 1st alternate allele at multiallelic sites .RE .PP \fB\-c, \-\-collapse\fR \fIsnps\fR|\fIindels\fR|\fIboth\fR|\fIall\fR|\fIsome\fR|\fInone\fR @@ -2682,6 +2756,16 @@ see see \fBCommon Options\fR .RE +.PP +\fB\-u, \-\-user\-tstv\fR \fI\fR +.RS 4 +collect Ts/Tv stats for any tag using the given binning [0:1:100] +.RE +.PP +\fB\-v, \-\-verbose\fR +.RS 4 +produce verbose per\-site and per\-sample output +.RE .SS "bcftools view [\fIOPTIONS\fR] \fIfile\&.vcf\&.gz\fR [\fIREGION\fR [\&...]]" .sp View, subset and filter VCF or BCF files by position and filtering expression\&. Convert between VCF and BCF\&. Former \fBbcftools subset\fR\&. @@ -2762,6 +2846,11 @@ see trim alternate alleles not seen in subset\&. Type A, G and R INFO and FORMAT fields will also be trimmed .RE .PP +\fB\-\-force\-samples\fR +.RS 4 +only warn about unknown subset samples +.RE +.PP \fB\-I, \-\-no\-update\fR .RS 4 do not (re)calculate INFO fields for the subset (currently INFO/AC and INFO/AN) @@ -3297,6 +3386,26 @@ MIN(DP)>10 & MIN(DV)>3 .RS 4 .\} .nf +FMT/DP>10 & FMT/GQ>10 \&.\&. both conditions must be satisfied within one sample +.fi +.if n \{\ +.RE +.\} +.sp +.if n \{\ +.RS 4 +.\} +.nf +FMT/DP>10 && FMT/GQ>10 \&.\&. the conditions can be satisfied in different samples +.fi +.if n \{\ +.RE +.\} +.sp +.if n \{\ +.RS 4 +.\} +.nf QUAL>10 | FMT/GQ>10 \&.\&. selects only GQ>10 samples .fi .if n \{\ diff --git a/doc/bcftools.html b/doc/bcftools.html index 3ac3e8614..a29a9148c 100644 --- a/doc/bcftools.html +++ b/doc/bcftools.html @@ -1,13 +1,14 @@ -bcftools

    Name

    bcftools — utilities for variant calling and manipulating VCFs and BCFs.

    Synopsis

    bcftools [--version|--version-only] [--help] [COMMAND] [OPTIONS]

    DESCRIPTION

    BCFtools is a set of utilities that manipulate variant calls in the Variant +bcftools

    Name

    bcftools — utilities for variant calling and manipulating VCFs and BCFs.

    Synopsis

    bcftools [--version|--version-only] [--help] [COMMAND] [OPTIONS]

    DESCRIPTION

    BCFtools is a set of utilities that manipulate variant calls in the Variant Call Format (VCF) and its binary counterpart BCF. All commands work transparently with both VCFs and BCFs, both uncompressed and BGZF-compressed.

    Most commands accept VCF, bgzipped VCF and BCF with filetype detected automatically even when streaming from a pipe. Indexed VCF and BCF will work in all situations. Un-indexed VCF and BCF and streams will -work in most, but not all situations.

    BCFtools is designed to work on a stream. It regards an input file "-" as the +work in most, but not all situations. In general, whenever multiple VCFs are +read simultaneously, they must be indexed and therefore also compressed.

    BCFtools is designed to work on a stream. It regards an input file "-" as the standard input (stdin) and outputs to the standard output (stdout). Several -commands can thus be combined with Unix pipes.

    VERSION

    This manual page was last updated 2015-09-15 11:42 BST and refers to bcftools git version 1.2-127-g5940dc0+.

    BCF1

    The BCF1 format output by versions of samtools <= 0.1.19 is not +commands can thus be combined with Unix pipes.

    VERSION

    This manual page was last updated 2015-11-06 16:12 GMT and refers to bcftools git version 1.2-170-g0b9ad1a+.

    BCF1

    The BCF1 format output by versions of samtools <= 0.1.19 is not compatible with this version of bcftools. To read BCF1 files one can use the view command from old versions of bcftools packaged with samtools versions <= 0.1.19 to convert to VCF, which can then be read by @@ -40,7 +41,7 @@

  • norm .. normalize indels
  • -plugin .. run user-defined plugin +plugin .. run user-defined plugin
  • query .. transform VCF/BCF into user-defined formats
  • @@ -150,11 +151,18 @@
    Comma-separated list of samples to include or exclude if prefixed with "^". -
    + Note that in general tags such as INFO/AC, INFO/AN, etc are not updated + to correspond to the subset samples. bcftools view is the + exception where some tags will be updated (unless the -I, --no-update + option is used; see bcftools view documentation). To use updated + tags for the subset in another command one can pipe from view into + that command. For example: +
  •     bcftools view -Ou -s sample1,sample2 file.vcf | bcftools query -f %INFO/AC\t%INFO/AN\n
    -S, --samples-file FILE
    File of sample names to include or exclude if prefixed with "^". - One sample per line. + One sample per line. See also the note above for the -s, --samples + option. The command bcftools call accepts an optional second column indicating ploidy (0, 1 or 2) or sex (as defined by --ploidy, for example "F" or "M"), and can parse also PED @@ -198,8 +206,9 @@
    With the call -C alleles command, third column of the targets file must be comma-separated list of alleles, starting with the reference allele. + Note that the file must be compressed and index. Such a file can be easily created from a VCF using: -
        bcftools query -f'%CHROM\t%POS\t%REF,%ALT\n' file.vcf

    bcftools annotate [OPTIONS] FILE

    This command allows to add or remove annotations.

    +
        bcftools query -f'%CHROM\t%POS\t%REF,%ALT\n' file.vcf | bgzip -c > als.tsv.gz && tabix -s1 -b2 -e2 als.tsv.gz

    bcftools annotate [OPTIONS] FILE

    This command allows to add or remove annotations.

    -a, --annotations file
    Bgzip-compressed and tabix-indexed file with annotations. The file @@ -403,6 +412,10 @@ minimum per-sample depth required to include a site in the non-variant block.
    +-i, --insert-missed INT +
    + output also sites missed by mpileup but present in -T, --targets-file. +
    -M, --keep-masked-ref
    output sites where REF allele is N @@ -640,11 +653,31 @@ convert from haps/sample format to VCF. The columns of .haps file are similar to .gen file above, but there are only two haplotype columns per sample. Note that the first column of the haps file is expected to be in - the form "CHR:POS_REF_ALT", for example: + the form "CHR:POS_REF_ALT(_END)?", with the _END being optional for + defining the INFO/END tag when ALT is a symbolic allele, for example:
      .haps
       ----
       1:111485207_G_A rsID1 111485207 G A 0 1 0 0
    -  1:111494194_C_T rsID2 111494194 C T 0 1 0 0

    HAPS/LEGEND/SAMPLE conversion:

    + 1:111494194_C_T rsID2 111494194 C T 0 1 0 0 + 1:111495231_A_<DEL>_111495784 rsID3 111495231 A <DEL> 0 0 1 0
    +--hapsample prefix or haps-file,sample-file +
    + convert from VCF to haps/sample format used by IMPUTE2 and SHAPEIT. + The columns of .haps file begin with ID,RSID,POS,REF,ALT. In order to + prevent strand swaps, the program uses IDs of the form + "CHROM:POS_REF_ALT". +
    +--haploid2diploid +
    + with -h option converts haploid genotypes to homozygous diploid + genotypes. For example, the program will print 0 0 instead of the + default 0 -. This is useful for programs which do not handle haploid + genotypes correctly. +
    +--vcf-ids +
    + output VCF IDs instead of "CHROM:POS_REF_ALT" IDs +

    HAPS/LEGEND/SAMPLE conversion:

    -H, --haplegendsample2vcf prefix or haps-file,legend-file,sample-file
    convert from haps/legend/sample format used by IMPUTE2 to VCF, see @@ -997,7 +1030,11 @@ -i, --info-rules -|TAG:METHOD[,…]
    Rules for merging INFO fields (scalars or vectors) or - to disable the - default rules. METHOD is one of sum, avg, min, max, join. + default rules. METHOD is one of sum, avg, min, max, join. + Default is DP:sum,DP4:sum if these fields exist in the input files. + Fields with no specified rule will take the value from the first input file. + The merged QUAL value is currently set to the maximum. This behaviour is + not user controllable at the moment.
    -l, --file-list FILE
    @@ -1039,9 +1076,16 @@ can swap alleles and will update genotypes (GT) and AC counts, but will not attempt to fix PL or other fields.
    +-d, --rm-dup snps|indels|both|all|none +
    + If a record is present in multiple files, output only the first instance, + see --collapse in Common Options. + Requires -a, --allow-overlaps. +
    -D, --remove-duplicates
    - remove duplicate lines of the same type + If a record is present in multiple files, output only the first instance. + Alias for -d none. Requires -a, --allow-overlaps.
    -f, --fasta-ref FILE
    @@ -1097,7 +1141,7 @@
    maximum distance between two records to consider when locally sorting variants which changed position during the realignment -

    bcftools plugin NAME [OPTIONS] FILE — [PLUGIN OPTIONS]

    VCF input options:

    +

    bcftools [plugin NAME|+NAME] [OPTIONS] FILE — [PLUGIN OPTIONS]

    VCF input options:

    -e, --exclude EXPRESSION
    exclude sites for which EXPRESSION is true. For valid expressions see @@ -1150,6 +1194,10 @@ -v, --verbose
    print debugging information to debug plugin failure +
    +-V, --version +
    + print version string and exit

    List of plugins coming with the distribution:

    counts
    @@ -1189,9 +1237,13 @@ # List available plugins bcftools plugin -l -# One can run plugins in several ways +# Run a plugin bcftools plugin counts in.vcf + +# Run a plugin using the abbreviated "+" notation bcftools +counts in.vcf + +# The input VCF can be streamed just like in other commands cat in.vcf | bcftools +counts # Print usage information of plugin "dosage" @@ -1380,6 +1432,10 @@ third column are used (position and Genetic_Map(cM)). The FILE can chromosome name.
    +-M, --rec-rate FLOAT +
    + constant recombination rate per bp +
    -r, --regions chr|chr:pos|chr:from-to|chr:from-[,…]
    see Common Options @@ -1418,7 +1474,7 @@ columns.

    -1, --1st-allele-only
    - consider only 1st allele at multiallelic sites + consider only the 1st alternate allele at multiallelic sites
    -c, --collapse snps|indels|both|all|some|none
    @@ -1484,6 +1540,14 @@ -T, --targets-file file
    see Common Options +
    +-u, --user-tstv <TAG[:min:max:n]> +
    + collect Ts/Tv stats for any tag using the given binning [0:1:100] +
    +-v, --verbose +
    + produce verbose per-site and per-sample output

    bcftools view [OPTIONS] file.vcf.gz [REGION […]]

    View, subset and filter VCF or BCF files by position and filtering expression. Convert between VCF and BCF. Former bcftools subset.

    Output options

    -G, --drop-genotypes @@ -1528,6 +1592,10 @@
    trim alternate alleles not seen in subset. Type A, G and R INFO and FORMAT fields will also be trimmed
    +--force-samples +
    + only warn about unknown subset samples +
    -I, --no-update
    do not (re)calculate INFO fields for the subset (currently INFO/AC and INFO/AN) @@ -1698,7 +1766,7 @@ Variables and function names are case-insensitive, but not tag names. For example, "qual" can be used instead of "QUAL", "strlen()" instead of "STRLEN()" , but not "dp" instead of "DP". -

    Examples:

    MIN(DV)>5
    MIN(DV/DP)>0.3
    MIN(DP)>10 & MIN(DV)>3
    QUAL>10 |  FMT/GQ>10   .. selects only GQ>10 samples
    QUAL>10 || FMT/GQ>10   .. selects all samples at QUAL>10 sites
    TYPE="snp" && QUAL>=10 && (DP4[2]+DP4[3] > 2)
    MIN(DP)>35 && AVG(GQ)>50
    ID=@file       .. selects lines with ID present in the file
    ID!=@~/file    .. skip lines with ID present in the ~/file
    MAF[0]<0.05    .. select rare variants at 5% cutoff

    Shell expansion:

    Note that expressions must often be quoted because some characters +

    Examples:

    MIN(DV)>5
    MIN(DV/DP)>0.3
    MIN(DP)>10 & MIN(DV)>3
    FMT/DP>10  & FMT/GQ>10 .. both conditions must be satisfied within one sample
    FMT/DP>10 && FMT/GQ>10 .. the conditions can be satisfied in different samples
    QUAL>10 |  FMT/GQ>10   .. selects only GQ>10 samples
    QUAL>10 || FMT/GQ>10   .. selects all samples at QUAL>10 sites
    TYPE="snp" && QUAL>=10 && (DP4[2]+DP4[3] > 2)
    MIN(DP)>35 && AVG(GQ)>50
    ID=@file       .. selects lines with ID present in the file
    ID!=@~/file    .. skip lines with ID present in the ~/file
    MAF[0]<0.05    .. select rare variants at 5% cutoff

    Shell expansion:

    Note that expressions must often be quoted because some characters have special meaning in the shell. An example of expression enclosed in single quotes which cause that the whole expression is passed to the program as intended:

    bcftools view -i '%ID!="." & MAF[0]<0.01'

    Please refer to the documentation of your shell for details.

    SCRIPTS AND OPTIONS

    plot-vcfstats [OPTIONS] file.vchk […]

    Script for processing output of bcftools stats. It can merge From 2e5fda73099ea237db5d2c0b98881509a1e81ab7 Mon Sep 17 00:00:00 2001 From: John Marshall Date: Mon, 9 Nov 2015 16:26:31 +0000 Subject: [PATCH 116/211] Dynamically export bcftools symbols to plugins ...instead of linking the plugins against libhts.so. This simplifies building and installation, as plugins no longer need to be able to find libhts.so/.dylib at runtime -- which to date has unfortunately often been done via $LD_LIBRARY_PATH. On OS X, build plugins as Mach-O bundles rather than shared libraries (and ensure that bcftools is built first, so is available for use with -bundle_loader). Fixes #225. (TODO) The advice in print_plugin_usage_hint() should be revisited. When bcftools is linked to libhts.a statically, there is a small chance that a plugin will need HTSlib functions that have not been pulled in by the bcftools executable. This is surely unlikely, and can be prevented by linking bcftools or your plugin against a shared libhts.so. Fixes #249; fixes #224; supersedes and closes #254. --- Makefile | 18 +++++++++++++----- plugins/color-chrs.mk | 4 ++-- plugins/fixploidy.mk | 4 ++-- plugins/vcf2sex.mk | 4 ++-- 4 files changed, 19 insertions(+), 11 deletions(-) diff --git a/Makefile b/Makefile index d6f620f86..042149993 100644 --- a/Makefile +++ b/Makefile @@ -1,6 +1,6 @@ # Makefile for bcftools, utilities for Variant Call Format VCF/BCF files. # -# Copyright (C) 2012-2014 Genome Research Ltd. +# Copyright (C) 2012-2015 Genome Research Ltd. # # Author: Petr Danecek # @@ -113,8 +113,16 @@ PLUGINC = $(foreach dir, plugins, $(wildcard $(dir)/*.c)) PLUGINS = $(PLUGINC:.c=.so) PLUGINM = $(PLUGINC:.c=.mk) -%.so: %.c version.h version.c $(HTSDIR)/libhts.so - $(CC) -fPIC -shared $(CFLAGS) $(EXTRA_CPPFLAGS) $(CPPFLAGS) -L$(HTSDIR) $(LDFLAGS) -o $@ version.c $< -lhts $(LIBS) +ifeq "$(shell uname -s)" "Darwin" +$(PLUGINS): | bcftools + +PLUGIN_FLAGS = -bundle -bundle_loader bcftools +else +PLUGIN_FLAGS = -fPIC -shared +endif + +%.so: %.c version.h version.c + $(CC) $(PLUGIN_FLAGS) $(CFLAGS) $(EXTRA_CPPFLAGS) $(CPPFLAGS) $(LDFLAGS) -o $@ version.c $< $(LIBS) -include $(PLUGINM) @@ -170,10 +178,10 @@ version.o: version.h version.c test/test-rbuf.o: test/test-rbuf.c rbuf.h test/test-rbuf: test/test-rbuf.o - $(CC) $(LDFLAGS) -o $@ $^ -lm -ldl $(LIBS) + $(CC) $(LDFLAGS) -o $@ $^ -lm $(LIBS) bcftools: $(HTSLIB) $(OBJS) - $(CC) $(LDFLAGS) -o $@ $(OBJS) $(HTSLIB) -lpthread -lz -lm -ldl $(GSL_LIBS) $(LIBS) + $(CC) -rdynamic $(LDFLAGS) -o $@ $(OBJS) $(HTSLIB) -lpthread -lz -lm -ldl $(GSL_LIBS) $(LIBS) doc/bcftools.1: doc/bcftools.txt cd doc && a2x -adate="$(DOC_DATE)" -aversion=$(DOC_VERSION) --doctype manpage --format manpage bcftools.txt diff --git a/plugins/color-chrs.mk b/plugins/color-chrs.mk index ca7a8a408..506b99d5a 100644 --- a/plugins/color-chrs.mk +++ b/plugins/color-chrs.mk @@ -1,2 +1,2 @@ -plugins/color-chrs.so: plugins/color-chrs.c version.h version.c HMM.h HMM.c $(HTSDIR)/libhts.so - $(CC) -fPIC -shared $(CFLAGS) $(EXTRA_CPPFLAGS) $(CPPFLAGS) -L$(HTSDIR) $(LDFLAGS) -o $@ HMM.c version.c $< -lhts $(LIBS) +plugins/color-chrs.so: plugins/color-chrs.c version.h version.c HMM.h HMM.c + $(CC) $(PLUGIN_FLAGS) $(CFLAGS) $(EXTRA_CPPFLAGS) $(CPPFLAGS) $(LDFLAGS) -o $@ HMM.c version.c $< $(LIBS) diff --git a/plugins/fixploidy.mk b/plugins/fixploidy.mk index 675282fe3..c476169d3 100644 --- a/plugins/fixploidy.mk +++ b/plugins/fixploidy.mk @@ -1,2 +1,2 @@ -plugins/fixploidy.so: plugins/fixploidy.c version.h version.c ploidy.h ploidy.c $(HTSDIR)/libhts.so - $(CC) -fPIC -shared $(CFLAGS) $(EXTRA_CPPFLAGS) $(CPPFLAGS) -L$(HTSDIR) $(LDFLAGS) -o $@ ploidy.c version.c $< -lhts $(LIBS) +plugins/fixploidy.so: plugins/fixploidy.c version.h version.c ploidy.h ploidy.c + $(CC) $(PLUGIN_FLAGS) $(CFLAGS) $(EXTRA_CPPFLAGS) $(CPPFLAGS) $(LDFLAGS) -o $@ ploidy.c version.c $< $(LIBS) diff --git a/plugins/vcf2sex.mk b/plugins/vcf2sex.mk index 1f12fb038..fa3d9996c 100644 --- a/plugins/vcf2sex.mk +++ b/plugins/vcf2sex.mk @@ -1,2 +1,2 @@ -plugins/vcf2sex.so: plugins/vcf2sex.c version.h version.c ploidy.h ploidy.c $(HTSDIR)/libhts.so - $(CC) -fPIC -shared $(CFLAGS) $(EXTRA_CPPFLAGS) $(CPPFLAGS) -L$(HTSDIR) $(LDFLAGS) -o $@ ploidy.c version.c $< -lhts $(LIBS) +plugins/vcf2sex.so: plugins/vcf2sex.c version.h version.c ploidy.h ploidy.c + $(CC) $(PLUGIN_FLAGS) $(CFLAGS) $(EXTRA_CPPFLAGS) $(CPPFLAGS) $(LDFLAGS) -o $@ ploidy.c version.c $< $(LIBS) From db3d87d21c16cada798daaf4bd8aea5e83e830c8 Mon Sep 17 00:00:00 2001 From: John Marshall Date: Tue, 10 Nov 2015 15:37:44 +0000 Subject: [PATCH 117/211] Fix error message segfault [minor] --- vcfview.c | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/vcfview.c b/vcfview.c index ed888c7c1..5727ab6d5 100644 --- a/vcfview.c +++ b/vcfview.c @@ -470,7 +470,7 @@ void set_allele_type (int *atype, char *atype_string) *atype = ALLELE_NONMAJOR; } else { - error("Error: allele type (%s) not recognised. Must be one of nref|alt1|minor|major|nonmajor: %s\n", atype_string); + error("Error: allele type not recognised. Expected one of nref|alt1|minor|major|nonmajor, got \"%s\".\n", atype_string); } } From 63cffa41eae7b0349b56a44e400fe2f963e69ca2 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Thu, 12 Nov 2015 10:48:08 +0000 Subject: [PATCH 118/211] further fixes in vcf2sex - check the return status of bcf_get_fmt to prevent segfaults when GT tag is not present - fix a silly error in assigning homs and hets from likelihoods - set to missing when most het and hom equally likely Closes #347 --- plugins/vcf2sex.c | 13 +++++++------ 1 file changed, 7 insertions(+), 6 deletions(-) diff --git a/plugins/vcf2sex.c b/plugins/vcf2sex.c index 85be9626e..b9ce69dcc 100644 --- a/plugins/vcf2sex.c +++ b/plugins/vcf2sex.c @@ -246,7 +246,8 @@ int process_region_guess(args_t *args, char *seq, regitr_t *itr) if ( args->guess & GUESS_GT ) // use GTs to guess the ploidy { - bcf_fmt_t * fmt = bcf_get_fmt(args->hdr, rec, "GT"); + bcf_fmt_t *fmt = bcf_get_fmt(args->hdr, rec, "GT"); + if ( !fmt ) continue; for (ismpl=0; ismplnsample; ismpl++) { count_t *counts = stats ? &stats->counts[ismpl] : &args->bg_counts[ismpl]; @@ -268,10 +269,6 @@ int process_region_guess(args_t *args, char *seq, regitr_t *itr) int phom = INT_MAX, phet = INT_MAX, ial, jal, k = 0; for (ial=0; ialn_allele; ial++) { - if ( ptr[k] == bcf_int32_missing || ptr[k] == bcf_int32_vector_end ) break; - ptr[k] *= gl2pl; - if ( phom > ptr[k] ) phom = ptr[k]; - k++; for (jal=0; jal ptr[k] ) phet = ptr[k]; k++; } + if ( ptr[k] == bcf_int32_missing || ptr[k] == bcf_int32_vector_end ) break; + ptr[k] *= gl2pl; + if ( phom > ptr[k] ) phom = ptr[k]; + k++; } count_t *counts = stats ? &stats->counts[ismpl] : &args->bg_counts[ismpl]; if ( k == rec->n_allele ) counts->nhom++; // haploid - else if ( k != rec->n_allele*(rec->n_allele+1)/2 ) counts->nmiss++; + else if ( phet == phom || k != rec->n_allele*(rec->n_allele+1)/2 ) counts->nmiss++; else if ( phet < phom ) counts->nhet++; else counts->nhom++; } From 3eb86dca612545d97a190d412d2e3673ff0f6212 Mon Sep 17 00:00:00 2001 From: David Laehnemann Date: Thu, 12 Nov 2015 21:19:03 +0100 Subject: [PATCH 119/211] plot-vcfstats: plotting of sample names fixed Plotting of sample names instead of sample ID numbers (flags -s/--sample-names) in plot-vcfstats did not work as the first input to plt.xticks in -plot.py was an array of strings instead of an array of integers for all by-sample plots. A simple call of int() around the row[0] argument in the list comprehension fixes that. --- plot-vcfstats | 14 +++++++------- 1 file changed, 7 insertions(+), 7 deletions(-) diff --git a/plot-vcfstats b/plot-vcfstats index e46b3eab8..5989062f4 100755 --- a/plot-vcfstats +++ b/plot-vcfstats @@ -877,7 +877,7 @@ sub plot_per_sample_stats \\tax1.set_ylabel('Ts/Tv') \\tax1.set_ylim(min(float(row[1]) for row in dat)-0.1,max(float(row[1]) for row in dat)+0.1) \\tif sample_names: - \\t\\t plt.xticks([row[0] for row in dat],[row[7] for row in dat],**sample_font) + \\t\\t plt.xticks([int(row[0]) for row in dat],[row[7] for row in dat],**sample_font) \\t\\t plt.subplots_adjust(**sample_margins) \\telse: \\t\\t plt.subplots_adjust(right=0.98,left=0.07,bottom=0.17) @@ -895,7 +895,7 @@ sub plot_per_sample_stats \\tax1.set_ylabel('nHet(RA) / nHom(AA)') \\tax1.ticklabel_format(style='sci', scilimits=(0,0), axis='y') \\tif sample_names: - \\t\\t plt.xticks([row[0] for row in dat],[row[7] for row in dat],**sample_font) + \\t\\t plt.xticks([int(row[0]) for row in dat],[row[7] for row in dat],**sample_font) \\t\\t plt.subplots_adjust(**sample_margins) \\telse: \\t\\t plt.subplots_adjust(right=0.98,left=0.07,bottom=0.17) @@ -913,7 +913,7 @@ sub plot_per_sample_stats \\tax1.set_ylabel('Number of SNPs') \\tax1.ticklabel_format(style='sci', scilimits=(0,0), axis='y') \\tif sample_names: - \\t\\t plt.xticks([row[0] for row in dat],[row[7] for row in dat],**sample_font) + \\t\\t plt.xticks([int(row[0]) for row in dat],[row[7] for row in dat],**sample_font) \\t\\t plt.subplots_adjust(**sample_margins) \\telse: \\t\\t plt.subplots_adjust(right=0.98,left=0.07,bottom=0.17) @@ -931,7 +931,7 @@ sub plot_per_sample_stats \\tax1.set_ylabel('Number of indels') \\tax1.ticklabel_format(style='sci', scilimits=(0,0), axis='y') \\tif sample_names: - \\t\\t plt.xticks([row[0] for row in dat],[row[7] for row in dat],**sample_font) + \\t\\t plt.xticks([int(row[0]) for row in dat],[row[7] for row in dat],**sample_font) \\t\\t plt.subplots_adjust(**sample_margins) \\telse: \\t\\t plt.subplots_adjust(right=0.98,left=0.07,bottom=0.17) @@ -949,7 +949,7 @@ sub plot_per_sample_stats \\tax1.set_ylabel('Number of singletons') \\tax1.ticklabel_format(style='sci', scilimits=(0,0), axis='y') \\tif sample_names: - \\t\\t plt.xticks([row[0] for row in dat],[row[7] for row in dat],**sample_font) + \\t\\t plt.xticks([int(row[0]) for row in dat],[row[7] for row in dat],**sample_font) \\t\\t plt.subplots_adjust(**sample_margins) \\telse: \\t\\t plt.subplots_adjust(right=0.98,left=0.07,bottom=0.17) @@ -967,7 +967,7 @@ sub plot_per_sample_stats \\tax1.set_ylabel('Average depth') \\tax1.ticklabel_format(style='sci', scilimits=(0,0), axis='y') \\tif sample_names: - \\t\\t plt.xticks([row[0] for row in dat],[row[7] for row in dat],**sample_font) + \\t\\t plt.xticks([int(row[0]) for row in dat],[row[7] for row in dat],**sample_font) \\t\\t plt.subplots_adjust(**sample_margins) \\telse: \\t\\t plt.subplots_adjust(right=0.98,left=0.07,bottom=0.17) @@ -1469,7 +1469,7 @@ sub plot_concordance_by_sample \\tax1.set_ylabel('Non-ref discordance') \\tax1.set_ylim(0,) \\tif sample_names: - \\t\\t plt.xticks([row[0] for row in dat],[row[2] for row in dat],**sample_font) + \\t\\t plt.xticks([int(row[0]) for row in dat],[row[2] for row in dat],**sample_font) \\t\\t plt.subplots_adjust(**sample_margins) \\telse: \\t\\t plt.subplots_adjust(right=0.98,left=0.07,bottom=0.17) From 459a7ab1ca94dff1d3fda324c2c657b181c214c7 Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Mon, 16 Nov 2015 09:02:53 +0000 Subject: [PATCH 120/211] update docs from asciidoc --- doc/bcftools.1 | 252 +++++++++++++++++++++++++++++++++++++++++++++- doc/bcftools.html | 171 +++++++++++++++++++++++++++++-- 2 files changed, 414 insertions(+), 9 deletions(-) diff --git a/doc/bcftools.1 b/doc/bcftools.1 index 37fbd21e0..ef6ae10ed 100644 --- a/doc/bcftools.1 +++ b/doc/bcftools.1 @@ -2,12 +2,12 @@ .\" Title: bcftools .\" Author: [see the "AUTHORS" section] .\" Generator: DocBook XSL Stylesheets v1.76.1 -.\" Date: 2015-11-06 16:12 GMT +.\" Date: 2015-11-16 09:01 GMT .\" Manual: \ \& .\" Source: \ \& .\" Language: English .\" -.TH "BCFTOOLS" "1" "2015\-11\-06 16:12 GMT" "\ \&" "\ \&" +.TH "BCFTOOLS" "1" "2015\-11\-16 09:01 GMT" "\ \&" "\ \&" .\" ----------------------------------------------------------------- .\" * Define some portability stuff .\" ----------------------------------------------------------------- @@ -41,7 +41,7 @@ Most commands accept VCF, bgzipped VCF and BCF with filetype detected automatica BCFtools is designed to work on a stream\&. It regards an input file "\-" as the standard input (stdin) and outputs to the standard output (stdout)\&. Several commands can thus be combined with Unix pipes\&. .SS "VERSION" .sp -This manual page was last updated \fB2015\-11\-06 16:12 GMT\fR and refers to bcftools git version \fB1\&.2\-170\-g0b9ad1a+\fR\&. +This manual page was last updated \fB2015\-11\-16 09:01 GMT\fR and refers to bcftools git version \fB1\&.2\-182\-g6710191+\fR\&. .SS "BCF1" .sp The BCF1 format output by versions of samtools <= 0\&.1\&.19 is \fBnot\fR compatible with this version of bcftools\&. To read BCF1 files one can use the view command from old versions of bcftools packaged with samtools versions <= 0\&.1\&.19 to convert to VCF, which can then be read by this version of bcftools\&. @@ -97,6 +97,19 @@ For a full list of available commands, run \fBbcftools\fR without arguments\&. F .IP \(bu 2.3 .\} +\fBcnv\fR +\&.\&. Copy Number Variation caller +.RE +.sp +.RS 4 +.ie n \{\ +\h'-04'\(bu\h'+03'\c +.\} +.el \{\ +.sp -1 +.IP \(bu 2.3 +.\} + \fBconcat\fR \&.\&. concatenate VCF/BCF files from the same set of samples .RE @@ -227,6 +240,19 @@ For a full list of available commands, run \fBbcftools\fR without arguments\&. F .IP \(bu 2.3 .\} +\fBpolysomy\fR +\&.\&. detect contaminations and whole\-chromosome aberrations +.RE +.sp +.RS 4 +.ie n \{\ +\h'-04'\(bu\h'+03'\c +.\} +.el \{\ +.sp -1 +.IP \(bu 2.3 +.\} + \fBquery\fR \&.\&. transform VCF/BCF into user\-defined formats .RE @@ -682,6 +708,131 @@ List of annotations to remove\&. Use "FILTER" to remove all filters or "FILTER/S .if n \{\ .RE .\} +.SS "bcftools cnv \fI[OPTIONS]\fR \fIFILE\fR" +.sp +Copy number variation caller, requires a VCF annotated with the Illumina\(cqs B\-allele frequency (BAF) and Log R Ratio intensity (LRR) values\&. The HMM considers the following copy number states: CN 2 (normal), 1 (single\-copy loss), 0 (complete loss), 3 (single\-copy gain)\&. +.sp +.it 1 an-trap +.nr an-no-space-flag 1 +.nr an-break-flag 1 +.br +.ps +1 +\fBGeneral Options:\fR +.RS 4 +.PP +\fB\-c, \-\-control\-sample\fR \fIstring\fR +.RS 4 +optional control sample name\&. If given, pairwise calling is performed and the +\fB\-P\fR +option can be used +.RE +.PP +\fB\-f, \-\-AF\-file\fR \fIfile\fR +.RS 4 +read allele frequencies from a tab\-delimited file with the columns CHR,POS,REF,ALT,AF +.RE +.PP +*\-o, \-\-output\-dir \fIpath\fR +.RS 4 +output directory +.RE +.PP +*\-p, \-\-plot\-threshold \fIfloat\fR +.RS 4 +call +\fBmatplotlib\fR +to produce plots for chromosomes with quality at least +\fIfloat\fR, useful for visual inspection of the calls\&. With +\fB\-p 0\fR, plots for all chromosomes will be generated\&. If not given, a +\fBmatplotlib\fR +script will be created but not called\&. +.RE +.PP +\fB\-r, \-\-regions\fR \fIchr\fR|\fIchr:pos\fR|\fIchr:from\-to\fR|\fIchr:from\-\fR[,\&...] +.RS 4 +see +\fBCommon Options\fR +.RE +.PP +\fB\-R, \-\-regions\-file\fR \fIfile\fR +.RS 4 +see +\fBCommon Options\fR +.RE +.PP +\fB\-s, \-\-query\-sample\fR \fIstring\fR +.RS 4 +query samply name +.RE +.PP +\fB\-t, \-\-targets\fR \fILIST\fR +.RS 4 +see +\fBCommon Options\fR +.RE +.PP +\fB\-T, \-\-targets\-file\fR \fIFILE\fR +.RS 4 +see +\fBCommon Options\fR +.RE +.RE +.sp +.it 1 an-trap +.nr an-no-space-flag 1 +.nr an-break-flag 1 +.br +.ps +1 +\fBHMM Options:\fR +.RS 4 +.PP +\fB\-a, \-\-aberrant\fR \fIfloat\fR[,\fIfloat\fR] +.RS 4 +fraction of aberrant cells in query and control\&. The hallmark of duplications and contaminations is the BAF value of heterozygous markers which is dependent on the fraction of aberrant cells\&. Sensitivity to smaller fractions of cells can be increased by setting +\fB\-a\fR +to a lower value\&. Note however, that this comes at the cost of increased false discovery rate\&. +.RE +.PP +\fB\-b, \-\-BAF\-weight\fR \fIfloat\fR +.RS 4 +relative contribution from BAF +.RE +.PP +\fBd, \-\-BAF\-dev\fR \fIfloat\fR[,\fIfloat\fR] +.RS 4 +expected BAF deviation in query and control, i\&.e\&. the noise observed in the data\&. +.RE +.PP +\fB\-e, \-\-err\-prob\fR \fIfloat\fR +.RS 4 +uniform error probability +.RE +.PP +\fB\-l, \-\-LRR\-weight\fR \fIfloat\fR +.RS 4 +relative contribution from LRR\&. With noisy data, this option can have big effect on the number of calls produced\&. In truly random noise (such as in simulated data), the value should be set high (1\&.0), but in the presence of systematic noise when LRR are not informative, lower values result in cleaner calls (0\&.2)\&. +.RE +.PP +\fB\-L, \-\-LRR\-smooth\-win\fR \fIint\fR +.RS 4 +reduce LRR noise by applying moving average given this window size +.RE +.PP +\fB\-O, \-\-optimize\fR \fIfloat\fR +.RS 4 +iteratively estimate the fraction of aberrant cells, down to the given fraction\&. Lowering this value from the default 1\&.0 to say, 0\&.3, can help discover more events but also increases noise +.RE +.PP +\fB\-P, \-\-same\-prob\fR \fIfloat\fR +.RS 4 +the prior probability of the query and the control sample being the same\&. Setting to 0 calls both independently, setting to 1 forces the same copy number state in both\&. +.RE +.PP +\fB\-x, \-\-xy\-prob\fR \fIfloat\fR +.RS 4 +the HMM probability of transition to another copy number state\&. Increasing this values leads to smaller and more frequent calls\&. +.RE +.RE .SS "bcftools call \fI[OPTIONS]\fR \fIFILE\fR" .sp This command replaces the former \fBbcftools view\fR caller\&. Some of the original functionality has been temporarily lost in the process of transition under htslib, but will be added back on popular demand\&. The original calling model can be invoked with the \fB\-c\fR option\&. @@ -2324,6 +2475,101 @@ void destroy(void); .RE .\} .RE +.SS "bcftools polysomy [\fIOPTIONS\fR] \fIfile\&.vcf\&.gz\fR" +.sp +Detect number of chromosomal copies in VCFs annotates with the Illumina\(cqs B\-allele frequency (BAF) values\&. Note that this command is not compiled in by default, see the section \fBOptional Compilation with GSL\fR in the INSTALL file for help\&. +.sp +.it 1 an-trap +.nr an-no-space-flag 1 +.nr an-break-flag 1 +.br +.ps +1 +\fBGeneral options:\fR +.RS 4 +.PP +\fB\-o, \-\-output\-dir\fR \fIpath\fR +.RS 4 +output directory +.RE +.PP +\fB\-r, \-\-regions\fR \fIchr\fR|\fIchr:pos\fR|\fIchr:from\-to\fR|\fIchr:from\-\fR[,\&...] +.RS 4 +see +\fBCommon Options\fR +.RE +.PP +\fB\-R, \-\-regions\-file\fR \fIfile\fR +.RS 4 +see +\fBCommon Options\fR +.RE +.PP +\fB\-s, \-\-sample\fR \fIstring\fR +.RS 4 +samply name +.RE +.PP +\fB\-t, \-\-targets\fR \fILIST\fR +.RS 4 +see +\fBCommon Options\fR +.RE +.PP +\fB\-T, \-\-targets\-file\fR \fIFILE\fR +.RS 4 +see +\fBCommon Options\fR +.RE +.PP +\fB\-v, \-\-verbose\fR +.RS 4 +verbose debugging output which gives hints about the thresholds and decisions made by the program\&. Note that the exact output can change between versions\&. +.RE +.RE +.sp +.it 1 an-trap +.nr an-no-space-flag 1 +.nr an-break-flag 1 +.br +.ps +1 +\fBAlgorithm options:\fR +.RS 4 +.PP +\fB\-b, \-\-peak\-size\fR \fIfloat\fR +.RS 4 +the minimum peak size considered as a good match can be from the interval [0,1] where larger is stricter +.RE +.PP +\fB\-c, \-\-cn\-penalty\fR \fIfloat\fR +.RS 4 +a penalty for increasing copy number state\&. How this works: multiple peaks are always a better fit than a single peak, therefore the program prefers a single peak (normal copy number) unless the absolute deviation of the multiple peaks fit is significantly smaller\&. Here the meaning of "significant" is given by the +\fIfloat\fR +from the interval [0,1] where larger is stricter\&. +.RE +.PP +\fB\-f, \-\-fit\-th\fR \fIfloat\fR +.RS 4 +threshold for goodness of fit (normalized absolute deviation), smaller is stricter +.RE +.PP +\fB\-i, \-\-include\-aa\fR +.RS 4 +include also the AA peak in CN2 and CN3 evaluation\&. This usually requires increasing +\fB\-f\fR\&. +.RE +.PP +\fB\-m, \-\-min\-fraction\fR \fIfloat\fR +.RS 4 +minimum distinguishable fraction of aberrant cells\&. The experience shows that trustworthy are estimates of 20% and more\&. +.RE +.PP +\fB\-p, \-\-peak\-symmetry\fR \fIfloat\fR +.RS 4 +a heuristics to filter failed fits where the expected peak symmetry is violated\&. The +\fIfloat\fR +is from the interval [0,1] and larger is stricter +.RE +.RE .SS "bcftools query [\fIOPTIONS\fR] \fIfile\&.vcf\&.gz\fR [\fIfile\&.vcf\&.gz\fR [\&...]]" .sp Extracts fields from VCF or BCF files and outputs them in user\-defined format\&. diff --git a/doc/bcftools.html b/doc/bcftools.html index a29a9148c..f3a14405a 100644 --- a/doc/bcftools.html +++ b/doc/bcftools.html @@ -1,6 +1,6 @@ -bcftools

    Name

    bcftools — utilities for variant calling and manipulating VCFs and BCFs.

    Synopsis

    bcftools [--version|--version-only] [--help] [COMMAND] [OPTIONS]

    DESCRIPTION

    BCFtools is a set of utilities that manipulate variant calls in the Variant +bcftools

    Name

    bcftools — utilities for variant calling and manipulating VCFs and BCFs.

    Synopsis

    bcftools [--version|--version-only] [--help] [COMMAND] [OPTIONS]

    DESCRIPTION

    BCFtools is a set of utilities that manipulate variant calls in the Variant Call Format (VCF) and its binary counterpart BCF. All commands work transparently with both VCFs and BCFs, both uncompressed and BGZF-compressed.

    Most commands accept VCF, bgzipped VCF and BCF with filetype detected automatically even when streaming from a pipe. Indexed VCF and BCF @@ -8,7 +8,7 @@ work in most, but not all situations. In general, whenever multiple VCFs are read simultaneously, they must be indexed and therefore also compressed.

    BCFtools is designed to work on a stream. It regards an input file "-" as the standard input (stdin) and outputs to the standard output (stdout). Several -commands can thus be combined with Unix pipes.

    VERSION

    This manual page was last updated 2015-11-06 16:12 GMT and refers to bcftools git version 1.2-170-g0b9ad1a+.

    BCF1

    The BCF1 format output by versions of samtools <= 0.1.19 is not +commands can thus be combined with Unix pipes.

    VERSION

    This manual page was last updated 2015-11-16 09:01 GMT and refers to bcftools git version 1.2-182-g6710191+.

    BCF1

    The BCF1 format output by versions of samtools <= 0.1.19 is not compatible with this version of bcftools. To read BCF1 files one can use the view command from old versions of bcftools packaged with samtools versions <= 0.1.19 to convert to VCF, which can then be read by @@ -23,6 +23,8 @@

  • call .. SNP/indel calling (former "view")
  • +cnv .. Copy Number Variation caller +
  • concat .. concatenate VCF/BCF files from the same set of samples
  • consensus .. create consensus sequence by applying VCF variants @@ -43,6 +45,8 @@
  • plugin .. run user-defined plugin
  • +polysomy .. detect contaminations and whole-chromosome aberrations +
  • query .. transform VCF/BCF into user-defined formats
  • reheader .. modify VCF/BCF header, change sample names @@ -342,7 +346,98 @@ bcftools annotate -a annots.tab.gz -h annots.hdr -c CHROM,FROM,TO,TAG inut.vcf # Annotate from a bed file (0-based coordinates, half-closed, half-open intervals) - bcftools annotate -a annots.bed.gz -h annots.hdr -c CHROM,FROM,TO,TAG input.vcf
  • bcftools call [OPTIONS] FILE

    This command replaces the former bcftools view caller. Some of the original + bcftools annotate -a annots.bed.gz -h annots.hdr -c CHROM,FROM,TO,TAG input.vcf

    bcftools cnv [OPTIONS] FILE

    Copy number variation caller, requires a VCF annotated with the Illumina’s +B-allele frequency (BAF) and Log R Ratio intensity (LRR) values. The HMM +considers the following copy number states: CN 2 (normal), 1 (single-copy +loss), 0 (complete loss), 3 (single-copy gain).

    General Options:

    +-c, --control-sample string +
    + optional control sample name. If given, pairwise calling is performed + and the -P option can be used +
    +-f, --AF-file file +
    + read allele frequencies from a tab-delimited file with the columns CHR,POS,REF,ALT,AF +
    +*-o, --output-dir path +
    + output directory +
    +*-p, --plot-threshold float +
    + call matplotlib to produce plots for chromosomes with quality at least float, + useful for visual inspection of the calls. With -p 0, plots for all chromosomes will be + generated. If not given, a matplotlib script will be created but not called. +
    +-r, --regions chr|chr:pos|chr:from-to|chr:from-[,…] +
    + see Common Options +
    +-R, --regions-file file +
    + see Common Options +
    +-s, --query-sample string +
    + query samply name +
    +-t, --targets LIST +
    + see Common Options +
    +-T, --targets-file FILE +
    + see Common Options +

    HMM Options:

    +-a, --aberrant float[,float] +
    + fraction of aberrant cells in query and control. The hallmark of + duplications and contaminations is the BAF value of heterozygous markers + which is dependent on the fraction of aberrant cells. Sensitivity to + smaller fractions of cells can be increased by setting -a to a lower value. Note + however, that this comes at the cost of increased false discovery rate. +
    +-b, --BAF-weight float +
    + relative contribution from BAF +
    +d, --BAF-dev float[,float] +
    + expected BAF deviation in query and control, i.e. the noise observed + in the data. +
    +-e, --err-prob float +
    + uniform error probability +
    +-l, --LRR-weight float +
    + relative contribution from LRR. With noisy data, this option can have big effect + on the number of calls produced. In truly random noise (such as in simulated data), + the value should be set high (1.0), but in the presence of systematic noise + when LRR are not informative, lower values result in cleaner calls (0.2). +
    +-L, --LRR-smooth-win int +
    + reduce LRR noise by applying moving average given this window size +
    +-O, --optimize float +
    + iteratively estimate the fraction of aberrant cells, down to the given fraction. + Lowering this value from the default 1.0 to say, 0.3, can help discover more + events but also increases noise +
    +-P, --same-prob float +
    + the prior probability of the query and the control sample being the same. + Setting to 0 calls both independently, setting to 1 forces the same copy + number state in both. +
    +-x, --xy-prob float +
    + the HMM probability of transition to another copy number state. Increasing this + values leads to smaller and more frequent calls. +

    bcftools call [OPTIONS] FILE

    This command replaces the former bcftools view caller. Some of the original functionality has been temporarily lost in the process of transition under htslib, but will be added back on popular demand. The original calling model can be invoked with the -c option.

    File format options:

    @@ -1281,7 +1376,71 @@ bcf1_t *process(bcf1_t *rec); // Called after all lines have been processed to clean up -void destroy(void);

    bcftools query [OPTIONS] file.vcf.gz [file.vcf.gz […]]

    Extracts fields from VCF or BCF files and outputs them in user-defined format.

    +void destroy(void);

    bcftools polysomy [OPTIONS] file.vcf.gz

    Detect number of chromosomal copies in VCFs annotates with the Illumina’s +B-allele frequency (BAF) values. Note that this command is not compiled +in by default, see the section Optional Compilation with GSL in the INSTALL +file for help.

    General options:

    +-o, --output-dir path +
    + output directory +
    +-r, --regions chr|chr:pos|chr:from-to|chr:from-[,…] +
    + see Common Options +
    +-R, --regions-file file +
    + see Common Options +
    +-s, --sample string +
    + samply name +
    +-t, --targets LIST +
    + see Common Options +
    +-T, --targets-file FILE +
    + see Common Options +
    +-v, --verbose +
    + verbose debugging output which gives hints about the thresholds and decisions made + by the program. Note that the exact output can change between versions. +

    Algorithm options:

    +-b, --peak-size float +
    + the minimum peak size considered as a good match can be from the interval [0,1] + where larger is stricter +
    +-c, --cn-penalty float +
    + a penalty for increasing copy number state. How this works: multiple peaks + are always a better fit than a single peak, therefore the program prefers + a single peak (normal copy number) unless the absolute deviation of the + multiple peaks fit is significantly smaller. Here the meaning of + "significant" is given by the float from the interval [0,1] where + larger is stricter. +
    +-f, --fit-th float +
    + threshold for goodness of fit (normalized absolute deviation), smaller is stricter +
    +-i, --include-aa +
    + include also the AA peak in CN2 and CN3 evaluation. This usually requires increasing -f. +
    +-m, --min-fraction float +
    + minimum distinguishable fraction of aberrant cells. The experience shows that trustworthy + are estimates of 20% and more. +
    +-p, --peak-symmetry float +
    + a heuristics to filter failed fits where the expected peak symmetry is violated. + The float is from the interval [0,1] and larger is stricter +

    bcftools query [OPTIONS] file.vcf.gz [file.vcf.gz […]]

    Extracts fields from VCF or BCF files and outputs them in user-defined format.

    -c, --collapse snps|indels|both|all|some|none
    see Common Options @@ -1389,7 +1548,7 @@ HWi = P_i(HW) P_{i+1}(AZ) = oAZ * max[(1 - tAZ * ci) * AZ{i-1} , tAZ * ci * (1-AZ{i-1})] - P_{i+1}(HW) = oHW * max[(1 - tHW * ci) * (1-AZ{i-1}) , tHW * ci * AZ{i-1}]

    General Options:

    + P_{i+1}(HW) = oHW * max[(1 - tHW * ci) * (1-AZ{i-1}) , tHW * ci * AZ{i-1}]

    General Options:

    --AF-dflt FLOAT
    in case allele frequency is not known, use the FLOAT. By default, sites where @@ -1455,7 +1614,7 @@ -T, --targets-file file
    see Common Options -

    HMM Options:

    +

    HMM Options:

    -a, --hw-to-az FLOAT
    P(AZ|HW) transition probability from AZ (autozygous) to HW (Hardy-Weinberg) state From 37b0ddc34ba17fbf58bdb96a19f4af14e7d158c5 Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Mon, 16 Nov 2015 16:09:40 +0000 Subject: [PATCH 121/211] add *.dSYM to .gitignore These files are generated on Mac OS X after 2e5fda73099ea237db5d2c0b98881509a1e81ab7 --- .gitignore | 1 + 1 file changed, 1 insertion(+) diff --git a/.gitignore b/.gitignore index 21e4d81fb..b251ae6ab 100644 --- a/.gitignore +++ b/.gitignore @@ -2,6 +2,7 @@ bcftools *.o /version.h plugins/*.so +plugins/*.dSYM plugins/*.P /test/test-rbuf From 8e8679d28a2bde33cc3a67c7afbde10b81f0b8c1 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Wed, 18 Nov 2015 13:57:25 +0000 Subject: [PATCH 122/211] Prevent empty PL fields on BCF output with "call -C alleles" --- mcall.c | 1 + 1 file changed, 1 insertion(+) diff --git a/mcall.c b/mcall.c index 67ae04482..70d617c79 100644 --- a/mcall.c +++ b/mcall.c @@ -1332,6 +1332,7 @@ static void mcall_constrain_alleles(call_t *call, bcf1_t *rec, int unseen) if ( ori_pl[k_ori]==bcf_int32_missing ) k_ori = bcf_alleles2gt(unseen,unseen); new_pl[k] = ori_pl[k_ori]; } + if ( !k && new_pl[k]==bcf_int32_vector_end ) new_pl[k]=bcf_int32_missing; } ori_pl += npls_ori; new_pl += npls_new; From 03c60cfd3c3ad5715f3795faa1101d58281a2d86 Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Thu, 19 Nov 2015 11:57:38 +0000 Subject: [PATCH 123/211] add POS as a filter column --- doc/bcftools.txt | 4 +++- filter.c | 14 +++++++++++++- test/filter.11.out | 26 ++++++++++++++++++++++++++ test/test.pl | 3 ++- 4 files changed, 44 insertions(+), 3 deletions(-) create mode 100644 test/filter.11.out diff --git a/doc/bcftools.txt b/doc/bcftools.txt index 9e4ea0d2d..9498e14a1 100644 --- a/doc/bcftools.txt +++ b/doc/bcftools.txt @@ -1945,7 +1945,7 @@ These filtering expressions are accepted by *<>*, INFO/DP or DP FORMAT/DV, FMT/DV, or DV - FILTER, QUAL, ID, REF, ALT[0] + FILTER, QUAL, ID, POS, REF, ALT[0] * 1 (or 0) to test the presence (or absence) of a flag @@ -2020,6 +2020,8 @@ not "dp" instead of "DP". MAF[0]<0.05 .. select rare variants at 5% cutoff + POS>=100 .. restrict your range query, e.g. 20:100-200 to strictly sites with POS in that range. + -- *Shell expansion:* diff --git a/filter.c b/filter.c index 924a095eb..c56ae6d12 100644 --- a/filter.c +++ b/filter.c @@ -1,6 +1,6 @@ /* filter.c -- filter expressions. - Copyright (C) 2013-2014 Genome Research Ltd. + Copyright (C) 2013-2015 Genome Research Ltd. Author: Petr Danecek @@ -364,6 +364,12 @@ static int bcf_get_info_value(bcf1_t *line, int info_id, int ivec, void *value) return -1; // this shouldn't happen } +static void filters_set_pos(filter_t *flt, bcf1_t *line, token_t *tok) +{ + tok->values[0] = line->pos+1; + tok->nvalues = 1; +} + static void filters_set_info_int(filter_t *flt, bcf1_t *line, token_t *tok) { if ( tok->idx==-2 ) @@ -1206,6 +1212,12 @@ static int filters_init1(filter_t *filter, char *str, int len, token_t *tok) tok->tag = strdup("ID"); return 0; } + else if ( !strncasecmp(str,"POS",len) ) + { + tok->setter = &filters_set_pos; + tok->tag = strdup("POS"); + return 0; + } else if ( !strncasecmp(str,"REF",len) ) { tok->setter = &filters_set_ref_string; diff --git a/test/filter.11.out b/test/filter.11.out new file mode 100644 index 000000000..8b58d6322 --- /dev/null +++ b/test/filter.11.out @@ -0,0 +1,26 @@ +##fileformat=VCFv4.1 +##FILTER= +##INFO= +##FORMAT= +##INFO= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##FILTER= +##FILTER= +##contig= +##contig= +##contig= +##contig= +##reference=file:///lustre/scratch105/projects/g1k/ref/main_project/human_g1k_v37.fasta +##readme=AAAAAA +##readme=BBBBBB +##INFO= +##INFO= +##INFO= +##INFO= +#CHROM POS ID REF ALT QUAL FILTER INFO FORMAT A B +1 3106154 . CAAA C 342 PASS AN=4;AC=2 GT:GQ:DP 0/1:245:32 0/1:25:300 +1 3106154 . C CT 59.2 PASS AN=4;AC=2 GT:GQ:DP 0/1:25:12 0/1:245:310 +1 3157410 . GA G 90.6 q10 AN=4;AC=4 GT:GQ:DP 1/1:21:21 1/1:21:21 diff --git a/test/test.pl b/test/test.pl index b23296725..b5b12e337 100755 --- a/test/test.pl +++ b/test/test.pl @@ -1,6 +1,6 @@ #!/usr/bin/env perl # -# Copyright (C) 2012-2014 Genome Research Ltd. +# Copyright (C) 2012-2015 Genome Research Ltd. # # Author: Petr Danecek # @@ -126,6 +126,7 @@ test_vcf_view($opts,in=>'view.filter',out=>'view.filter.4.out',args=>q[-H -i'FMT/FRS[1]="BB"'],reg=>''); test_vcf_view($opts,in=>'view.filter',out=>'view.filter.5.out',args=>q[-H -i'TXT0="text"'],reg=>''); test_vcf_view($opts,in=>'view.chrs',out=>'view.chrs.out',args=>'',reg=>'',tgts=>'view.chrs.tab'); +test_vcf_view($opts,in=>'filter.2',out=>'filter.11.out',args=>q[-i 'POS>=3062917'],reg=>'1:3062917-3157410'); test_vcf_filter($opts,in=>'view.filter',out=>'view.filter.6.out',args=>q[-S. -e'TXT0="text"'],reg=>''); test_vcf_filter($opts,in=>'view.filter',out=>'view.filter.7.out',args=>q[-S. -e'FMT/FRS[1]="BB"'],reg=>''); test_vcf_filter($opts,in=>'view.filter',out=>'view.filter.8.out',args=>q[-S. -e'FMT/FGS[0]="AAAAAA"'],reg=>''); From 3aa989e2191f68441f6be8d07d99d3160442f65a Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Mon, 30 Nov 2015 12:34:00 +0000 Subject: [PATCH 124/211] Fix typo: annotate -x ^FORMAT/TAG did not work --- vcfannotate.c | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/vcfannotate.c b/vcfannotate.c index 621da5739..d653bcd4d 100644 --- a/vcfannotate.c +++ b/vcfannotate.c @@ -310,7 +310,7 @@ static void init_remove_annots(args_t *args) ss = *se ? se+1 : se; } free(str.s); - if ( keep_flt || keep_info || keep_flt ) + if ( keep_flt || keep_info || keep_fmt ) { int j; for (j=0; jhdr->nhrec; j++) From 5d90843e0b271233a42fbf2579c4daa324f4dd30 Mon Sep 17 00:00:00 2001 From: mcshane Date: Mon, 7 Dec 2015 21:24:44 +0000 Subject: [PATCH 125/211] split out test input files for -c and -m calling this is to allow pulling in the bugfix from pd3/bcftools@47ab239744ab2aaf2165d1542010ba7e6ba7dafd the `-c' calling mode is not ready for PLs with missing values etc yet that are added to the test files in that commit. --- test/mpileup.c.X.vcf | 4127 ++++++++++++++++++++++++++++++++++++++++++ test/mpileup.c.vcf | 4127 ++++++++++++++++++++++++++++++++++++++++++ test/test.pl | 8 +- 3 files changed, 8258 insertions(+), 4 deletions(-) create mode 100644 test/mpileup.c.X.vcf create mode 100644 test/mpileup.c.vcf diff --git a/test/mpileup.c.X.vcf b/test/mpileup.c.X.vcf new file mode 100644 index 000000000..ea2983a3b --- /dev/null +++ b/test/mpileup.c.X.vcf @@ -0,0 +1,4127 @@ +##fileformat=VCFv4.2 +##FILTER= +##samtoolsVersion=1.1-19-g6b249e2+htslib-1.1-74-g845c515 +##samtoolsCommand=samtools mpileup -uvDV -b xxx//mpileup.bam.list -f xxx//mpileup.ref.fa.gz +##reference=file://xxx//mpileup.ref.fa.gz +##contig= +##ALT= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##FORMAT= +##FORMAT= +##FORMAT= +#CHROM POS ID REF ALT QUAL FILTER INFO FORMAT HG00100 HG00101 HG00102 +X 1 . A <*> 0 . DP=11;I16=11,0,0,0,452,18594,0,0,319,9251,0,0,223,4959,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 +X 2 . A <*> 0 . DP=11;I16=11,0,0,0,439,17587,0,0,319,9251,0,0,226,5030,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 +X 3 . G <*> 0 . DP=11;I16=11,0,0,0,431,16971,0,0,319,9251,0,0,229,5111,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 +X 4 . C <*> 0 . DP=11;I16=11,0,0,0,423,16417,0,0,319,9251,0,0,232,5202,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,71:3:0 +X 5 . T <*> 0 . DP=11;I16=11,0,0,0,450,18520,0,0,319,9251,0,0,234,5252,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 +X 6 . T <*> 0 . DP=11;I16=11,0,0,0,403,14847,0,0,319,9251,0,0,236,5310,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 +X 7 . C <*> 0 . DP=11;I16=11,0,0,0,446,18114,0,0,319,9251,0,0,237,5327,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 +X 8 . T <*> 0 . DP=11;I16=11,0,0,0,465,19677,0,0,319,9251,0,0,238,5354,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 +X 9 . C <*> 0 . DP=11;I16=11,0,0,0,447,18205,0,0,319,9251,0,0,239,5391,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 +X 10 . A <*> 0 . DP=11;I16=11,0,0,0,426,16756,0,0,319,9251,0,0,240,5438,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,69:3:0 +X 11 . C <*> 0 . DP=11;I16=11,0,0,0,413,15603,0,0,319,9251,0,0,241,5495,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 +X 12 . C <*> 0 . DP=11;I16=11,0,0,0,438,17506,0,0,319,9251,0,0,242,5562,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 +X 13 . C <*> 0 . DP=11;I16=11,0,0,0,437,17463,0,0,319,9251,0,0,243,5639,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 +X 14 . T <*> 0 . DP=11;I16=11,0,0,0,453,18715,0,0,319,9251,0,0,242,5628,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 +X 15 . G <*> 0 . DP=11;I16=11,0,0,0,439,17599,0,0,319,9251,0,0,240,5580,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 +X 16 . T <*> 0 . DP=11;I16=11,0,0,0,426,16546,0,0,319,9251,0,0,238,5544,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 +X 17 . T <*> 0 . DP=11;I16=11,0,0,0,407,15195,0,0,319,9251,0,0,235,5469,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 +X 18 . C <*> 0 . DP=12;I16=12,0,0,0,450,17136,0,0,379,12851,0,0,231,5353,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,18,113:6:0 0,9,72:3:0 0,9,72:3:0 +X 19 . C <*> 0 . DP=13;I16=13,0,0,0,502,19652,0,0,439,16451,0,0,228,5246,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,18,112:6:0 0,12,89:4:0 0,9,72:3:0 +X 20 . T <*> 0 . DP=13;I16=13,0,0,0,532,21878,0,0,439,16451,0,0,226,5150,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,18,116:6:0 0,12,98:4:0 0,9,72:3:0 +X 21 . G <*> 0 . DP=13;I16=13,0,0,0,498,19254,0,0,439,16451,0,0,224,5066,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,18,117:6:0 0,12,94:4:0 0,9,72:3:0 +X 22 . C <*> 0 . DP=13;I16=13,0,0,0,511,20289,0,0,470,19210,0,0,223,4993,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,18,115:6:0 0,12,91:4:0 0,9,76:3:0 +X 23 . A <*> 0 . DP=14;I16=14,0,0,0,513,19399,0,0,530,22810,0,0,223,4931,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,133:7:0 0,12,82:4:0 0,9,82:3:0 +X 24 . T <*> 0 . DP=14;I16=14,0,0,0,534,20540,0,0,530,22810,0,0,224,4882,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,131:7:0 0,12,96:4:0 0,9,80:3:0 +X 25 . A <*> 0 . DP=15;I16=15,0,0,0,561,21133,0,0,590,26410,0,0,225,4847,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,140:8:0 0,12,96:4:0 0,9,81:3:0 +X 26 . G <*> 0 . DP=15;I16=15,0,0,0,591,23429,0,0,590,26410,0,0,227,4827,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,151:8:0 0,12,96:4:0 0,9,81:3:0 +X 27 . A <*> 0 . DP=15;I16=15,0,0,0,588,23120,0,0,590,26410,0,0,229,4823,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,146:8:0 0,12,98:4:0 0,9,83:3:0 +X 28 . T <*> 0 . DP=16;I16=16,0,0,0,605,23001,0,0,650,30010,0,0,231,4835,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,147:8:0 0,12,97:4:0 0,12,101:4:0 +X 29 . A <*> 0 . DP=17;I16=17,0,0,0,615,22533,0,0,710,33610,0,0,234,4864,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,146:8:0 0,15,102:5:0 0,12,104:4:0 +X 30 . A <*> 0 . DP=17;I16=17,0,0,0,660,25914,0,0,710,33610,0,0,238,4912,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,149:8:0 0,15,115:5:0 0,12,108:4:0 +X 31 . T <*> 0 . DP=17;I16=17,0,0,0,656,25392,0,0,710,33610,0,0,242,4980,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,150:8:0 0,15,113:5:0 0,12,105:4:0 +X 32 . T <*> 0 . DP=17;I16=17,0,0,0,605,21789,0,0,741,36369,0,0,247,5067,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,143:8:0 0,15,104:5:0 0,12,104:4:0 +X 33 . G <*> 0 . DP=17;I16=17,0,0,0,659,25757,0,0,741,36369,0,0,252,5124,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,158:8:0 0,15,118:5:0 0,12,105:4:0 +X 34 . C <*> 0 . DP=17;I16=17,0,0,0,658,25704,0,0,741,36369,0,0,257,5203,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,151:8:0 0,15,121:5:0 0,12,106:4:0 +X 35 . A <*> 0 . DP=18;I16=18,0,0,0,677,25881,0,0,801,39969,0,0,262,5304,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,152:8:0 0,15,109:5:0 0,15,121:5:0 +X 36 . T <*> 0 . DP=18;I16=18,0,0,0,678,25796,0,0,801,39969,0,0,268,5428,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,151:8:0 0,15,114:5:0 0,15,125:5:0 +X 37 . G <*> 0 . DP=18;I16=18,0,0,0,685,26291,0,0,801,39969,0,0,274,5576,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,157:8:0 0,15,116:5:0 0,15,126:5:0 +X 38 . A <*> 0 . DP=18;I16=18,0,0,0,697,27245,0,0,801,39969,0,0,280,5748,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,152:8:0 0,15,116:5:0 0,15,129:5:0 +X 39 . C <*> 0 . DP=16;I16=16,0,0,0,591,22311,0,0,743,38287,0,0,288,5942,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,148:7:0 0,12,94:4:0 0,15,123:5:0 +X 40 . A <*> 0 . DP=16;I16=16,0,0,0,630,24896,0,0,743,38287,0,0,295,6107,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,146:7:0 0,12,104:4:0 0,15,127:5:0 +X 41 . A <*> 0 . DP=17;I16=17,0,0,0,645,24685,0,0,803,41887,0,0,302,6294,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,151:8:0 0,12,104:4:0 0,15,131:5:0 +X 42 . T <*> 0 . DP=17;I16=17,0,0,0,618,23118,0,0,803,41887,0,0,310,6504,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,155:8:0 0,12,82:4:0 0,15,127:5:0 +X 43 . T <*> 0 . DP=17;I16=17,0,0,0,631,23689,0,0,803,41887,0,0,318,6738,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,151:8:0 0,12,101:4:0 0,15,129:5:0 +X 44 . G <*> 0 . DP=17;I16=17,0,0,0,664,26162,0,0,803,41887,0,0,324,6896,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,164:8:0 0,12,100:4:0 0,15,129:5:0 +X 45 . C <*> 0 . DP=17;I16=17,0,0,0,657,25525,0,0,803,41887,0,0,329,7027,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,163:8:0 0,12,108:4:0 0,15,125:5:0 +X 46 . C <*> 0 . DP=17;I16=17,0,0,0,646,25244,0,0,803,41887,0,0,334,7180,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,161:8:0 0,12,98:4:0 0,15,131:5:0 +X 47 . T <*> 0 . DP=17;I16=17,0,0,0,700,28998,0,0,803,41887,0,0,339,7355,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,165:8:0 0,12,110:4:0 0,15,136:5:0 +X 48 . T <*> 0 . DP=17;I16=17,0,0,0,648,25020,0,0,803,41887,0,0,343,7501,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,155:8:0 0,12,105:4:0 0,15,131:5:0 +X 49 . G <*> 0 . DP=18;I16=18,0,0,0,686,26674,0,0,832,42728,0,0,346,7616,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,158:8:0 0,15,119:5:0 0,15,128:5:0 +X 50 . T <*> 0 . DP=18;I16=17,0,0,0,650,24972,0,0,772,39128,0,0,332,7426,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,155:8:0 0,12,101:4:0 0,15,128:5:0 +X 51 . C <*> 0 . DP=18;I16=18,0,0,0,681,26529,0,0,832,42728,0,0,353,7853,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,167:8:0 0,15,99:5:0 0,15,127:5:0 +X 52 . C <*> 0 . DP=18;I16=17,0,0,0,645,24983,0,0,803,41887,0,0,353,7965,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,164:8:0 0,12,99:4:0 0,15,128:5:0 +X 53 . C <*> 0 . DP=18;I16=18,0,0,0,687,26735,0,0,832,42728,0,0,359,8113,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,164:8:0 0,15,113:5:0 0,15,132:5:0 +X 54 . T <*> 0 . DP=18;I16=18,0,0,0,736,30194,0,0,832,42728,0,0,361,8219,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,163:8:0 0,15,128:5:0 0,15,136:5:0 +X 55 . G <*> 0 . DP=18;I16=18,0,0,0,674,26082,0,0,832,42728,0,0,362,8290,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,168:8:0 0,15,112:5:0 0,15,122:5:0 +X 56 . C <*> 0 . DP=18;I16=18,0,0,0,701,27645,0,0,832,42728,0,0,363,8375,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,162:8:0 0,15,121:5:0 0,15,131:5:0 +X 57 . T <*> 0 . DP=18;I16=17,0,0,0,694,29118,0,0,803,41887,0,0,356,8410,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,163:8:0 0,12,117:4:0 0,15,138:5:0 +X 58 . G <*> 0 . DP=17;I16=16,0,0,0,616,24356,0,0,774,41046,0,0,356,8454,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,159:7:0 0,12,95:4:0 0,15,131:5:0 +X 59 . A <*> 0 . DP=17;I16=17,0,0,0,656,26038,0,0,803,41887,0,0,366,8606,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,155:7:0 0,15,116:5:0 0,15,134:5:0 +X 60 . A <*> 0 . DP=17;I16=17,0,0,0,663,26463,0,0,803,41887,0,0,367,8687,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,151:7:0 0,15,127:5:0 0,15,138:5:0 +X 61 . T <*> 0 . DP=17;I16=16,0,0,0,605,23215,0,0,774,41046,0,0,355,8583,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,152:7:0 0,12,101:4:0 0,15,131:5:0 +X 62 . G <*> 0 . DP=18;I16=17,0,0,0,646,24868,0,0,834,44646,0,0,353,8557,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,158:7:0 0,12,103:4:0 0,18,141:6:0 +X 63 . T <*> 0 . DP=18;I16=17,0,0,0,590,21682,0,0,803,41887,0,0,341,8111,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,148:7:0 0,12,80:4:0 0,18,144:6:0 +X 64 . G <*> 0 . DP=19;I16=19,0,0,0,696,26416,0,0,923,49087,0,0,366,8758,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,169:8:0 0,15,103:5:0 0,18,142:6:0 +X 65 . C <*> 0 . DP=18;I16=18,0,0,0,686,26512,0,0,894,48246,0,0,367,8743,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,163:7:0 0,15,116:5:0 0,18,147:6:0 +X 66 . T <*> 0 . DP=18;I16=17,0,0,0,691,28315,0,0,834,44646,0,0,342,8068,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,164:7:0 0,12,110:4:0 0,18,153:6:0 +X 67 . C <*> 0 . DP=17;I16=17,0,0,0,645,25313,0,0,834,44646,0,0,341,7983,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,163:7:0 0,12,94:4:0 0,18,147:6:0 +X 68 . T <*> 0 . DP=17;I16=17,0,0,0,691,28307,0,0,834,44646,0,0,339,7863,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,165:7:0 0,12,108:4:0 0,18,151:6:0 +X 69 . G <*> 0 . DP=17;I16=17,0,0,0,657,25721,0,0,865,47405,0,0,338,7758,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,172:8:0 0,9,93:3:0 0,18,142:6:0 +X 70 . G <*> 0 . DP=17;I16=16,0,0,0,575,21391,0,0,836,46564,0,0,317,7227,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,162:8:0 0,6,64:2:0 0,18,141:6:0 +X 71 . G <*> 0 . DP=17;I16=15,0,0,0,571,21975,0,0,776,42964,0,0,307,7029,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,170:8:0 0,6,72:2:0 0,15,130:5:0 +X 72 . G <*> 0 . DP=17;I16=15,0,0,0,572,22002,0,0,776,42964,0,0,305,6907,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,171:8:0 0,6,65:2:0 0,15,131:5:0 +X 73 . T <*> 0 . DP=18;I16=16,0,0,0,623,25301,0,0,836,46564,0,0,314,6918,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,158:8:0 0,6,94:2:0 0,18,143:6:0 +X 74 . C <*> 0 . DP=18;I16=17,0,0,0,674,28110,0,0,865,47405,0,0,338,7468,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,176:8:0 0,9,106:3:0 0,18,141:6:0 +X 75 . T <*> 0 . DP=18;I16=16,0,0,0,685,30675,0,0,836,46564,0,0,312,6782,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,175:8:0 0,6,90:2:0 0,18,150:6:0 +X 76 . C <*> 0 . DP=18;I16=17,0,0,0,683,29481,0,0,865,47405,0,0,336,7360,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,174:8:0 0,9,98:3:0 0,18,148:6:0 +X 77 . T <*> 0 . DP=18;I16=16,0,0,0,710,33072,0,0,836,46564,0,0,310,6702,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,179:8:0 0,6,92:2:0 0,18,154:6:0 +X 78 . G <*> 0 . DP=18;I16=16,0,0,0,692,31158,0,0,836,46564,0,0,309,6683,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,180:8:0 0,6,94:2:0 0,18,149:6:0 +X 79 . G <*> 0 . DP=18;I16=15,0,0,0,605,26629,0,0,776,42964,0,0,283,6053,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,168:8:0 0,3,60:1:0 0,18,149:6:0 +X 80 . G <*> 0 . DP=18;I16=17,0,0,0,688,30128,0,0,865,47405,0,0,332,7312,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,173:8:0 0,9,106:3:0 0,18,151:6:0 +X 81 . G <*> 0 . DP=18;I16=16,0,0,0,631,27429,0,0,836,46564,0,0,326,7310,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,165:7:0 0,9,97:3:0 0,18,145:6:0 +X 82 . T <*> 0 . DP=18;I16=15,0,0,0,559,22735,0,0,776,42964,0,0,280,6122,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,154:8:0 0,3,60:1:0 0,18,131:6:0 +X 83 . C <*> 0 . DP=18;I16=16,0,0,0,622,27146,0,0,836,46564,0,0,304,6798,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,170:8:0 0,6,75:2:0 0,18,145:6:0 +X 84 . T <*> 0 . DP=18;I16=17,0,0,0,705,32445,0,0,865,47405,0,0,328,7488,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,181:8:0 0,9,85:3:0 0,18,154:6:0 +X 85 . C <*> 0 . DP=18;I16=17,0,0,0,708,31222,0,0,865,47405,0,0,327,7567,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,181:8:0 0,9,108:3:0 0,18,153:6:0 +X 86 . A <*> 0 . DP=18;I16=17,0,0,0,692,29540,0,0,865,47405,0,0,326,7660,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,169:8:0 0,9,111:3:0 0,18,149:6:0 +X 87 . C <*> 0 . DP=18;I16=17,0,0,0,683,29493,0,0,896,50164,0,0,326,7766,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,174:8:0 0,9,103:3:0 0,18,148:6:0 +X 88 . C <*> 0 . DP=18;I16=17,0,0,0,703,31005,0,0,896,50164,0,0,326,7834,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,174:8:0 0,9,113:3:0 0,18,153:6:0 +X 89 . C <*> 0 . DP=18;I16=17,0,0,0,697,30875,0,0,896,50164,0,0,326,7914,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,176:8:0 0,9,103:3:0 0,18,154:6:0 +X 90 . A <*> 0 . DP=17;I16=16,0,0,0,668,29732,0,0,867,49323,0,0,326,7954,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,173:8:0 0,9,114:3:0 0,15,138:5:0 +X 91 . C <*> 0 . DP=16;I16=15,0,0,0,613,26409,0,0,838,48482,0,0,327,8001,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,170:7:0 0,9,113:3:0 0,15,133:5:0 +X 92 . G <*> 0 . DP=16;I16=15,0,0,0,499,18731,0,0,838,48482,0,0,328,8054,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,143:7:0 0,9,100:3:0 0,15,96:5:0 +X 93 . A <*> 0 . DP=16;I16=15,0,0,0,635,28655,0,0,869,51241,0,0,329,8063,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,167:7:0 0,9,108:3:0 0,15,145:5:0 +X 94 . C <*> 0 . DP=16;I16=15,0,0,0,607,25893,0,0,869,51241,0,0,331,8079,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,166:7:0 0,9,105:3:0 0,15,135:5:0 +X 95 . C <*> 0 . DP=17;I16=15,0,0,0,615,26761,0,0,900,54000,0,0,306,7378,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,178:8:0 0,6,91:2:0 0,15,135:5:0 +X 96 . A <*> 0 . DP=17;I16=16,0,0,0,625,26705,0,0,929,54841,0,0,332,7936,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,172:8:0 0,9,99:3:0 0,15,134:5:0 +X 97 . A <*> 0 . DP=18;I16=17,0,0,0,675,29017,0,0,958,55682,0,0,333,7879,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,179:9:0 0,9,104:3:0 0,15,145:5:0 +X 98 . C <*> 0 . DP=18;I16=17,0,0,0,655,27231,0,0,958,55682,0,0,333,7735,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,179:9:0 0,9,105:3:0 0,15,131:5:0 +X 99 . T <*> 0 . DP=18;I16=17,0,0,0,720,32840,0,0,958,55682,0,0,333,7607,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,186:9:0 0,9,115:3:0 0,15,153:5:0 +X 100 . C <*> 0 . DP=18;I16=17,0,0,0,688,29762,0,0,958,55682,0,0,332,7446,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,189:9:0 0,9,108:3:0 0,15,134:5:0 +X 101 . C <*> 0 . DP=18;I16=17,0,0,0,650,27530,0,0,958,55682,0,0,331,7303,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,182:9:0 0,9,99:3:0 0,15,132:5:0 +X 102 . C <*> 0 . DP=18;I16=17,0,0,0,695,30453,0,0,958,55682,0,0,330,7178,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,188:9:0 0,9,111:3:0 0,15,139:5:0 +X 103 . T <*> 0 . DP=18;I16=16,0,0,0,692,31998,0,0,929,54841,0,0,323,7035,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,189:8:0 0,9,108:3:0 0,15,147:5:0 +X 104 . G <*> 0 . DP=18;I16=15,0,0,0,611,26723,0,0,900,54000,0,0,295,6259,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,178:8:0 0,6,89:2:0 0,15,133:5:0 +X 105 . G <*> 0 . DP=19;I16=17,0,0,0,604,23936,0,0,989,58441,0,0,317,6751,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,170:9:0 0,9,97:3:0 0,15,125:5:0 +X 106 . G <*> 0 . DP=19;I16=17,0,0,0,644,26574,0,0,989,58441,0,0,299,6093,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,30,190:10:0 0,6,85:2:0 0,15,124:5:0 +X 107 . C <*> 0 . DP=19;I16=17,0,0,0,694,30064,0,0,989,58441,0,0,313,6543,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,192:9:0 0,9,108:3:0 0,15,136:5:0 +X 108 . C <*> 0 . DP=19;I16=17,0,0,0,692,30148,0,0,989,58441,0,0,310,6420,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,190:9:0 0,9,108:3:0 0,15,135:5:0 +X 109 . T <*> 0 . DP=19;I16=17,0,0,0,741,34273,0,0,989,58441,0,0,307,6319,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,195:9:0 0,9,110:3:0 0,15,150:5:0 +X 110 . G <*> 0 . DP=19;I16=17,0,0,0,704,31276,0,0,989,58441,0,0,304,6240,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,194:9:0 0,9,104:3:0 0,15,136:5:0 +X 111 . G <*> 0 . DP=19;I16=16,0,0,0,584,24362,0,0,929,54841,0,0,272,5416,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,30,167:10:0 0,6,88:2:0 0,12,118:4:0 +X 112 . C <*> 0 . DP=19;I16=17,0,0,0,680,29854,0,0,989,58441,0,0,296,6052,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,191:9:0 0,9,95:3:0 0,15,135:5:0 +X 113 . A <*> 0 . DP=19;I16=16,0,0,0,645,28035,0,0,960,57600,0,0,266,5318,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,176:9:0 0,6,87:2:0 0,15,139:5:0 +X 114 . C <*> 0 . DP=19;I16=17,0,0,0,674,28788,0,0,989,58441,0,0,286,5856,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,182:9:0 0,9,103:3:0 0,15,133:5:0 +X 115 . C <*> 0 . DP=21;I16=18,0,0,0,708,30546,0,0,1049,62041,0,0,274,5490,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,30,189:10:0 0,6,89:2:0 0,18,147:6:0 +X 116 . A <*> 0 . DP=21;I16=17,1,0,0,727,31755,0,0,1049,62041,0,0,253,5079,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,183:9:0 0,6,90:2:0 0,21,175:7:0 +X 117 . G <*> 0 . DP=21;I16=17,1,0,0,723,31221,0,0,1049,62041,0,0,249,5019,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,186:9:0 0,6,86:2:0 0,21,177:7:0 +X 118 . G <*> 0 . DP=20;I16=16,1,0,0,636,26574,0,0,958,55682,0,0,266,5426,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,175:9:0 0,3,60:1:0 0,21,162:7:0 +X 119 . G <*> 0 . DP=19;I16=16,1,0,0,629,26439,0,0,958,55682,0,0,267,5553,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,175:8:0 0,6,73:2:0 0,21,160:7:0 +X 120 . A <*> 0 . DP=19;I16=16,1,0,0,672,29188,0,0,958,55682,0,0,264,5518,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,175:8:0 0,6,83:2:0 0,21,171:7:0 +X 121 . G <*> 0 . DP=19;I16=16,1,0,0,662,28460,0,0,958,55682,0,0,260,5454,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,181:8:0 0,6,80:2:0 0,21,168:7:0 +X 122 . C <*> 0 . DP=20;I16=17,1,0,0,716,31224,0,0,1018,59282,0,0,256,5410,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,181:8:0 0,9,99:3:0 0,21,178:7:0 +X 123 . T <*> 0 . DP=18;I16=15,1,0,0,661,29997,0,0,898,52082,0,0,255,5385,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,167:7:0 0,9,112:3:0 0,18,166:6:0 +X 124 . T <*> 0 . DP=19;I16=17,1,0,0,626,24802,0,0,987,56523,0,0,279,6003,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,154:9:0 0,9,104:3:0 0,18,154:6:0 +X 125 . A <*> 0 . DP=18;I16=15,1,0,0,611,25689,0,0,898,52082,0,0,254,5340,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,154:7:0 0,9,104:3:0 0,18,162:6:0 +X 126 . A <*> 0 . DP=18;I16=16,1,0,0,648,27366,0,0,927,52923,0,0,279,5947,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,162:8:0 0,9,107:3:0 0,18,174:6:0 +X 127 . C <*> 0 . DP=18;I16=16,1,0,0,646,26972,0,0,927,52923,0,0,279,5949,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,163:8:0 0,9,109:3:0 0,18,160:6:0 +X 128 . A <*> 0 . DP=18;I16=16,1,0,0,673,28797,0,0,927,52923,0,0,279,5971,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,169:8:0 0,9,111:3:0 0,18,162:6:0 +X 129 . A <*> 0 . DP=17;I16=15,1,0,0,645,27891,0,0,867,49323,0,0,280,6012,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,168:8:0 0,9,113:3:0 0,15,159:5:0 +X 130 . A <*> 0 . DP=17;I16=15,1,0,0,641,27295,0,0,867,49323,0,0,281,6071,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,169:8:0 0,9,113:3:0 0,15,152:5:0 +X 131 . C <*> 0 . DP=16;I16=14,1,0,0,606,25732,0,0,838,48482,0,0,256,5472,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,167:7:0 0,9,110:3:0 0,15,147:5:0 +X 132 . A <*> 0 . DP=16;I16=14,1,0,0,627,27579,0,0,838,48482,0,0,256,5514,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,169:7:0 0,9,110:3:0 0,15,151:5:0 +X 133 . T <*> 0 . DP=15;I16=13,2,0,0,584,22816,0,0,838,48482,0,0,282,6196,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL:DP:DV 0,21,163:7:0 0,9,105:3:0 0,15,150:5:0 +X 134 . C <*> 0 . DP=15;I16=13,2,0,0,607,24653,0,0,838,48482,0,0,283,6267,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL:DP:DV 0,21,177:7:0 0,9,105:3:0 0,15,152:5:0 +X 135 . T <*> 0 . DP=15;I16=13,2,0,0,600,24178,0,0,838,48482,0,0,284,6352,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL:DP:DV 0,21,173:7:0 0,9,106:3:0 0,15,156:5:0 +X 136 . G <*> 0 . DP=15;I16=13,2,0,0,574,22258,0,0,838,48482,0,0,286,6450,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL:DP:DV 0,21,172:7:0 0,9,105:3:0 0,15,134:5:0 +X 137 . T <*> 0 . DP=15;I16=13,2,0,0,563,21377,0,0,838,48482,0,0,289,6561,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL:DP:DV 0,21,160:7:0 0,9,104:3:0 0,15,139:5:0 +X 138 . C <*> 0 . DP=15;I16=13,2,0,0,584,23088,0,0,838,48482,0,0,291,6637,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL:DP:DV 0,21,172:7:0 0,9,108:3:0 0,15,142:5:0 +X 139 . C <*> 0 . DP=15;I16=13,2,0,0,554,20790,0,0,838,48482,0,0,292,6680,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL:DP:DV 0,21,161:7:0 0,9,106:3:0 0,15,143:5:0 +X 140 . A <*> 0 . DP=15;I16=13,2,0,0,583,22789,0,0,838,48482,0,0,292,6690,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL:DP:DV 0,21,163:7:0 0,9,107:3:0 0,15,153:5:0 +X 141 . G <*> 0 . DP=14;I16=12,2,0,0,534,20750,0,0,778,44882,0,0,292,6664,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL:DP:DV 0,18,158:6:0 0,9,108:3:0 0,15,142:5:0 +X 142 . C <*> 0 . DP=14;I16=12,2,0,0,503,18593,0,0,778,44882,0,0,292,6650,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL:DP:DV 0,18,157:6:0 0,9,97:3:0 0,15,129:5:0 +X 143 . G <*> 0 . DP=14;I16=11,2,0,0,415,13657,0,0,718,41282,0,0,285,6599,0,0;QS=3,0;MQSB=0.590909;MQ0F=0 PL:DP:DV 0,18,128:6:0 0,9,95:3:0 0,12,97:4:0 +X 144 . A <*> 0 . DP=14;I16=12,2,0,0,519,19725,0,0,778,44882,0,0,291,6609,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL:DP:DV 0,18,152:6:0 0,9,105:3:0 0,15,129:5:0 +X 145 . A <*> 0 . DP=14;I16=12,2,0,0,527,20289,0,0,778,44882,0,0,290,6584,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL:DP:DV 0,18,153:6:0 0,9,106:3:0 0,15,138:5:0 +X 146 . T <*> 0 . DP=14;I16=12,2,0,0,514,19484,0,0,778,44882,0,0,289,6573,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL:DP:DV 0,18,152:6:0 0,9,103:3:0 0,15,128:5:0 +X 147 . A <*> 0 . DP=14;I16=12,2,0,0,515,19213,0,0,778,44882,0,0,288,6576,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL:DP:DV 0,18,150:6:0 0,9,99:3:0 0,15,140:5:0 +X 148 . C <*> 0 . DP=14;I16=12,2,0,0,541,21019,0,0,778,44882,0,0,286,6542,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL:DP:DV 0,18,157:6:0 0,9,106:3:0 0,15,146:5:0 +X 149 . C <*> 0 . DP=14;I16=12,2,0,0,512,19326,0,0,778,44882,0,0,283,6471,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL:DP:DV 0,18,148:6:0 0,9,109:3:0 0,15,140:5:0 +X 150 . T <*> 0 . DP=13;I16=11,2,0,0,511,20251,0,0,749,44041,0,0,280,6362,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,18,153:6:0 0,6,84:2:0 0,15,152:5:0 +X 151 . G <*> 0 . DP=13;I16=11,2,0,0,506,19826,0,0,749,44041,0,0,277,6263,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,18,157:6:0 0,6,84:2:0 0,15,144:5:0 +X 152 . C <*> 0 . DP=14;I16=12,2,0,0,543,21283,0,0,809,47641,0,0,274,6174,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,21,168:7:0 0,6,84:2:0 0,15,146:5:0 +X 153 . A <*> 0 . DP=14;I16=12,2,0,0,536,20594,0,0,809,47641,0,0,272,6096,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,21,156:7:0 0,6,81:2:0 0,15,153:5:0 +X 154 . T <*> 0 . DP=14;I16=12,2,0,0,523,20051,0,0,809,47641,0,0,270,6030,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,21,159:7:0 0,6,83:2:0 0,15,139:5:0 +X 155 . C <*> 0 . DP=14;I16=12,2,0,0,542,21254,0,0,809,47641,0,0,268,5976,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,21,172:7:0 0,6,85:2:0 0,15,139:5:0 +X 156 . C <*> 0 . DP=14;I16=12,2,0,0,536,20884,0,0,809,47641,0,0,266,5934,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,21,163:7:0 0,6,84:2:0 0,15,150:5:0 +X 157 . C <*> 0 . DP=14;I16=12,2,0,0,555,22081,0,0,809,47641,0,0,264,5904,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,21,169:7:0 0,6,85:2:0 0,15,149:5:0 +X 158 . T <*> 0 . DP=14;I16=12,2,0,0,568,23154,0,0,809,47641,0,0,262,5886,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,21,170:7:0 0,6,84:2:0 0,15,159:5:0 +X 159 . A <*> 0 . DP=15;I16=12,2,0,0,519,19467,0,0,809,47641,0,0,260,5880,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,21,157:7:0 0,6,83:2:0 0,15,135:5:0 +X 160 . G <*> 0 . DP=15;I16=13,2,0,0,547,20633,0,0,869,51241,0,0,259,5887,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,21,165:7:0 0,6,85:2:0 0,18,139:6:0 +X 161 . A <*> 0 . DP=15;I16=13,2,0,0,568,21610,0,0,869,51241,0,0,258,5908,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,21,157:7:0 0,6,83:2:0 0,18,162:6:0 +X 162 . A <*> 0 . DP=15;I16=13,2,0,0,557,21139,0,0,869,51241,0,0,255,5843,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,21,147:7:0 0,6,87:2:0 0,18,167:6:0 +X 163 . G <*> 0 . DP=14;I16=12,2,0,0,503,18645,0,0,809,47641,0,0,253,5791,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,21,153:7:0 0,6,79:2:0 0,15,138:5:0 +X 164 . T <*> 0 . DP=14;I16=12,2,0,0,460,15968,0,0,809,47641,0,0,252,5750,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,18,131:6:0 0,6,79:2:0 0,18,136:6:0 +X 165 . G <*> 0 . DP=14;I16=10,2,0,0,456,17460,0,0,689,40441,0,0,226,5094,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,18,149:6:0 0,6,80:2:0 0,12,122:4:0 +X 166 . A <*> 0 . DP=14;I16=11,2,0,0,496,19138,0,0,749,44041,0,0,227,5077,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,18,145:6:0 0,6,82:2:0 0,15,148:5:0 +X 167 . A <*> 0 . DP=14;I16=11,2,0,0,477,17851,0,0,749,44041,0,0,227,5071,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,18,132:6:0 0,6,86:2:0 0,15,147:5:0 +X 168 . G <*> 0 . DP=14;I16=12,2,0,0,481,18015,0,0,809,47641,0,0,252,5702,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,18,145:6:0 0,6,82:2:0 0,18,140:6:0 +X 169 . C <*> 0 . DP=13;I16=10,2,0,0,402,14224,0,0,689,40441,0,0,227,5045,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,15,106:5:0 0,6,76:2:0 0,15,145:5:0 +X 170 . C <*> 0 . DP=13;I16=11,2,0,0,447,16383,0,0,749,44041,0,0,251,5601,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,15,128:5:0 0,6,80:2:0 0,18,143:6:0 +X 171 . A <*> 0 . DP=13;I16=11,2,0,0,500,19366,0,0,749,44041,0,0,250,5546,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,15,134:5:0 0,6,81:2:0 0,18,166:6:0 +X 172 . C <*> 0 . DP=13;I16=10,2,0,0,439,16395,0,0,689,40441,0,0,241,5441,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,15,138:5:0 0,6,75:2:0 0,15,129:5:0 +X 173 . C <*> 0 . DP=13;I16=11,2,0,0,435,15225,0,0,749,44041,0,0,248,5478,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,15,121:5:0 0,6,76:2:0 0,18,146:6:0 +X 174 . G <*> 0 . DP=13;I16=11,1,0,0,351,10685,0,0,689,40441,0,0,238,5364,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,15,111:5:0 0,3,27:1:0 0,18,117:6:0 +X 175 . C <*> 0 . DP=14;I16=13,1,0,0,511,19161,0,0,809,47641,0,0,249,5463,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,143:6:0 0,3,41:1:0 0,21,175:7:0 +X 176 . C <*> 0 . DP=14;I16=13,1,0,0,489,17733,0,0,809,47641,0,0,251,5477,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,146:6:0 0,3,44:1:0 0,21,152:7:0 +X 177 . C <*> 0 . DP=14;I16=13,1,0,0,488,17328,0,0,809,47641,0,0,253,5507,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,138:6:0 0,3,44:1:0 0,21,158:7:0 +X 178 . A <*> 0 . DP=14;I16=13,1,0,0,519,19485,0,0,809,47641,0,0,254,5502,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,147:6:0 0,3,42:1:0 0,21,172:7:0 +X 179 . A <*> 0 . DP=14;I16=13,1,0,0,478,17278,0,0,809,47641,0,0,255,5511,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,134:6:0 0,3,44:1:0 0,21,170:7:0 +X 180 . A <*> 0 . DP=14;I16=12,1,0,0,425,14653,0,0,749,44041,0,0,250,5498,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,126:6:0 0,3,43:1:0 0,18,148:6:0 +X 181 . G <*> 0 . DP=14;I16=11,1,0,0,450,17152,0,0,689,40441,0,0,233,5233,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,156:6:0 0,3,41:1:0 0,15,138:5:0 +X 182 . A <*> 0 . DP=15;I16=14,1,0,0,515,18235,0,0,869,51241,0,0,258,5622,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,150:7:0 0,3,43:1:0 0,21,159:7:0 +X 183 . C <*> 0 . DP=15;I16=13,1,0,0,483,17419,0,0,809,47641,0,0,235,5063,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,159:7:0 0,3,40:1:0 0,18,139:6:0 +X 184 . A <*> 0 . DP=15;I16=14,1,0,0,535,19667,0,0,869,51241,0,0,262,5770,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,158:7:0 0,3,41:1:0 0,21,163:7:0 +X 185 . C <*> 0 . DP=15;I16=13,1,0,0,487,17295,0,0,809,47641,0,0,238,5192,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,150:7:0 0,3,38:1:0 0,18,160:6:0 +X 186 . G <*> 0 . DP=15;I16=12,1,0,0,381,11429,0,0,749,44041,0,0,239,5253,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,117:6:0 0,3,32:1:0 0,18,124:6:0 +X 187 . C <*> 0 . DP=14;I16=13,1,0,0,511,18979,0,0,809,47641,0,0,266,5952,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,147:6:0 0,3,38:1:0 0,21,172:7:0 +X 188 . C <*> 0 . DP=14;I16=13,1,0,0,496,18042,0,0,809,47641,0,0,267,5989,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,147:6:0 0,3,37:1:0 0,21,162:7:0 +X 189 . C <*> 0 . DP=15;I16=13,2,0,0,552,20504,0,0,838,48482,0,0,268,6040,0,0;QS=3,0;MQSB=0;MQ0F=0 PL:DP:DV 0,18,152:6:0 0,6,67:2:0 0,21,167:7:0 +X 190 . A <*> 0 . DP=15;I16=12,2,0,0,500,18230,0,0,778,44882,0,0,243,5381,0,0;QS=3,0;MQSB=0;MQ0F=0 PL:DP:DV 0,18,138:6:0 0,6,68:2:0 0,18,159:6:0 +X 191 . T <*> 0 . DP=15;I16=13,2,0,0,534,19276,0,0,838,48482,0,0,267,5939,0,0;QS=3,0;MQSB=0;MQ0F=0 PL:DP:DV 0,18,143:6:0 0,6,67:2:0 0,21,169:7:0 +X 192 . G <*> 0 . DP=15;I16=13,2,0,0,499,17439,0,0,838,48482,0,0,266,5890,0,0;QS=3,0;MQSB=0;MQ0F=0 PL:DP:DV 0,18,143:6:0 0,6,67:2:0 0,21,151:7:0 +X 193 . T <*> 0 . DP=15;I16=13,2,0,0,505,17811,0,0,838,48482,0,0,265,5859,0,0;QS=3,0;MQSB=0;MQ0F=0 PL:DP:DV 0,18,140:6:0 0,6,63:2:0 0,21,157:7:0 +X 194 . C <*> 0 . DP=14;I16=12,2,0,0,467,16569,0,0,778,44882,0,0,265,5845,0,0;QS=3,0;MQSB=0;MQ0F=0 PL:DP:DV 0,18,142:6:0 0,6,67:2:0 0,18,145:6:0 +X 195 . C <*> 0 . DP=14;I16=11,3,0,0,503,18647,0,0,747,42123,0,0,266,5846,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:DV 0,18,159:6:0 0,6,71:2:0 0,18,160:6:0 +X 196 . A <*> 0 . DP=14;I16=11,3,0,0,482,17400,0,0,747,42123,0,0,268,5862,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:DV 0,18,166:6:0 0,6,69:2:0 0,18,138:6:0 +X 197 . G <*> 0 . DP=14;I16=11,3,0,0,481,17391,0,0,747,42123,0,0,270,5894,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:DV 0,18,164:6:0 0,6,68:2:0 0,18,134:6:0 +X 198 . C <*> 0 . DP=14;I16=11,3,0,0,539,20957,0,0,747,42123,0,0,271,5893,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:DV 0,18,172:6:0 0,6,70:2:0 0,18,164:6:0 +X 199 . T <*> 0 . DP=14;I16=11,3,0,0,505,19197,0,0,747,42123,0,0,271,5861,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:DV 0,18,162:6:0 0,6,73:2:0 0,18,154:6:0 +X 200 . T <*> 0 . DP=15;I16=11,4,0,0,544,19918,0,0,776,42964,0,0,270,5798,0,0;QS=3,0;MQSB=0.0161635;MQ0F=0 PL:DP:DV 0,18,161:6:0 0,9,89:3:0 0,18,154:6:0 +X 201 . A <*> 0 . DP=16;I16=12,4,0,0,568,20416,0,0,836,46564,0,0,269,5703,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,171:7:0 0,9,89:3:0 0,18,157:6:0 +X 202 . A <*> 0 . DP=16;I16=12,4,0,0,566,20590,0,0,836,46564,0,0,269,5627,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,178:7:0 0,9,84:3:0 0,18,163:6:0 +X 203 . C <*> 0 . DP=16;I16=12,4,0,0,557,20119,0,0,836,46564,0,0,269,5571,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,166:7:0 0,9,90:3:0 0,18,153:6:0 +X 204 . C <*> 0 . DP=16;I16=12,4,0,0,591,22379,0,0,836,46564,0,0,269,5535,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,173:7:0 0,9,91:3:0 0,18,163:6:0 +X 205 . T <*> 0 . DP=16;I16=12,4,0,0,635,25281,0,0,836,46564,0,0,269,5519,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,188:7:0 0,9,95:3:0 0,18,173:6:0 +X 206 . G <*> 0 . DP=16;I16=12,4,0,0,577,21337,0,0,836,46564,0,0,269,5523,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,180:7:0 0,9,89:3:0 0,18,143:6:0 +X 207 . C <*> 0 . DP=16;I16=12,4,0,0,574,21076,0,0,836,46564,0,0,269,5547,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,179:7:0 0,9,93:3:0 0,18,151:6:0 +X 208 . A <*> 0 . DP=16;I16=12,4,0,0,576,21486,0,0,836,46564,0,0,268,5540,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,184:7:0 0,9,93:3:0 0,18,154:6:0 +X 209 . T <*> 0 . DP=16;I16=12,4,0,0,567,20475,0,0,836,46564,0,0,267,5551,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,173:7:0 0,9,91:3:0 0,18,146:6:0 +X 210 . C <*> 0 . DP=16;I16=12,4,0,0,577,21109,0,0,836,46564,0,0,266,5580,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,185:7:0 0,9,92:3:0 0,18,151:6:0 +X 211 . C <*> 0 . DP=16;I16=12,4,0,0,563,20227,0,0,836,46564,0,0,265,5627,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,172:7:0 0,9,92:3:0 0,18,153:6:0 +X 212 . C <*> 0 . DP=16;I16=12,4,0,0,589,22179,0,0,836,46564,0,0,263,5643,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,181:7:0 0,9,92:3:0 0,18,152:6:0 +X 213 . T <*> 0 . DP=16;I16=12,4,0,0,598,22838,0,0,836,46564,0,0,262,5678,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,181:7:0 0,9,95:3:0 0,18,165:6:0 +X 214 . A <*> 0 . DP=16;I16=11,4,0,0,529,19401,0,0,776,42964,0,0,240,5248,0,0;QS=3,0;MQSB=0.0161635;MQ0F=0 PL:DP:DV 0,21,176:7:0 0,9,92:3:0 0,15,118:5:0 +X 215 . G <*> 0 . DP=15;I16=12,3,0,0,521,19073,0,0,807,45723,0,0,262,5754,0,0;QS=3,0;MQSB=0.0342181;MQ0F=0 PL:DP:DV 0,21,185:7:0 0,9,90:3:0 0,15,105:5:0 +X 216 . A <*> 0 . DP=14;I16=10,3,0,0,464,16900,0,0,687,38523,0,0,238,5166,0,0;QS=3,0;MQSB=0.040184;MQ0F=0 PL:DP:DV 0,21,173:7:0 0,9,92:3:0 0,9,81:3:0 +X 217 . A <*> 0 . DP=14;I16=11,3,0,0,515,19433,0,0,747,42123,0,0,264,5842,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:DV 0,21,181:7:0 0,9,90:3:0 0,12,97:4:0 +X 218 . G <*> 0 . DP=14;I16=11,3,0,0,507,18957,0,0,747,42123,0,0,265,5907,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:DV 0,21,178:7:0 0,9,90:3:0 0,12,110:4:0 +X 219 . T <*> 0 . DP=14;I16=11,3,0,0,470,16286,0,0,747,42123,0,0,266,5986,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:DV 0,21,173:7:0 0,9,88:3:0 0,12,89:4:0 +X 220 . G <*> 0 . DP=14;I16=10,3,0,0,485,18307,0,0,687,38523,0,0,242,5454,0,0;QS=3,0;MQSB=0.040184;MQ0F=0 PL:DP:DV 0,21,188:7:0 0,9,88:3:0 0,9,80:3:0 +X 221 . A <*> 0 . DP=14;I16=11,3,0,0,487,17615,0,0,747,42123,0,0,267,6135,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:DV 0,21,176:7:0 0,9,88:3:0 0,12,101:4:0 +X 222 . A <*> 0 . DP=14;I16=10,3,0,0,465,17367,0,0,687,38523,0,0,242,5578,0,0;QS=3,0;MQSB=0.040184;MQ0F=0 PL:DP:DV 0,21,186:7:0 0,9,85:3:0 0,9,69:3:0 +X 223 . G <*> 0 . DP=13;I16=9,3,0,0,405,14327,0,0,627,34923,0,0,243,5657,0,0;QS=3,0;MQSB=0.0443614;MQ0F=0 PL:DP:DV 0,18,168:6:0 0,6,53:2:0 0,12,81:4:0 +X 224 . G <*> 0 . DP=12;I16=9,3,0,0,379,12759,0,0,627,34923,0,0,270,6370,0,0;QS=3,0;MQSB=0.0443614;MQ0F=0 PL:DP:DV 0,18,168:6:0 0,6,50:2:0 0,12,70:4:0 +X 225 . C <*> 0 . DP=12;I16=8,3,0,0,382,13896,0,0,567,31323,0,0,261,6345,0,0;QS=3,0;MQSB=0.0497871;MQ0F=0 PL:DP:DV 0,18,165:6:0 0,6,48:2:0 0,9,83:3:0 +X 226 . A <*> 0 . DP=13;I16=8,3,0,0,381,13669,0,0,567,31323,0,0,248,5894,0,0;QS=3,0;MQSB=0.0497871;MQ0F=0 PL:DP:DV 0,18,166:6:0 0,6,53:2:0 0,9,84:3:0 +X 227 . C <*> 0 . DP=13;I16=8,4,0,0,406,14306,0,0,596,32164,0,0,267,6253,0,0;QS=3,0;MQSB=0.0249144;MQ0F=0 PL:DP:DV 0,21,190:7:0 0,6,53:2:0 0,9,73:3:0 +X 228 . C <*> 0 . DP=13;I16=9,4,0,0,417,14381,0,0,656,35764,0,0,292,6884,0,0;QS=3,0;MQSB=0.0211283;MQ0F=0 PL:DP:DV 0,21,187:7:0 0,6,45:2:0 0,12,96:4:0 +X 229 . G <*> 0 . DP=13;I16=9,3,0,0,358,11424,0,0,627,34923,0,0,270,6414,0,0;QS=3,0;MQSB=0.0443614;MQ0F=0 PL:DP:DV 0,18,136:6:0 0,6,53:2:0 0,12,70:4:0 +X 230 . C <*> 0 . DP=13;I16=9,4,0,0,461,16861,0,0,656,35764,0,0,292,6920,0,0;QS=3,0;MQSB=0.0211283;MQ0F=0 PL:DP:DV 0,21,186:7:0 0,6,53:2:0 0,12,100:4:0 +X 231 . C <*> 0 . DP=13;I16=7,4,0,0,414,15832,0,0,536,28564,0,0,247,5925,0,0;QS=3,0;MQSB=0.0401934;MQ0F=0 PL:DP:DV 0,18,184:6:0 0,6,53:2:0 0,9,82:3:0 +X 232 . C <*> 0 . DP=14;I16=9,4,0,0,471,17371,0,0,656,35764,0,0,267,6363,0,0;QS=3,0;MQSB=0.0211283;MQ0F=0 PL:DP:DV 0,21,198:7:0 0,6,53:2:0 0,12,101:4:0 +X 233 . A <*> 0 . DP=14;I16=10,4,0,0,496,18142,0,0,716,39364,0,0,292,6984,0,0;QS=3,0;MQSB=0.0183156;MQ0F=0 PL:DP:DV 0,21,192:7:0 0,6,53:2:0 0,15,119:5:0 +X 234 . A <*> 0 . DP=14;I16=10,4,0,0,502,18390,0,0,716,39364,0,0,292,6988,0,0;QS=3,0;MQSB=0.0183156;MQ0F=0 PL:DP:DV 0,21,185:7:0 0,6,53:2:0 0,15,123:5:0 +X 235 . A <*> 0 . DP=14;I16=9,4,0,0,476,17652,0,0,656,35764,0,0,267,6375,0,0;QS=3,0;MQSB=0.0211283;MQ0F=0 PL:DP:DV 0,21,186:7:0 0,6,53:2:0 0,12,111:4:0 +X 236 . G <*> 0 . DP=15;I16=11,4,0,0,501,17481,0,0,776,42964,0,0,290,6924,0,0;QS=3,0;MQSB=0.0161635;MQ0F=0 PL:DP:DV 0,24,206:8:0 0,6,53:2:0 0,15,103:5:0 +X 237 . A <*> 0 . DP=14;I16=9,4,0,0,465,16877,0,0,656,35764,0,0,266,6282,0,0;QS=3,0;MQSB=0.0211283;MQ0F=0 PL:DP:DV 0,24,206:8:0 0,6,53:2:0 0,9,92:3:0 +X 238 . C <*> 0 . DP=14;I16=10,4,0,0,482,17238,0,0,716,39364,0,0,292,6900,0,0;QS=3,0;MQSB=0.0183156;MQ0F=0 PL:DP:DV 0,24,211:8:0 0,6,53:2:0 0,12,82:4:0 +X 239 . A <*> 0 . DP=15;I16=10,5,0,0,525,19155,0,0,776,42964,0,0,292,6852,0,0;QS=3,0;MQSB=0.0497871;MQ0F=0 PL:DP:DV 0,27,223:9:0 0,6,50:2:0 0,12,108:4:0 +X 240 . C <*> 0 . DP=15;I16=10,5,0,0,512,17930,0,0,776,42964,0,0,292,6764,0,0;QS=3,0;MQSB=0.0497871;MQ0F=0 PL:DP:DV 0,27,220:9:0 0,6,53:2:0 0,12,106:4:0 +X 241 . G <*> 0 . DP=15;I16=9,5,0,0,444,14636,0,0,716,39364,0,0,269,6159,0,0;QS=3,0;MQSB=0.0561348;MQ0F=0 PL:DP:DV 0,27,203:9:0 0,6,53:2:0 0,9,59:3:0 +X 242 . C <*> 0 . DP=15;I16=10,5,0,0,555,21177,0,0,776,42964,0,0,292,6624,0,0;QS=3,0;MQSB=0.0497871;MQ0F=0 PL:DP:DV 0,27,242:9:0 0,6,53:2:0 0,12,94:4:0 +X 243 . C <*> 0 . DP=16;I16=9,5,0,0,523,19737,0,0,716,39364,0,0,284,6508,0,0;QS=3,0;MQSB=0.0561348;MQ0F=0 PL:DP:DV 0,24,220:8:0 0,6,53:2:0 0,12,104:4:0 +X 244 . C <*> 0 . DP=16;I16=10,6,0,0,620,24272,0,0,805,43805,0,0,298,6568,0,0;QS=3,0;MQSB=0.0253122;MQ0F=0 PL:DP:DV 0,27,245:9:0 0,9,72:3:0 0,12,106:4:0 +X 245 . A <*> 0 . DP=17;I16=10,7,0,0,649,24843,0,0,865,47405,0,0,299,6553,0,0;QS=3,0;MQSB=0.0509867;MQ0F=0 PL:DP:DV 0,27,236:9:0 0,12,93:4:0 0,12,115:4:0 +X 246 . T <*> 0 . DP=18;I16=10,8,0,0,649,23833,0,0,894,48246,0,0,301,6553,0,0;QS=3,0;MQSB=0.0286491;MQ0F=0 PL:DP:DV 0,30,247:10:0 0,12,94:4:0 0,12,98:4:0 +X 247 . G <*> 0 . DP=18;I16=10,8,0,0,642,23610,0,0,894,48246,0,0,304,6570,0,0;QS=3,0;MQSB=0.0286491;MQ0F=0 PL:DP:DV 0,30,252:10:0 0,12,83:4:0 0,12,103:4:0 +X 248 . T <*> 0 . DP=18;I16=10,8,0,0,636,22944,0,0,894,48246,0,0,307,6605,0,0;QS=3,0;MQSB=0.0286491;MQ0F=0 PL:DP:DV 0,30,234:10:0 0,12,86:4:0 0,12,114:4:0 +X 249 . C <*> 0 . DP=18;I16=10,8,0,0,656,24846,0,0,894,48246,0,0,310,6658,0,0;QS=3,0;MQSB=0.0286491;MQ0F=0 PL:DP:DV 0,30,253:10:0 0,12,79:4:0 0,12,112:4:0 +X 250 . C <*> 0 . DP=19;I16=10,9,0,0,694,26160,0,0,923,49087,0,0,311,6631,0,0;QS=3,0;MQSB=0.0168512;MQ0F=0 PL:DP:DV 0,30,248:10:0 0,12,89:4:0 0,15,142:5:0 +X 251 . A <*> 0 . DP=19;I16=9,9,0,0,688,26506,0,0,863,45487,0,0,313,6627,0,0;QS=3,0;MQSB=0.0208913;MQ0F=0 PL:DP:DV 0,27,233:9:0 0,12,97:4:0 0,15,148:5:0 +X 252 . G <*> 0 . DP=18;I16=8,9,0,0,641,24631,0,0,803,41887,0,0,304,6502,0,0;QS=3,0;MQSB=0.026526;MQ0F=0 PL:DP:DV 0,27,243:9:0 0,12,91:4:0 0,12,121:4:0 +X 253 . C <*> 0 . DP=19;I16=9,10,0,0,705,26921,0,0,892,46328,0,0,319,6687,0,0;QS=3,0;MQSB=0.0132999;MQ0F=0 PL:DP:DV 0,27,247:9:0 0,12,86:4:0 0,18,155:6:0 +X 254 . T <*> 0 . DP=20;I16=10,9,0,0,719,27517,0,0,892,46328,0,0,314,6670,0,0;QS=3,0;MQSB=0.00482795;MQ0F=0 PL:DP:DV 0,30,254:10:0 0,9,72:3:0 0,18,164:6:0 +X 255 . T <*> 0 . DP=21;I16=11,10,0,0,750,27076,0,0,1012,53528,0,0,328,6840,0,0;QS=3,0;MQSB=0.00822975;MQ0F=0 PL:DP:DV 0,33,241:11:0 0,12,95:4:0 0,18,161:6:0 +X 256 . A <*> 0 . DP=22;I16=11,11,0,0,811,30063,0,0,1049,54897,0,0,334,6956,0,0;QS=3,0;MQSB=0.00507916;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,110:5:0 0,18,166:6:0 +X 257 . T <*> 0 . DP=22;I16=11,11,0,0,814,30420,0,0,1049,54897,0,0,341,7101,0,0;QS=3,0;MQSB=0.00507916;MQ0F=0 PL:DP:DV 0,33,247:11:0 0,15,113:5:0 0,18,168:6:0 +X 258 . T <*> 0 . DP=22;I16=11,11,0,0,791,28943,0,0,1049,54897,0,0,347,7225,0,0;QS=3,0;MQSB=0.00507916;MQ0F=0 PL:DP:DV 0,33,254:11:0 0,15,116:5:0 0,18,155:6:0 +X 259 . C <*> 0 . DP=22;I16=11,10,0,0,785,29809,0,0,1020,54056,0,0,332,6936,0,0;QS=3,0;MQSB=0.00822975;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,90:4:0 0,18,170:6:0 +X 260 . T <*> 0 . DP=21;I16=10,11,0,0,829,32899,0,0,989,51297,0,0,360,7556,0,0;QS=3,0;MQSB=0.00660016;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,118:5:0 0,15,156:5:0 +X 261 . G <*> 0 . DP=21;I16=10,11,0,0,735,27379,0,0,989,51297,0,0,367,7761,0,0;QS=3,0;MQSB=0.00660016;MQ0F=0 PL:DP:DV 0,33,254:11:0 0,15,111:5:0 0,15,122:5:0 +X 262 . C <*> 0 . DP=22;I16=10,12,0,0,806,30278,0,0,1049,54897,0,0,373,7941,0,0;QS=3,0;MQSB=0.0122507;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,99:5:0 0,18,164:6:0 +X 263 . C <*> 0 . DP=22;I16=10,12,0,0,799,29717,0,0,1049,54897,0,0,380,8146,0,0;QS=3,0;MQSB=0.0122507;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,98:5:0 0,18,168:6:0 +X 264 . C <*> 0 . DP=22;I16=10,12,0,0,821,31325,0,0,1049,54897,0,0,386,8326,0,0;QS=3,0;MQSB=0.0122507;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,104:5:0 0,18,172:6:0 +X 265 . A <*> 0 . DP=21;I16=9,12,0,0,800,31906,0,0,989,51297,0,0,390,8380,0,0;QS=3,0;MQSB=0.0158903;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,114:5:0 0,15,129:5:0 +X 266 . G <*> 0 . DP=21;I16=9,11,0,0,747,28155,0,0,960,50456,0,0,369,7833,0,0;QS=3,0;MQSB=0.0237479;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,97:4:0 0,15,138:5:0 +X 267 . T <*> 0 . DP=21;I16=9,11,0,0,739,27465,0,0,960,50456,0,0,373,7935,0,0;QS=3,0;MQSB=0.0237479;MQ0F=0 PL:DP:DV 0,33,254:11:0 0,12,101:4:0 0,15,149:5:0 +X 268 . T <*> 0 . DP=21;I16=9,12,0,0,748,27708,0,0,989,51297,0,0,402,8686,0,0;QS=3,0;MQSB=0.0158903;MQ0F=0 PL:DP:DV 0,33,238:11:0 0,15,110:5:0 0,15,156:5:0 +X 269 . C <*> 0 . DP=22;I16=9,12,0,0,764,28632,0,0,989,51297,0,0,381,8211,0,0;QS=3,0;MQSB=0.0158903;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,91:4:0 0,15,154:5:0 +X 270 . C <*> 0 . DP=22;I16=9,12,0,0,758,28146,0,0,989,51297,0,0,385,8337,0,0;QS=3,0;MQSB=0.0158903;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,96:4:0 0,15,143:5:0 +X 271 . T <*> 0 . DP=22;I16=9,13,0,0,847,32935,0,0,1018,52138,0,0,413,9065,0,0;QS=3,0;MQSB=0.0109431;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,113:5:0 0,15,152:5:0 +X 272 . C <*> 0 . DP=22;I16=9,12,0,0,809,31413,0,0,989,51297,0,0,390,8518,0,0;QS=3,0;MQSB=0.0158903;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,96:4:0 0,15,149:5:0 +X 273 . T <*> 0 . DP=22;I16=9,12,0,0,798,30664,0,0,989,51297,0,0,392,8620,0,0;QS=3,0;MQSB=0.0158903;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,95:4:0 0,15,161:5:0 +X 274 . C <*> 0 . DP=22;I16=9,12,0,0,763,28177,0,0,989,51297,0,0,394,8746,0,0;QS=3,0;MQSB=0.0158903;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,101:4:0 0,15,144:5:0 +X 275 . C <*> 0 . DP=20;I16=7,13,0,0,768,29994,0,0,898,44938,0,0,423,9519,0,0;QS=3,0;MQSB=0.0213617;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,114:5:0 0,12,122:4:0 +X 276 . A <*> 0 . DP=20;I16=7,13,0,0,805,32931,0,0,898,44938,0,0,424,9538,0,0;QS=3,0;MQSB=0.0213617;MQ0F=0 PL:DP:DV 0,33,253:11:0 0,15,122:5:0 0,12,124:4:0 +X 277 . G <*> 0 . DP=20;I16=7,13,0,0,764,29732,0,0,898,44938,0,0,425,9579,0,0;QS=3,0;MQSB=0.0213617;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,114:5:0 0,12,121:4:0 +X 278 . A <*> 0 . DP=21;I16=6,14,0,0,722,26452,0,0,867,42179,0,0,415,9521,0,0;QS=3,0;MQSB=0.0246228;MQ0F=0 PL:DP:DV 0,30,238:10:0 0,18,123:6:0 0,12,121:4:0 +X 279 . A <*> 0 . DP=22;I16=7,15,0,0,786,28694,0,0,956,46620,0,0,427,9677,0,0;QS=3,0;MQSB=0.0124927;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,123:6:0 0,12,122:4:0 +X 280 . A <*> 0 . DP=22;I16=7,15,0,0,815,31561,0,0,956,46620,0,0,428,9684,0,0;QS=3,0;MQSB=0.0124927;MQ0F=0 PL:DP:DV 0,36,253:12:0 0,18,130:6:0 0,12,129:4:0 +X 281 . G <*> 0 . DP=22;I16=7,15,0,0,820,31416,0,0,956,46620,0,0,428,9662,0,0;QS=3,0;MQSB=0.0124927;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,122:6:0 0,12,123:4:0 +X 282 . G <*> 0 . DP=22;I16=7,15,0,0,806,30420,0,0,956,46620,0,0,427,9609,0,0;QS=3,0;MQSB=0.0124927;MQ0F=0 PL:DP:DV 0,36,253:12:0 0,18,124:6:0 0,12,119:4:0 +X 283 . C <*> 0 . DP=23;I16=7,15,0,0,827,31785,0,0,956,46620,0,0,426,9574,0,0;QS=3,0;MQSB=0.0124927;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,125:6:0 0,12,122:4:0 +X 284 . T <*> 0 . DP=23;I16=7,16,0,0,901,35479,0,0,1016,50220,0,0,431,9593,0,0;QS=3,0;MQSB=0.0194969;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,126:6:0 0,15,144:5:0 +X 285 . G <*> 0 . DP=23;I16=7,16,0,0,860,32856,0,0,1016,50220,0,0,431,9607,0,0;QS=3,0;MQSB=0.0194969;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,119:6:0 0,15,132:5:0 +X 286 . C <*> 0 . DP=24;I16=8,16,0,0,875,32883,0,0,1076,53820,0,0,431,9641,0,0;QS=3,0;MQSB=0.0132999;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,150:7:0 0,15,134:5:0 +X 287 . A <*> 0 . DP=25;I16=9,16,0,0,895,32957,0,0,1136,57420,0,0,432,9696,0,0;QS=3,0;MQSB=0.00934348;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,178:8:0 0,15,133:5:0 +X 288 . T <*> 0 . DP=25;I16=9,16,0,0,931,35011,0,0,1136,57420,0,0,432,9674,0,0;QS=3,0;MQSB=0.00934348;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,184:8:0 0,15,146:5:0 +X 289 . G <*> 0 . DP=25;I16=9,16,0,0,939,36117,0,0,1136,57420,0,0,432,9676,0,0;QS=3,0;MQSB=0.00934348;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,185:8:0 0,15,136:5:0 +X 290 . G <*> 0 . DP=23;I16=8,15,0,0,805,29157,0,0,1047,52979,0,0,433,9651,0,0;QS=3,0;MQSB=0.0177152;MQ0F=0 PL:DP:DV 0,33,240:11:0 0,21,164:7:0 0,15,126:5:0 +X 291 . T <*> 0 . DP=24;I16=8,15,0,0,840,31616,0,0,1047,52979,0,0,421,9479,0,0;QS=3,0;MQSB=0.0177152;MQ0F=0 PL:DP:DV 0,33,244:11:0 0,21,168:7:0 0,15,136:5:0 +X 292 . T <*> 0 . DP=25;I16=9,16,0,0,888,32274,0,0,1167,60179,0,0,436,9668,0,0;QS=3,0;MQSB=0.0197089;MQ0F=0 PL:DP:DV 0,33,253:11:0 0,24,181:8:0 0,18,156:6:0 +X 293 . G <*> 0 . DP=26;I16=10,15,0,0,934,35232,0,0,1167,60179,0,0,424,9488,0,0;QS=3,0;MQSB=0.0095249;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,196:8:0 0,15,145:5:0 +X 294 . A <*> 0 . DP=26;I16=10,16,0,0,931,33937,0,0,1227,63779,0,0,443,9785,0,0;QS=3,0;MQSB=0.0149748;MQ0F=0 PL:DP:DV 0,36,252:12:0 0,24,201:8:0 0,18,161:6:0 +X 295 . C <*> 0 . DP=25;I16=10,14,0,0,897,33973,0,0,1169,62097,0,0,430,9544,0,0;QS=3,0;MQSB=0.0310726;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,180:7:0 0,18,159:6:0 +X 296 . A <*> 0 . DP=25;I16=10,15,0,0,874,31846,0,0,1198,62938,0,0,451,9905,0,0;QS=3,0;MQSB=0.0213617;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,169:8:0 0,18,169:6:0 +X 297 . C <*> 0 . DP=25;I16=9,15,0,0,901,34305,0,0,1138,59338,0,0,445,9901,0,0;QS=3,0;MQSB=0.0273237;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,174:7:0 0,18,161:6:0 +X 298 . A <*> 0 . DP=26;I16=11,15,0,0,936,34652,0,0,1258,66538,0,0,459,10121,0,0;QS=3,0;MQSB=0.017008;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,184:8:0 0,21,191:7:0 +X 299 . C <*> 0 . DP=27;I16=11,15,0,0,971,36863,0,0,1258,66538,0,0,464,10266,0,0;QS=3,0;MQSB=0.017008;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,193:8:0 0,21,189:7:0 +X 300 . A <*> 0 . DP=27;I16=11,15,0,0,1001,39455,0,0,1258,66538,0,0,469,10437,0,0;QS=3,0;MQSB=0.017008;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,204:8:0 0,21,210:7:0 +X 301 . G <*> 0 . DP=25;I16=10,14,0,0,928,36116,0,0,1169,62097,0,0,476,10632,0,0;QS=3,0;MQSB=0.0310726;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,195:7:0 0,21,196:7:0 +X 302 . T <*> 0 . DP=25;I16=10,14,0,0,879,32885,0,0,1169,62097,0,0,483,10849,0,0;QS=3,0;MQSB=0.0310726;MQ0F=0 PL:DP:DV 0,30,231:10:0 0,21,172:7:0 0,21,202:7:0 +X 302 . T TA 0 . INDEL;IDV=7;IMF=1;DP=25;I16=2,4,8,11,214,7674,793,33369,236,10564,993,55133,109,2229,377,8629;QS=0.511212,2.48879;VDB=0.27613;SGB=-4.22417;MQSB=0.0443614;MQ0F=0 PL:DP:DV 167,0,96:11:6 157,0,9:7:6 201,21,0:7:7 +X 303 . G <*> 0 . DP=25;I16=10,15,0,0,976,38516,0,0,1229,65697,0,0,497,11181,0,0;QS=3,0;MQSB=0.0443614;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,197:7:0 0,21,195:7:0 +X 304 . C <*> 0 . DP=27;I16=11,16,0,0,991,37005,0,0,1318,70138,0,0,503,11359,0,0;QS=3,0;MQSB=0.129164;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,206:8:0 0,24,200:8:0 +X 305 . C <*> 0 . DP=27;I16=11,16,0,0,1057,41761,0,0,1318,70138,0,0,510,11508,0,0;QS=3,0;MQSB=0.129164;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,213:8:0 0,24,211:8:0 +X 306 . T <*> 0 . DP=27;I16=11,16,0,0,1033,40253,0,0,1318,70138,0,0,517,11679,0,0;QS=3,0;MQSB=0.129164;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,207:8:0 0,24,217:8:0 +X 307 . G <*> 0 . DP=27;I16=11,15,0,0,984,37886,0,0,1289,69297,0,0,498,11198,0,0;QS=3,0;MQSB=0.174566;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,189:7:0 0,24,203:8:0 +X 308 . C <*> 0 . DP=27;I16=11,16,0,0,892,30810,0,0,1318,70138,0,0,529,11991,0,0;QS=3,0;MQSB=0.129164;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,178:8:0 0,24,185:8:0 +X 309 . G <*> 0 . DP=27;I16=11,16,0,0,951,34599,0,0,1318,70138,0,0,535,12183,0,0;QS=3,0;MQSB=0.129164;MQ0F=0 PL:DP:DV 0,33,243:11:0 0,24,183:8:0 0,24,205:8:0 +X 310 . A <*> 0 . DP=27;I16=11,16,0,0,1001,38063,0,0,1318,70138,0,0,540,12350,0,0;QS=3,0;MQSB=0.129164;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,200:8:0 0,24,217:8:0 +X 311 . C <*> 0 . DP=27;I16=11,16,0,0,1037,40263,0,0,1318,70138,0,0,544,12492,0,0;QS=3,0;MQSB=0.129164;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,215:8:0 0,24,210:8:0 +X 312 . A <*> 0 . DP=26;I16=10,16,0,0,985,38043,0,0,1258,66538,0,0,549,12657,0,0;QS=3,0;MQSB=0.157183;MQ0F=0 PL:DP:DV 0,30,237:10:0 0,24,215:8:0 0,24,218:8:0 +X 313 . A <*> 0 . DP=26;I16=10,16,0,0,983,37969,0,0,1258,66538,0,0,551,12695,0,0;QS=3,0;MQSB=0.157183;MQ0F=0 PL:DP:DV 0,30,235:10:0 0,24,219:8:0 0,24,215:8:0 +X 314 . A <*> 0 . DP=27;I16=10,17,0,0,1050,41798,0,0,1318,70138,0,0,553,12757,0,0;QS=3,0;MQSB=0.195223;MQ0F=0 PL:DP:DV 0,33,250:11:0 0,24,217:8:0 0,24,227:8:0 +X 315 . G <*> 0 . DP=26;I16=10,16,0,0,1025,40941,0,0,1289,69297,0,0,557,12843,0,0;QS=3,0;MQSB=0.252051;MQ0F=0 PL:DP:DV 0,30,252:10:0 0,24,216:8:0 0,24,225:8:0 +X 316 . C <*> 0 . DP=27;I16=10,15,0,0,983,39393,0,0,1252,67928,0,0,535,12277,0,0;QS=3,0;MQSB=0.312403;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,183:7:0 0,24,224:8:0 +X 317 . T <*> 0 . DP=27;I16=10,16,0,0,1028,41392,0,0,1320,72056,0,0,547,12557,0,0;QS=3,0;MQSB=0.377061;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,24,230:8:0 0,24,206:8:0 +X 318 . G <*> 0 . DP=27;I16=10,17,0,0,1038,40546,0,0,1349,72897,0,0,570,13018,0,0;QS=3,0;MQSB=0.297797;MQ0F=0 PL:DP:DV 0,30,249:10:0 0,27,235:9:0 0,24,208:8:0 +X 319 . A <*> 0 . DP=27;I16=9,17,0,0,994,38654,0,0,1289,69297,0,0,560,12906,0,0;QS=3,0;MQSB=0.346864;MQ0F=0 PL:DP:DV 0,30,249:10:0 0,27,228:9:0 0,21,185:7:0 +X 320 . A <*> 0 . DP=27;I16=10,17,0,0,1022,39418,0,0,1349,72897,0,0,573,13053,0,0;QS=3,0;MQSB=0.297797;MQ0F=0 PL:DP:DV 0,30,247:10:0 0,27,230:9:0 0,24,211:8:0 +X 321 . T <*> 0 . DP=27;I16=10,17,0,0,1026,39772,0,0,1349,72897,0,0,573,13029,0,0;QS=3,0;MQSB=0.297797;MQ0F=0 PL:DP:DV 0,30,253:10:0 0,27,214:9:0 0,24,218:8:0 +X 322 . G <*> 0 . DP=28;I16=10,18,0,0,1091,43151,0,0,1409,76497,0,0,573,13029,0,0;QS=3,0;MQSB=0.343265;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,27,226:9:0 0,27,223:9:0 +X 323 . C <*> 0 . DP=28;I16=9,18,0,0,1067,42619,0,0,1349,72897,0,0,565,12939,0,0;QS=3,0;MQSB=0.394987;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,27,225:9:0 0,24,198:8:0 +X 324 . T <*> 0 . DP=30;I16=12,18,0,0,1145,44221,0,0,1529,83697,0,0,573,13001,0,0;QS=3,0;MQSB=0.264959;MQ0F=0 PL:DP:DV 0,30,253:10:0 0,27,237:9:0 0,33,255:11:0 +X 325 . A <*> 0 . DP=31;I16=13,18,0,0,1132,42058,0,0,1589,87297,0,0,573,12925,0,0;QS=3,0;MQSB=0.235201;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,208:9:0 0,33,255:11:0 +X 326 . T <*> 0 . DP=31;I16=13,18,0,0,1157,44193,0,0,1589,87297,0,0,574,12878,0,0;QS=3,0;MQSB=0.235201;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,216:9:0 0,33,255:11:0 +X 327 . C <*> 0 . DP=31;I16=13,18,0,0,1147,43895,0,0,1589,87297,0,0,575,12861,0,0;QS=3,0;MQSB=0.235201;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,198:9:0 0,33,255:11:0 +X 328 . A <*> 0 . DP=31;I16=13,18,0,0,1167,44531,0,0,1589,87297,0,0,574,12776,0,0;QS=3,0;MQSB=0.235201;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,226:9:0 0,33,255:11:0 +X 329 . T <*> 0 . DP=31;I16=13,18,0,0,1210,47742,0,0,1589,87297,0,0,572,12676,0,0;QS=3,0;MQSB=0.235201;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,237:9:0 0,33,255:11:0 +X 330 . T <*> 0 . DP=31;I16=13,18,0,0,1185,45839,0,0,1589,87297,0,0,568,12510,0,0;QS=3,0;MQSB=0.235201;MQ0F=0 PL:DP:DV 0,33,254:11:0 0,27,231:9:0 0,33,255:11:0 +X 331 . T <*> 0 . DP=32;I16=14,18,0,0,1154,42510,0,0,1649,90897,0,0,563,12327,0,0;QS=3,0;MQSB=0.210122;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,222:9:0 0,36,255:12:0 +X 332 . A <*> 0 . DP=32;I16=14,18,0,0,1156,42666,0,0,1649,90897,0,0,560,12178,0,0;QS=3,0;MQSB=0.210122;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,214:9:0 0,33,255:11:0 +X 333 . A <*> 0 . DP=32;I16=14,18,0,0,1141,41987,0,0,1649,90897,0,0,558,12064,0,0;QS=3,0;MQSB=0.210122;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,223:9:0 0,33,255:11:0 +X 334 . A <*> 0 . DP=32;I16=14,18,0,0,1162,43328,0,0,1649,90897,0,0,556,11986,0,0;QS=3,0;MQSB=0.210122;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,221:9:0 0,33,255:11:0 +X 335 . A <*> 0 . DP=32;I16=12,18,0,0,1077,40287,0,0,1529,83697,0,0,552,11934,0,0;QS=3,0;MQSB=0.264959;MQ0F=0 PL:DP:DV 0,30,250:10:0 0,27,219:9:0 0,33,251:11:0 +X 336 . A <*> 0 . DP=32;I16=14,17,0,0,1088,39758,0,0,1612,89528,0,0,536,11574,0,0;QS=3,0;MQSB=0.274662;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,211:8:0 0,36,255:12:0 +X 337 . C <*> 0 . DP=32;I16=13,17,0,0,1115,42381,0,0,1552,85928,0,0,531,11565,0,0;QS=3,0;MQSB=0.301511;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,24,202:8:0 0,36,255:12:0 +X 338 . T <*> 0 . DP=30;I16=14,16,0,0,1191,47979,0,0,1560,86456,0,0,554,11878,0,0;QS=3,0;MQSB=0.242376;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,24,226:8:0 0,36,255:12:0 +X 339 . C <*> 0 . DP=31;I16=14,17,0,0,1130,43210,0,0,1589,87297,0,0,554,11874,0,0;QS=3,0;MQSB=0.175471;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,185:8:0 0,36,255:12:0 +X 340 . C <*> 0 . DP=31;I16=14,17,0,0,1196,47044,0,0,1589,87297,0,0,554,11852,0,0;QS=3,0;MQSB=0.175471;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,221:8:0 0,36,255:12:0 +X 341 . T <*> 0 . DP=31;I16=14,17,0,0,1227,48995,0,0,1589,87297,0,0,554,11862,0,0;QS=3,0;MQSB=0.175471;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,216:8:0 0,36,255:12:0 +X 342 . T <*> 0 . DP=31;I16=14,17,0,0,1162,43942,0,0,1589,87297,0,0,554,11904,0,0;QS=3,0;MQSB=0.175471;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,210:8:0 0,36,255:12:0 +X 343 . G <*> 0 . DP=32;I16=14,17,0,0,1150,43702,0,0,1620,90056,0,0,550,11962,0,0;QS=3,0;MQSB=0.283511;MQ0F=0 PL:DP:DV 0,30,249:10:0 0,27,218:9:0 0,36,255:12:0 +X 344 . C <*> 0 . DP=32;I16=14,18,0,0,1181,45169,0,0,1649,90897,0,0,554,12036,0,0;QS=3,0;MQSB=0.210122;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,217:9:0 0,36,255:12:0 +X 345 . T <*> 0 . DP=31;I16=14,17,0,0,1205,47259,0,0,1589,87297,0,0,555,12129,0,0;QS=3,0;MQSB=0.175471;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,221:8:0 0,36,255:12:0 +X 346 . G <*> 0 . DP=31;I16=15,16,0,0,1147,43597,0,0,1620,90056,0,0,557,12255,0,0;QS=3,0;MQSB=0.220358;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,212:8:0 0,36,255:12:0 +X 347 . G <*> 0 . DP=31;I16=14,16,0,0,1119,42227,0,0,1560,86456,0,0,545,12189,0,0;QS=3,0;MQSB=0.242376;MQ0F=0 PL:DP:DV 0,30,251:10:0 0,24,207:8:0 0,36,255:12:0 +X 348 . T <*> 0 . DP=32;I16=15,16,0,0,1145,43007,0,0,1620,90056,0,0,546,12300,0,0;QS=3,0;MQSB=0.220358;MQ0F=0 PL:DP:DV 0,30,243:10:0 0,27,228:9:0 0,36,255:12:0 +X 349 . T <*> 0 . DP=32;I16=16,16,0,0,1194,45350,0,0,1680,93656,0,0,565,12731,0,0;QS=3,0;MQSB=0.201402;MQ0F=0 PL:DP:DV 0,33,246:11:0 0,27,230:9:0 0,36,255:12:0 +X 350 . T <*> 0 . DP=31;I16=16,15,0,0,1142,43072,0,0,1651,92815,0,0,567,12837,0,0;QS=3,0;MQSB=0.286505;MQ0F=0 PL:DP:DV 0,33,249:11:0 0,27,230:9:0 0,33,255:11:0 +X 351 . G <*> 0 . DP=31;I16=16,15,0,0,1146,43750,0,0,1651,92815,0,0,568,12920,0,0;QS=3,0;MQSB=0.286505;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,212:9:0 0,33,255:11:0 +X 352 . A <*> 0 . DP=31;I16=16,14,0,0,1150,45520,0,0,1591,89215,0,0,544,12404,0,0;QS=3,0;MQSB=0.242376;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,224:8:0 0,33,255:11:0 +X 353 . G <*> 0 . DP=29;I16=15,14,0,0,1109,43095,0,0,1562,88374,0,0,570,13064,0,0;QS=3,0;MQSB=0.424373;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,27,231:9:0 0,30,255:10:0 +X 354 . A <*> 0 . DP=28;I16=14,14,0,0,1078,42938,0,0,1502,84774,0,0,571,13075,0,0;QS=3,0;MQSB=0.450096;MQ0F=0 PL:DP:DV 0,27,225:9:0 0,27,244:9:0 0,30,255:10:0 +X 355 . G T,<*> 0 . DP=28;I16=14,13,0,1,1001,37907,41,1681,1442,81174,60,3600,547,12487,25,625;QS=2.875,0.125,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.450096;BQB=1;MQ0F=0 PL:DP:DV 14,0,200,38,203,231:9:1 0,27,222,27,222,222:9:0 0,30,255,30,255,255:10:0 +X 356 . G <*> 0 . DP=27;I16=14,13,0,0,993,37481,0,0,1465,83405,0,0,574,13174,0,0;QS=3,0;MQSB=0.580277;MQ0F=0 PL:DP:DV 0,27,228:9:0 0,24,201:8:0 0,30,255:10:0 +X 357 . C <*> 0 . DP=28;I16=14,13,0,0,1021,39471,0,0,1465,83405,0,0,550,12584,0,0;QS=3,0;MQSB=0.580277;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,24,205:8:0 0,27,251:9:0 +X 358 . A <*> 0 . DP=28;I16=15,13,0,0,1050,40518,0,0,1525,87005,0,0,576,13216,0,0;QS=3,0;MQSB=0.556581;MQ0F=0 PL:DP:DV 0,30,254:10:0 0,24,197:8:0 0,30,255:10:0 +X 359 . G <*> 0 . DP=29;I16=15,13,0,0,1085,42761,0,0,1525,87005,0,0,552,12620,0,0;QS=3,0;MQSB=0.556581;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,187:7:0 0,33,255:11:0 +X 360 . A <*> 0 . DP=29;I16=15,14,0,0,1111,43259,0,0,1585,90605,0,0,579,13297,0,0;QS=3,0;MQSB=0.604224;MQ0F=0 PL:DP:DV 0,30,252:10:0 0,24,220:8:0 0,33,255:11:0 +X 361 . A <*> 0 . DP=29;I16=15,14,0,0,1116,43442,0,0,1585,90605,0,0,579,13273,0,0;QS=3,0;MQSB=0.604224;MQ0F=0 PL:DP:DV 0,30,252:10:0 0,24,219:8:0 0,33,255:11:0 +X 362 . A <*> 0 . DP=29;I16=16,13,0,0,1104,42700,0,0,1585,90605,0,0,580,13272,0,0;QS=3,0;MQSB=0.535133;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,218:8:0 0,30,255:10:0 +X 363 . A <*> 0 . DP=29;I16=16,13,0,0,1087,41437,0,0,1585,90605,0,0,581,13245,0,0;QS=3,0;MQSB=0.535133;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,213:8:0 0,30,255:10:0 +X 364 . T <*> 0 . DP=29;I16=16,13,0,0,1032,37960,0,0,1585,90605,0,0,582,13244,0,0;QS=3,0;MQSB=0.535133;MQ0F=0 PL:DP:DV 0,33,250:11:0 0,24,205:8:0 0,30,255:10:0 +X 365 . G <*> 0 . DP=29;I16=16,13,0,0,1105,43079,0,0,1585,90605,0,0,582,13218,0,0;QS=3,0;MQSB=0.535133;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,211:8:0 0,30,255:10:0 +X 366 . A <*> 0 . DP=29;I16=16,13,0,0,1090,41562,0,0,1585,90605,0,0,581,13167,0,0;QS=3,0;MQSB=0.535133;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,211:8:0 0,30,255:10:0 +X 367 . T <*> 0 . DP=29;I16=16,13,0,0,1055,39149,0,0,1585,90605,0,0,579,13093,0,0;QS=3,0;MQSB=0.535133;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,204:8:0 0,30,255:10:0 +X 368 . A <*> 0 . DP=29;I16=16,13,0,0,1054,39632,0,0,1585,90605,0,0,576,12998,0,0;QS=3,0;MQSB=0.535133;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,208:8:0 0,30,255:10:0 +X 369 . T <*> 0 . DP=28;I16=16,11,0,0,1037,40275,0,0,1496,86164,0,0,548,12256,0,0;QS=3,0;MQSB=0.659218;MQ0F=0 PL:DP:DV 0,30,250:10:0 0,21,196:7:0 0,30,255:10:0 +X 370 . C <*> 0 . DP=28;I16=16,12,0,0,1045,40219,0,0,1556,89764,0,0,570,12790,0,0;QS=3,0;MQSB=0.705296;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,24,201:8:0 0,30,255:10:0 +X 371 . T <*> 0 . DP=29;I16=16,13,0,0,1155,46591,0,0,1616,93364,0,0,567,12725,0,0;QS=3,0;MQSB=0.744925;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,24,227:8:0 0,33,255:11:0 +X 372 . C <*> 0 . DP=30;I16=16,14,0,0,1139,44019,0,0,1676,96964,0,0,564,12636,0,0;QS=3,0;MQSB=0.779025;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,215:8:0 0,33,255:11:0 +X 373 . A <*> 0 . DP=30;I16=16,14,0,0,1142,44118,0,0,1676,96964,0,0,561,12525,0,0;QS=3,0;MQSB=0.779025;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,220:8:0 0,33,255:11:0 +X 374 . T <*> 0 . DP=30;I16=16,14,0,0,1098,41180,0,0,1676,96964,0,0,556,12344,0,0;QS=3,0;MQSB=0.779025;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,221:8:0 0,33,255:11:0 +X 375 . A T,<*> 0 . DP=31;I16=17,13,0,1,1138,43798,14,196,1676,96964,60,3600,547,12177,4,16;QS=2.9661,0.0338983,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.763662;BQB=1;MQ0F=0 PL:DP:DV 0,36,255,36,255,255:12:0 0,24,218,24,218,218:8:0 0,18,255,30,255,255:11:1 +X 376 . G <*> 0 . DP=31;I16=17,14,0,0,1131,42581,0,0,1736,100564,0,0,547,12073,0,0;QS=3,0;MQSB=0.763662;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,220:8:0 0,33,255:11:0 +X 377 . T <*> 0 . DP=31;I16=16,14,0,0,1105,41629,0,0,1676,96964,0,0,518,11360,0,0;QS=3,0;MQSB=0.779025;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,211:8:0 0,33,255:11:0 +X 378 . T <*> 0 . DP=30;I16=18,12,0,0,1098,41066,0,0,1707,99723,0,0,541,11927,0,0;QS=3,0;MQSB=0.878946;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,186:7:0 0,30,255:10:0 +X 379 . G <*> 0 . DP=29;I16=18,10,0,0,1053,40181,0,0,1618,95282,0,0,534,11848,0,0;QS=3,0;MQSB=0.981777;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,187:7:0 0,30,255:10:0 +X 380 . C <*> 0 . DP=29;I16=18,10,0,0,1087,42743,0,0,1618,95282,0,0,514,11172,0,0;QS=3,0;MQSB=0.981777;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,177:6:0 0,30,255:10:0 +X 381 . T <*> 0 . DP=29;I16=18,11,0,0,1168,47412,0,0,1678,98882,0,0,537,11729,0,0;QS=3,0;MQSB=0.987702;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,212:7:0 0,30,255:10:0 +X 382 . T <*> 0 . DP=29;I16=17,11,0,0,1054,40450,0,0,1618,95282,0,0,510,11068,0,0;QS=3,0;MQSB=0.990092;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,182:7:0 0,30,255:10:0 +X 383 . T <*> 0 . DP=29;I16=18,10,0,0,1052,39798,0,0,1618,95282,0,0,507,11013,0,0;QS=3,0;MQSB=0.981777;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,165:6:0 0,30,255:10:0 +X 384 . A <*> 0 . DP=31;I16=19,11,0,0,1077,39885,0,0,1738,102482,0,0,504,10988,0,0;QS=3,0;MQSB=0.985292;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,176:7:0 0,30,255:10:0 +X 385 . C <*> 0 . DP=31;I16=19,12,0,0,1118,41180,0,0,1798,106082,0,0,527,11569,0,0;QS=3,0;MQSB=0.989977;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,24,186:8:0 0,30,255:10:0 +X 386 . T <*> 0 . DP=30;I16=18,12,0,0,1158,45592,0,0,1738,102482,0,0,526,11556,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,191:7:0 0,30,255:10:0 +X 387 . T <*> 0 . DP=30;I16=18,12,0,0,1105,41821,0,0,1738,102482,0,0,525,11573,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,187:7:0 0,30,255:10:0 +X 388 . T <*> 0 . DP=29;I16=17,12,0,0,1089,41577,0,0,1678,98882,0,0,523,11519,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,180:6:0 0,30,255:10:0 +X 389 . G <*> 0 . DP=29;I16=17,12,0,0,1067,40095,0,0,1678,98882,0,0,520,11444,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,171:6:0 0,30,255:10:0 +X 390 . C <*> 0 . DP=29;I16=17,12,0,0,1071,40423,0,0,1678,98882,0,0,517,11399,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,162:6:0 0,30,255:10:0 +X 391 . A <*> 0 . DP=29;I16=18,11,0,0,1091,41603,0,0,1647,96123,0,0,515,11383,0,0;QS=3,0;MQSB=0.995968;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,163:6:0 0,30,255:10:0 +X 392 . T <*> 0 . DP=29;I16=18,11,0,0,1046,38838,0,0,1647,96123,0,0,515,11395,0,0;QS=3,0;MQSB=0.995968;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,153:5:0 0,33,255:11:0 +X 393 . A <*> 0 . DP=28;I16=17,11,0,0,1014,37582,0,0,1587,92523,0,0,517,11435,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,133:5:0 0,33,255:11:0 +X 394 . T <*> 0 . DP=28;I16=17,11,0,0,1022,38342,0,0,1587,92523,0,0,519,11503,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,141:5:0 0,33,255:11:0 +X 395 . T <*> 0 . DP=28;I16=17,11,0,0,1060,40596,0,0,1587,92523,0,0,521,11599,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,164:5:0 0,33,255:11:0 +X 396 . T <*> 0 . DP=28;I16=17,11,0,0,1032,39228,0,0,1587,92523,0,0,523,11723,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,158:5:0 0,33,255:11:0 +X 397 . T <*> 0 . DP=28;I16=17,11,0,0,1046,39510,0,0,1587,92523,0,0,524,11824,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,149:5:0 0,33,255:11:0 +X 398 . A <*> 0 . DP=28;I16=17,11,0,0,1021,38105,0,0,1587,92523,0,0,524,11850,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,144:5:0 0,30,255:10:0 +X 399 . A <*> 0 . DP=28;I16=17,11,0,0,1015,38469,0,0,1587,92523,0,0,526,11900,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,140:5:0 0,30,255:10:0 +X 400 . A <*> 0 . DP=29;I16=17,12,0,0,1056,39702,0,0,1647,96123,0,0,526,11828,0,0;QS=3,0;MQSB=0.988062;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,159:5:0 0,33,255:11:0 +X 401 . A <*> 0 . DP=29;I16=17,11,0,0,1052,40302,0,0,1587,92523,0,0,501,11113,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,160:5:0 0,30,255:10:0 +X 402 . T <*> 0 . DP=29;I16=17,12,0,0,1082,41232,0,0,1647,96123,0,0,526,11680,0,0;QS=3,0;MQSB=0.988062;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,149:5:0 0,33,255:11:0 +X 403 . T <*> 0 . DP=29;I16=17,12,0,0,1085,40985,0,0,1647,96123,0,0,526,11654,0,0;QS=3,0;MQSB=0.988062;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,148:5:0 0,33,255:11:0 +X 404 . G <*> 0 . DP=29;I16=17,12,0,0,1074,40524,0,0,1647,96123,0,0,525,11609,0,0;QS=3,0;MQSB=0.988062;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,131:5:0 0,33,255:11:0 +X 405 . T <*> 0 . DP=27;I16=16,10,0,0,988,37870,0,0,1498,88082,0,0,519,11543,0,0;QS=3,0;MQSB=0.987578;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,103:3:0 0,30,255:10:0 +X 406 . G <*> 0 . DP=27;I16=16,11,0,0,976,36752,0,0,1558,91682,0,0,527,11601,0,0;QS=3,0;MQSB=0.992419;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,125:4:0 0,30,247:10:0 +X 407 . A <*> 0 . DP=27;I16=16,11,0,0,1007,38355,0,0,1558,91682,0,0,526,11538,0,0;QS=3,0;MQSB=0.992419;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,125:4:0 0,30,255:10:0 +X 408 . C <*> 0 . DP=28;I16=16,11,0,0,1006,38136,0,0,1558,91682,0,0,521,11489,0,0;QS=3,0;MQSB=0.992419;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,110:3:0 0,30,244:10:0 +X 409 . T <*> 0 . DP=29;I16=17,12,0,0,1100,42734,0,0,1678,98882,0,0,525,11503,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,131:4:0 0,33,255:11:0 +X 410 . T <*> 0 . DP=29;I16=17,12,0,0,1035,38325,0,0,1678,98882,0,0,524,11432,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,125:4:0 0,33,255:11:0 +X 411 . T <*> 0 . DP=29;I16=17,10,0,0,1003,37747,0,0,1558,91682,0,0,496,10716,0,0;QS=3,0;MQSB=0.984677;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,104:3:0 0,30,255:10:0 +X 412 . C T,<*> 0 . DP=30;I16=17,12,1,0,1094,42458,14,196,1678,98882,60,3600,495,10659,25,625;QS=2.97455,0.0254545,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.991968;BQB=1;MQ0F=0 PL:DP:DV 0,30,255,42,255,255:15:1 0,12,124,12,124,124:4:0 0,33,255,33,255,255:11:0 +X 413 . A <*> 0 . DP=31;I16=18,13,0,0,1189,45985,0,0,1798,106082,0,0,520,11258,0,0;QS=3,0;MQSB=0.995005;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,9,102:3:0 0,33,255:11:0 +X 414 . T <*> 0 . DP=30;I16=18,12,0,0,1151,44355,0,0,1738,102482,0,0,523,11265,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,109:3:0 0,33,255:11:0 +X 415 . G <*> 0 . DP=30;I16=18,12,0,0,1131,43175,0,0,1738,102482,0,0,526,11306,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,110:3:0 0,33,255:11:0 +X 416 . G <*> 0 . DP=30;I16=17,12,0,0,1083,41273,0,0,1678,98882,0,0,514,11156,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,114:3:0 0,30,253:10:0 +X 417 . C <*> 0 . DP=30;I16=18,12,0,0,1114,42244,0,0,1738,102482,0,0,531,11439,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,108:3:0 0,33,255:11:0 +X 418 . A <*> 0 . DP=30;I16=18,12,0,0,1146,44248,0,0,1738,102482,0,0,532,11478,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,111:3:0 0,33,255:11:0 +X 419 . T <*> 0 . DP=30;I16=18,12,0,0,1117,42327,0,0,1738,102482,0,0,532,11498,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,112:3:0 0,33,255:11:0 +X 420 . A <*> 0 . DP=31;I16=18,13,0,0,1117,41011,0,0,1798,106082,0,0,532,11550,0,0;QS=3,0;MQSB=0.995005;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,108:3:0 0,36,255:12:0 +X 421 . A <*> 0 . DP=33;I16=19,14,0,0,1208,45398,0,0,1887,110523,0,0,533,11635,0,0;QS=3,0;MQSB=0.986656;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,113:3:0 0,42,255:14:0 +X 422 . A <*> 0 . DP=33;I16=19,13,0,0,1205,46441,0,0,1827,106923,0,0,510,11082,0,0;QS=3,0;MQSB=0.991023;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,116:3:0 0,39,255:13:0 +X 423 . T <*> 0 . DP=32;I16=19,13,0,0,1202,45416,0,0,1827,106923,0,0,538,11818,0,0;QS=3,0;MQSB=0.991023;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,110:3:0 0,39,255:13:0 +X 424 . A <*> 0 . DP=32;I16=19,13,0,0,1147,41685,0,0,1827,106923,0,0,539,11867,0,0;QS=3,0;MQSB=0.991023;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,106:3:0 0,39,255:13:0 +X 425 . A <*> 0 . DP=29;I16=16,13,0,0,1070,40616,0,0,1647,96123,0,0,542,11900,0,0;QS=3,0;MQSB=0.976248;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,111:3:0 0,33,249:11:0 +X 426 . T <*> 0 . DP=29;I16=16,12,0,0,997,36561,0,0,1587,92523,0,0,519,11287,0,0;QS=3,0;MQSB=0.982906;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,105:3:0 0,30,225:10:0 +X 427 . A <*> 0 . DP=29;I16=16,13,0,0,1024,37266,0,0,1647,96123,0,0,546,11952,0,0;QS=3,0;MQSB=0.976248;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,111:3:0 0,33,242:11:0 +X 428 . C <*> 0 . DP=29;I16=16,13,0,0,1064,39706,0,0,1647,96123,0,0,548,12020,0,0;QS=3,0;MQSB=0.976248;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,111:3:0 0,33,254:11:0 +X 429 . T <*> 0 . DP=30;I16=16,14,0,0,1150,44918,0,0,1707,99723,0,0,549,12067,0,0;QS=3,0;MQSB=0.969373;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,115:3:0 0,33,255:11:0 +X 430 . G <*> 0 . DP=30;I16=16,14,0,0,1113,42443,0,0,1707,99723,0,0,551,12145,0,0;QS=3,0;MQSB=0.969373;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,112:3:0 0,33,246:11:0 +X 431 . G <*> 0 . DP=30;I16=14,14,0,0,1003,36953,0,0,1587,92523,0,0,553,12255,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,101:3:0 0,30,225:10:0 +X 432 . T <*> 0 . DP=28;I16=14,14,0,0,1049,39621,0,0,1587,92523,0,0,556,12346,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,114:3:0 0,30,255:10:0 +X 433 . T <*> 0 . DP=28;I16=14,12,0,0,949,35443,0,0,1467,85323,0,0,509,11217,0,0;QS=3,0;MQSB=0.967472;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,112:3:0 0,27,227:9:0 +X 434 . T <*> 0 . DP=29;I16=15,14,0,0,1036,37654,0,0,1647,96123,0,0,561,12567,0,0;QS=3,0;MQSB=0.960561;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,98:3:0 0,30,243:10:0 +X 435 . A <*> 0 . DP=29;I16=15,13,0,0,1024,37970,0,0,1587,92523,0,0,556,12560,0,0;QS=3,0;MQSB=0.968414;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,103:3:0 0,30,237:10:0 +X 436 . T <*> 0 . DP=28;I16=14,14,0,0,998,36220,0,0,1587,92523,0,0,564,12654,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,110:3:0 0,27,223:9:0 +X 437 . T <*> 0 . DP=28;I16=13,14,0,0,990,36832,0,0,1558,91682,0,0,549,12435,0,0;QS=3,0;MQSB=0.999706;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,109:3:0 0,24,207:8:0 +X 438 . A <*> 0 . DP=28;I16=14,13,0,0,972,35640,0,0,1527,88923,0,0,540,12082,0,0;QS=3,0;MQSB=0.9585;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,107:3:0 0,24,216:8:0 +X 439 . C <*> 0 . DP=28;I16=14,14,0,0,1055,40273,0,0,1587,92523,0,0,563,12649,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,107:3:0 0,27,224:9:0 +X 440 . A <*> 0 . DP=28;I16=14,14,0,0,1095,43251,0,0,1587,92523,0,0,561,12615,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,115:3:0 0,27,247:9:0 +X 441 . G <*> 0 . DP=29;I16=15,14,0,0,1068,40344,0,0,1647,96123,0,0,559,12605,0,0;QS=3,0;MQSB=0.960561;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,9,104:3:0 0,27,198:9:0 +X 442 . A <*> 0 . DP=29;I16=15,14,0,0,1091,41507,0,0,1647,96123,0,0,558,12620,0,0;QS=3,0;MQSB=0.960561;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,9,112:3:0 0,27,233:9:0 +X 443 . A <*> 0 . DP=30;I16=15,14,0,0,1173,49439,0,0,1647,96123,0,0,557,12661,0,0;QS=3,0;MQSB=0.960561;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,9,129:3:0 0,27,246:9:0 +X 444 . G <*> 0 . DP=29;I16=15,13,0,0,1095,44661,0,0,1587,92523,0,0,557,12727,0,0;QS=3,0;MQSB=0.968414;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,91:2:0 0,27,227:9:0 +X 445 . C <*> 0 . DP=30;I16=16,13,0,0,1100,43706,0,0,1647,96123,0,0,557,12817,0,0;QS=3,0;MQSB=0.976248;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,9,111:3:0 0,27,219:9:0 +X 446 . A <*> 0 . DP=30;I16=16,13,0,0,1107,44265,0,0,1647,96123,0,0,557,12881,0,0;QS=3,0;MQSB=0.976248;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,9,115:3:0 0,27,232:9:0 +X 447 . C <*> 0 . DP=29;I16=16,12,0,0,1108,45364,0,0,1618,95282,0,0,555,12817,0,0;QS=3,0;MQSB=0.856268;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,114:3:0 0,27,235:9:0 +X 448 . T <*> 0 . DP=29;I16=16,12,0,0,1125,47237,0,0,1618,95282,0,0,553,12773,0,0;QS=3,0;MQSB=0.856268;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,118:3:0 0,27,240:9:0 +X 449 . A <*> 0 . DP=28;I16=15,12,0,0,1091,45981,0,0,1558,91682,0,0,552,12748,0,0;QS=3,0;MQSB=0.84246;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,90:2:0 0,27,245:9:0 +X 450 . G <*> 0 . DP=28;I16=15,12,0,0,1069,44603,0,0,1558,91682,0,0,551,12741,0,0;QS=3,0;MQSB=0.84246;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,91:2:0 0,27,233:9:0 +X 451 . A <*> 0 . DP=28;I16=15,12,0,0,1021,41371,0,0,1558,91682,0,0,550,12752,0,0;QS=3,0;MQSB=0.84246;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,93:2:0 0,27,244:9:0 +X 452 . A <*> 0 . DP=31;I16=18,11,0,0,1079,43353,0,0,1678,98882,0,0,530,12420,0,0;QS=3,0;MQSB=0.884952;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,9,110:3:0 0,24,225:8:0 +X 453 . A <*> 0 . DP=31;I16=17,11,0,0,1037,41069,0,0,1649,98041,0,0,508,11882,0,0;QS=3,0;MQSB=0.967085;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,9,111:3:0 0,21,221:7:0 +X 454 . A <*> 0 . DP=31;I16=18,12,0,0,1158,47028,0,0,1738,102482,0,0,554,12904,0,0;QS=3,0;MQSB=0.878946;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,9,113:3:0 0,30,255:10:0 +X 455 . T <*> 0 . DP=32;I16=17,13,0,0,1148,46574,0,0,1715,100251,0,0,550,12864,0,0;QS=3,0;MQSB=0.973855;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,113:3:0 0,33,255:11:0 +X 456 . G <*> 0 . DP=32;I16=17,13,0,0,1161,47287,0,0,1746,103010,0,0,534,12296,0,0;QS=3,0;MQSB=0.998031;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,9,116:3:0 0,30,245:10:0 +X 457 . C <*> 0 . DP=33;I16=19,13,0,0,1218,48642,0,0,1835,107451,0,0,563,12967,0,0;QS=3,0;MQSB=0.985204;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,9,118:3:0 0,33,255:11:0 +X 458 . A <*> 0 . DP=33;I16=19,13,0,0,1226,49034,0,0,1835,107451,0,0,568,12990,0,0;QS=3,0;MQSB=0.985204;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,9,111:3:0 0,33,255:11:0 +X 459 . T <*> 0 . DP=33;I16=18,13,0,0,1167,46981,0,0,1775,103851,0,0,565,12945,0,0;QS=3,0;MQSB=0.980167;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,92:2:0 0,33,255:11:0 +X 460 . G <*> 0 . DP=32;I16=19,12,0,0,1219,50105,0,0,1775,103851,0,0,575,12929,0,0;QS=3,0;MQSB=0.989977;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,9,116:3:0 0,30,255:10:0 +X 461 . T <*> 0 . DP=32;I16=19,12,0,0,1213,49819,0,0,1775,103851,0,0,577,12845,0,0;QS=3,0;MQSB=0.989977;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,9,115:3:0 0,30,255:10:0 +X 462 . G <*> 0 . DP=32;I16=19,12,0,0,1190,48962,0,0,1775,103851,0,0,580,12792,0,0;QS=3,0;MQSB=0.989977;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,119:4:0 0,30,241:10:0 +X 463 . G <*> 0 . DP=32;I16=19,12,0,0,1114,44214,0,0,1775,103851,0,0,584,12770,0,0;QS=3,0;MQSB=0.989977;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,114:4:0 0,30,221:10:0 +X 464 . A <*> 0 . DP=32;I16=18,11,0,0,1100,43908,0,0,1686,99410,0,0,556,12106,0,0;QS=3,0;MQSB=0.99095;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,133:4:0 0,24,213:8:0 +X 465 . C <*> 0 . DP=33;I16=20,11,0,0,1191,48085,0,0,1775,103851,0,0,586,12786,0,0;QS=3,0;MQSB=0.996597;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,140:5:0 0,27,231:9:0 +X 466 . A <*> 0 . DP=34;I16=21,12,0,0,1293,53311,0,0,1895,111051,0,0,597,12897,0,0;QS=3,0;MQSB=0.995633;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,154:5:0 0,30,255:10:0 +X 467 . A <*> 0 . DP=34;I16=21,11,0,0,1256,51450,0,0,1835,107451,0,0,597,12891,0,0;QS=3,0;MQSB=0.998231;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,157:5:0 0,27,248:9:0 +X 468 . A <*> 0 . DP=35;I16=22,12,0,0,1274,51268,0,0,1955,114651,0,0,604,12904,0,0;QS=3,0;MQSB=0.997406;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,154:5:0 0,30,251:10:0 +X 469 . A <*> 0 . DP=35;I16=22,12,0,0,1285,52989,0,0,1955,114651,0,0,608,12940,0,0;QS=3,0;MQSB=0.997406;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,146:5:0 0,30,255:10:0 +X 470 . G <*> 0 . DP=35;I16=22,12,0,0,1281,51055,0,0,1955,114651,0,0,612,13016,0,0;QS=3,0;MQSB=0.997406;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,148:5:0 0,30,238:10:0 +X 471 . T <*> 0 . DP=36;I16=22,11,0,0,1239,49021,0,0,1918,113282,0,0,599,12825,0,0;QS=3,0;MQSB=0.915545;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,150:5:0 0,27,232:9:0 +X 472 . T <*> 0 . DP=35;I16=21,12,0,0,1245,48915,0,0,1926,113810,0,0,595,12559,0,0;QS=3,0;MQSB=0.988858;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,153:5:0 0,27,237:9:0 +X 473 . G <*> 0 . DP=35;I16=21,12,0,0,1307,53473,0,0,1926,113810,0,0,599,12651,0,0;QS=3,0;MQSB=0.988858;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,141:5:0 0,27,249:9:0 +X 474 . G <*> 0 . DP=36;I16=22,12,0,0,1284,51708,0,0,1986,117410,0,0,602,12734,0,0;QS=3,0;MQSB=0.986937;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,131:5:0 0,30,255:10:0 +X 475 . G <*> 0 . DP=36;I16=23,12,0,0,1311,51609,0,0,2015,118251,0,0,631,13485,0,0;QS=3,0;MQSB=0.998642;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,141:5:0 0,33,252:11:0 +X 476 . A <*> 0 . DP=36;I16=23,12,0,0,1312,52078,0,0,2015,118251,0,0,634,13606,0,0;QS=3,0;MQSB=0.998642;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,157:5:0 0,33,255:11:0 +X 477 . T <*> 0 . DP=36;I16=23,12,0,0,1318,52668,0,0,2015,118251,0,0,637,13773,0,0;QS=3,0;MQSB=0.998642;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,148:5:0 0,33,255:11:0 +X 478 . T <*> 0 . DP=38;I16=25,12,0,0,1338,51774,0,0,2135,125451,0,0,637,13833,0,0;QS=3,0;MQSB=0.999868;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,18,154:6:0 0,33,255:11:0 +X 479 . A <*> 0 . DP=38;I16=25,12,0,0,1420,57788,0,0,2135,125451,0,0,639,13935,0,0;QS=3,0;MQSB=0.999868;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,18,163:6:0 0,33,255:11:0 +X 480 . G <*> 0 . DP=37;I16=25,11,0,0,1438,60172,0,0,2075,121851,0,0,641,14029,0,0;QS=3,0;MQSB=0.999853;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,165:6:0 0,33,255:11:0 +X 481 . G <*> 0 . DP=37;I16=25,11,0,0,1392,55824,0,0,2075,121851,0,0,642,14112,0,0;QS=3,0;MQSB=0.999853;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,165:6:0 0,33,255:11:0 +X 482 . A <*> 0 . DP=37;I16=24,11,0,0,1352,55134,0,0,2015,118251,0,0,618,13608,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,143:5:0 0,33,255:11:0 +X 483 . G <*> 0 . DP=37;I16=24,12,0,0,1417,57747,0,0,2075,121851,0,0,642,14240,0,0;QS=3,0;MQSB=0.999437;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,165:6:0 0,33,255:11:0 +X 484 . A <*> 0 . DP=36;I16=24,11,0,0,1340,53992,0,0,2015,118251,0,0,643,14281,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,168:6:0 0,33,255:11:0 +X 485 . G <*> 0 . DP=35;I16=23,12,0,0,1329,51411,0,0,2015,118251,0,0,669,14931,0,0;QS=3,0;MQSB=0.998642;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,160:6:0 0,33,255:11:0 +X 486 . A <*> 0 . DP=34;I16=22,12,0,0,1311,51523,0,0,1955,114651,0,0,671,14989,0,0;QS=3,0;MQSB=0.997406;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,173:6:0 0,33,255:11:0 +X 487 . G <*> 0 . DP=34;I16=22,12,0,0,1306,50760,0,0,1955,114651,0,0,672,15030,0,0;QS=3,0;MQSB=0.997406;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,169:6:0 0,33,255:11:0 +X 488 . A <*> 0 . DP=35;I16=22,12,0,0,1274,48140,0,0,1986,117410,0,0,646,14380,0,0;QS=3,0;MQSB=0.986937;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,177:6:0 0,30,255:10:0 +X 489 . A <*> 0 . DP=35;I16=23,12,0,0,1264,46916,0,0,2015,118251,0,0,671,15015,0,0;QS=3,0;MQSB=0.998642;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,175:6:0 0,33,255:11:0 +X 490 . A <*> 0 . DP=36;I16=24,12,0,0,1332,50280,0,0,2075,121851,0,0,671,15061,0,0;QS=3,0;MQSB=0.999437;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,188:7:0 0,33,255:11:0 +X 491 . T <*> 0 . DP=36;I16=24,12,0,0,1284,46802,0,0,2075,121851,0,0,671,15093,0,0;QS=3,0;MQSB=0.999437;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,178:7:0 0,33,255:11:0 +X 492 . G <*> 0 . DP=35;I16=21,12,0,0,1252,48326,0,0,1926,113810,0,0,621,13859,0,0;QS=3,0;MQSB=0.988858;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,172:6:0 0,30,251:10:0 +X 493 . A <*> 0 . DP=34;I16=22,11,0,0,1273,49481,0,0,1926,113810,0,0,650,14672,0,0;QS=3,0;MQSB=0.981935;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,186:7:0 0,24,240:8:0 +X 494 . A <*> 0 . DP=34;I16=22,12,0,0,1326,52604,0,0,1986,117410,0,0,672,15182,0,0;QS=3,0;MQSB=0.986937;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,196:7:0 0,27,255:9:0 +X 495 . G <*> 0 . DP=34;I16=21,12,0,0,1255,48577,0,0,1926,113810,0,0,647,14611,0,0;QS=3,0;MQSB=0.988858;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,168:6:0 0,27,244:9:0 +X 496 . A <*> 0 . DP=34;I16=22,12,0,0,1250,46926,0,0,1986,117410,0,0,670,15220,0,0;QS=3,0;MQSB=0.986937;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,186:7:0 0,27,249:9:0 +X 497 . C <*> 0 . DP=34;I16=22,12,0,0,1250,47006,0,0,1986,117410,0,0,665,15087,0,0;QS=3,0;MQSB=0.986937;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,164:7:0 0,27,239:9:0 +X 498 . A <*> 0 . DP=34;I16=22,12,0,0,1286,49158,0,0,1986,117410,0,0,661,14987,0,0;QS=3,0;MQSB=0.986937;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,185:7:0 0,27,252:9:0 +X 499 . T <*> 0 . DP=34;I16=23,11,0,0,1224,45284,0,0,1986,117410,0,0,659,14919,0,0;QS=3,0;MQSB=0.979712;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,183:7:0 0,30,255:10:0 +X 500 . A <*> 0 . DP=34;I16=23,11,0,0,1230,45152,0,0,1986,117410,0,0,657,14833,0,0;QS=3,0;MQSB=0.979712;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,179:7:0 0,30,255:10:0 +X 501 . T <*> 0 . DP=33;I16=23,10,0,0,1241,47167,0,0,1926,113810,0,0,656,14778,0,0;QS=3,0;MQSB=0.972757;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,186:7:0 0,27,241:9:0 +X 502 . G <*> 0 . DP=33;I16=23,10,0,0,1215,45829,0,0,1926,113810,0,0,655,14753,0,0;QS=3,0;MQSB=0.972757;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,183:7:0 0,27,235:9:0 +X 503 . T <*> 0 . DP=34;I16=23,11,0,0,1194,43366,0,0,1986,117410,0,0,654,14758,0,0;QS=3,0;MQSB=0.979712;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,177:7:0 0,27,234:9:0 +X 504 . C <*> 0 . DP=34;I16=23,11,0,0,1218,45552,0,0,1986,117410,0,0,651,14643,0,0;QS=3,0;MQSB=0.979712;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,183:7:0 0,27,219:9:0 +X 505 . C <*> 0 . DP=35;I16=23,11,0,0,1207,44321,0,0,1986,117410,0,0,641,14509,0,0;QS=3,0;MQSB=0.979712;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,189:7:0 0,27,221:9:0 +X 506 . A <*> 0 . DP=35;I16=24,11,0,0,1266,46776,0,0,2046,121010,0,0,646,14504,0,0;QS=3,0;MQSB=0.977529;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,188:7:0 0,27,231:9:0 +X 507 . C <*> 0 . DP=35;I16=23,11,0,0,1220,45016,0,0,1986,117410,0,0,635,14401,0,0;QS=3,0;MQSB=0.979712;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,183:7:0 0,27,226:9:0 +X 508 . A <*> 0 . DP=34;I16=24,10,0,0,1204,44542,0,0,1986,117410,0,0,643,14491,0,0;QS=3,0;MQSB=0.970272;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,189:7:0 0,27,220:9:0 +X 509 . C <*> 0 . DP=34;I16=24,10,0,0,1272,48272,0,0,1986,117410,0,0,640,14430,0,0;QS=3,0;MQSB=0.970272;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,186:7:0 0,27,241:9:0 +X 510 . A <*> 0 . DP=34;I16=22,11,0,0,1194,44196,0,0,1926,113810,0,0,613,13773,0,0;QS=3,0;MQSB=0.981935;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,187:7:0 0,24,221:8:0 +X 511 . A <*> 0 . DP=34;I16=23,11,0,0,1222,45562,0,0,1986,117410,0,0,637,14395,0,0;QS=3,0;MQSB=0.979712;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,195:7:0 0,24,233:8:0 +X 512 . A C,<*> 0 . DP=33;I16=22,10,0,1,1121,40793,13,169,1866,110210,60,3600,628,14340,9,81;QS=2.97719,0.022807,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.981935;BQB=1;MQ0F=0 PL:DP:DV 0,39,255,51,255,255:18:1 0,21,183,21,183,183:7:0 0,24,231,24,231,231:8:0 +X 513 . A <*> 0 . DP=32;I16=20,10,0,0,1115,42183,0,0,1746,103010,0,0,598,13624,0,0;QS=3,0;MQSB=0.980594;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,175:6:0 0,24,233:8:0 +X 514 . A T,<*> 0 . DP=32;I16=20,9,0,1,1066,40004,16,256,1686,99410,60,3600,586,13500,11,121;QS=2.97075,0.0292505,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.980594;BQB=1;MQ0F=0 PL:DP:DV 0,31,255,45,255,255:16:1 0,18,171,18,171,171:6:0 0,24,235,24,235,235:8:0 +X 515 . C <*> 0 . DP=32;I16=18,10,0,0,1010,37294,0,0,1626,95810,0,0,561,12915,0,0;QS=3,0;MQSB=0.986018;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,167:6:0 0,24,211:8:0 +X 516 . C <*> 0 . DP=32;I16=21,10,0,0,1100,40570,0,0,1806,106610,0,0,612,13954,0,0;QS=3,0;MQSB=0.977926;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,187:7:0 0,24,215:8:0 +X 517 . T <*> 0 . DP=33;I16=23,10,0,0,1269,49995,0,0,1926,113810,0,0,636,14626,0,0;QS=3,0;MQSB=0.972757;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,201:7:0 0,24,242:8:0 +X 518 . G <*> 0 . DP=34;I16=24,10,0,0,1247,46839,0,0,1986,117410,0,0,636,14696,0,0;QS=3,0;MQSB=0.970272;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,182:7:0 0,24,220:8:0 +X 519 . T <*> 0 . DP=36;I16=25,11,0,0,1283,46693,0,0,2106,124610,0,0,636,14742,0,0;QS=3,0;MQSB=0.975394;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,21,177:7:0 0,24,224:8:0 +X 520 . T <*> 0 . DP=36;I16=24,11,0,0,1238,44894,0,0,2046,121010,0,0,613,14193,0,0;QS=3,0;MQSB=0.977529;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,21,180:7:0 0,24,223:8:0 +X 521 . C <*> 0 . DP=34;I16=25,9,0,0,1280,49454,0,0,1986,117410,0,0,641,14875,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,21,191:7:0 0,21,204:7:0 +X 522 . A <*> 0 . DP=32;I16=24,8,0,0,1158,43228,0,0,1897,112969,0,0,646,14960,0,0;QS=3,0;MQSB=0.872525;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,21,185:7:0 0,15,170:5:0 +X 523 . T G,<*> 0 . DP=32;I16=23,8,1,0,1184,45708,15,225,1837,109369,60,3600,626,14446,25,625;QS=2.9794,0.0206044,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.872525;BQB=1;MQ0F=0 PL:DP:DV 0,44,255,57,255,255:20:1 0,21,191,21,191,191:7:0 0,15,166,15,166,166:5:0 +X 524 . T <*> 0 . DP=32;I16=24,7,0,0,1084,39474,0,0,1837,109369,0,0,629,14483,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,21,194:7:0 0,12,140:4:0 +X 525 . G <*> 0 . DP=32;I16=24,7,0,0,1181,45669,0,0,1837,109369,0,0,631,14495,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,21,188:7:0 0,12,129:4:0 +X 526 . C <*> 0 . DP=32;I16=24,7,0,0,1146,43950,0,0,1860,111600,0,0,633,14531,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,21,185:7:0 0,12,131:4:0 +X 527 . A <*> 0 . DP=33;I16=24,8,0,0,1209,46265,0,0,1897,112969,0,0,636,14634,0,0;QS=3,0;MQSB=0.872525;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,194:7:0 0,18,181:6:0 +X 528 . G <*> 0 . DP=33;I16=24,8,0,0,1256,49824,0,0,1897,112969,0,0,634,14484,0,0;QS=3,0;MQSB=0.872525;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,18,169:6:0 0,18,193:6:0 +X 529 . C <*> 0 . DP=32;I16=24,7,0,0,1148,44362,0,0,1837,109369,0,0,633,14357,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,187:7:0 0,18,184:6:0 +X 530 . T <*> 0 . DP=32;I16=25,7,0,0,1244,49168,0,0,1897,112969,0,0,657,14883,0,0;QS=3,0;MQSB=0.850154;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,196:7:0 0,18,202:6:0 +X 531 . T <*> 0 . DP=32;I16=25,7,0,0,1177,44171,0,0,1897,112969,0,0,654,14714,0,0;QS=3,0;MQSB=0.850154;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,181:7:0 0,18,193:6:0 +X 532 . T <*> 0 . DP=32;I16=24,7,0,0,1153,43543,0,0,1837,109369,0,0,630,14116,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,181:7:0 0,18,192:6:0 +X 533 . C <*> 0 . DP=32;I16=24,7,0,0,1142,43940,0,0,1837,109369,0,0,619,13649,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,178:7:0 0,18,180:6:0 +X 534 . T <*> 0 . DP=31;I16=24,6,0,0,1212,49426,0,0,1777,105769,0,0,615,13479,0,0;QS=3,0;MQSB=0.82403;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,205:7:0 0,18,205:6:0 +X 535 . A <*> 0 . DP=31;I16=24,6,0,0,1080,39870,0,0,1777,105769,0,0,611,13341,0,0;QS=3,0;MQSB=0.82403;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,194:7:0 0,18,189:6:0 +X 536 . C <*> 0 . DP=31;I16=24,7,0,0,1097,40707,0,0,1837,109369,0,0,631,13809,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,184:7:0 0,18,157:6:0 +X 537 . C <*> 0 . DP=31;I16=22,7,0,0,1034,38564,0,0,1717,102169,0,0,587,12861,0,0;QS=3,0;MQSB=0.854582;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,172:7:0 0,18,183:6:0 +X 538 . A <*> 0 . DP=31;I16=24,7,0,0,1138,42478,0,0,1837,109369,0,0,620,13536,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,189:7:0 0,18,181:6:0 +X 539 . T <*> 0 . DP=31;I16=24,7,0,0,1134,42070,0,0,1837,109369,0,0,614,13422,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,178:7:0 0,18,181:6:0 +X 540 . C <*> 0 . DP=31;I16=24,7,0,0,1148,43768,0,0,1837,109369,0,0,608,13340,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,177:7:0 0,18,178:6:0 +X 541 . A <*> 0 . DP=32;I16=24,6,0,0,1083,40483,0,0,1777,105769,0,0,551,11991,0,0;QS=3,0;MQSB=0.82403;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,180:8:0 0,15,150:5:0 +X 542 . C <*> 0 . DP=33;I16=25,6,0,0,1123,41759,0,0,1837,109369,0,0,570,12552,0,0;QS=3,0;MQSB=0.822578;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,172:8:0 0,18,174:6:0 +X 543 . C <*> 0 . DP=34;I16=25,9,0,0,1219,45959,0,0,1986,117410,0,0,601,13245,0,0;QS=3,0;MQSB=0.621145;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,27,194:9:0 0,18,188:6:0 +X 544 . A <*> 0 . DP=33;I16=24,8,0,0,1170,43898,0,0,1866,110210,0,0,570,12506,0,0;QS=3,0;MQSB=0.579578;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,24,192:8:0 0,18,180:6:0 +X 545 . A <*> 0 . DP=33;I16=25,8,0,0,1174,43602,0,0,1926,113810,0,0,587,12951,0,0;QS=3,0;MQSB=0.576102;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,24,190:8:0 0,18,184:6:0 +X 546 . A <*> 0 . DP=32;I16=24,8,0,0,1126,41444,0,0,1866,110210,0,0,580,12802,0,0;QS=3,0;MQSB=0.579578;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,166:7:0 0,18,193:6:0 +X 547 . A <*> 0 . DP=32;I16=24,7,0,0,1129,42381,0,0,1806,106610,0,0,547,12009,0,0;QS=3,0;MQSB=0.525788;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,180:7:0 0,18,195:6:0 +X 548 . A <*> 0 . DP=33;I16=23,9,0,0,1153,42673,0,0,1866,110210,0,0,561,12489,0,0;QS=3,0;MQSB=0.628357;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,181:7:0 0,21,211:7:0 +X 549 . T G,<*> 0 . DP=32;I16=22,8,0,1,1101,40987,20,400,1746,103010,60,3600,530,11716,25,625;QS=2.96748,0.0325203,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.632337;BQB=1;MQ0F=0 PL:DP:DV 0,31,255,48,255,255:17:1 0,21,168,21,168,168:7:0 0,21,208,21,208,208:7:0 +X 550 . T <*> 0 . DP=32;I16=22,9,0,0,1052,37298,0,0,1806,106610,0,0,548,12176,0,0;QS=3,0;MQSB=0.632337;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,150:7:0 0,21,220:7:0 +X 551 . G <*> 0 . DP=31;I16=22,9,0,0,1121,41639,0,0,1806,106610,0,0,541,12045,0,0;QS=3,0;MQSB=0.632337;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,172:7:0 0,21,208:7:0 +X 552 . C <*> 0 . DP=30;I16=21,9,0,0,1093,41365,0,0,1746,103010,0,0,535,11947,0,0;QS=3,0;MQSB=0.636601;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,167:7:0 0,21,208:7:0 +X 553 . A <*> 0 . DP=30;I16=20,8,0,0,981,35387,0,0,1626,95810,0,0,485,10831,0,0;QS=3,0;MQSB=0.596163;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,150:6:0 0,21,194:7:0 +X 554 . A <*> 0 . DP=30;I16=19,9,0,0,975,35601,0,0,1626,95810,0,0,488,10906,0,0;QS=3,0;MQSB=0.646113;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,139:5:0 0,24,211:8:0 +X 555 . A <*> 0 . DP=30;I16=20,10,0,0,1024,36526,0,0,1746,103010,0,0,514,11392,0,0;QS=3,0;MQSB=0.679025;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,150:6:0 0,21,211:7:0 +X 556 . C <*> 0 . DP=29;I16=20,9,0,0,1055,39195,0,0,1709,101641,0,0,509,11219,0,0;QS=3,0;MQSB=0.894839;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,158:6:0 0,18,186:6:0 +X 557 . A <*> 0 . DP=27;I16=18,9,0,0,987,36749,0,0,1589,94441,0,0,506,11074,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,157:6:0 0,18,186:6:0 +X 558 . A <*> 0 . DP=27;I16=18,8,0,0,948,35808,0,0,1560,93600,0,0,477,10281,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,143:5:0 0,18,177:6:0 +X 559 . C A,<*> 0 . DP=27;I16=17,8,0,1,908,33726,14,196,1500,90000,29,841,448,9516,25,625;QS=2.92708,0.0729167,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.90038;BQB=1;MQ0F=0 PL:DP:DV 0,42,255,42,255,255:14:0 0,4,116,15,119,123:6:1 0,18,169,18,169,169:6:0 +X 560 . C <*> 0 . DP=28;I16=19,9,0,0,992,36552,0,0,1649,98041,0,0,494,10654,0,0;QS=3,0;MQSB=0.896555;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,160:6:0 0,21,181:7:0 +X 561 . A <*> 0 . DP=28;I16=18,9,0,0,963,35455,0,0,1589,94441,0,0,466,9946,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,158:6:0 0,21,194:7:0 +X 562 . C <*> 0 . DP=28;I16=18,9,0,0,1006,38392,0,0,1589,94441,0,0,463,9893,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,153:6:0 0,21,187:7:0 +X 563 . A <*> 0 . DP=27;I16=17,9,0,0,893,32413,0,0,1529,90841,0,0,460,9820,0,0;QS=3,0;MQSB=0.90038;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,149:5:0 0,21,179:7:0 +X 564 . C <*> 0 . DP=27;I16=18,9,0,0,859,28747,0,0,1589,94441,0,0,482,10402,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,121:5:0 0,21,182:7:0 +X 565 . G <*> 0 . DP=30;I16=17,9,0,0,818,26928,0,0,1560,93600,0,0,454,9764,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,96:4:0 0,21,154:7:0 +X 566 . C <*> 0 . DP=29;I16=15,11,0,0,903,33405,0,0,1529,90841,0,0,424,9084,0,0;QS=3,0;MQSB=0.927041;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,155:5:0 0,18,167:6:0 +X 567 . C <*> 0 . DP=30;I16=15,12,0,0,932,33774,0,0,1589,94441,0,0,462,10178,0,0;QS=3,0;MQSB=0.935229;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,155:5:0 0,21,196:7:0 +X 568 . C <*> 0 . DP=29;I16=15,13,0,0,1057,40817,0,0,1649,98041,0,0,482,10438,0,0;QS=3,0;MQSB=0.942064;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,183:6:0 0,18,189:6:0 +X 569 . T <*> 0 . DP=30;I16=16,12,0,0,1056,41296,0,0,1649,98041,0,0,493,10655,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,190:6:0 0,21,213:7:0 +X 570 . T <*> 0 . DP=30;I16=16,12,0,0,954,34972,0,0,1680,100800,0,0,472,10086,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,157:5:0 0,21,195:7:0 +X 571 . C <*> 0 . DP=31;I16=17,12,0,0,1061,40675,0,0,1740,104400,0,0,472,10158,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,155:5:0 0,21,193:7:0 +X 572 . A <*> 0 . DP=31;I16=18,12,0,0,1102,42642,0,0,1769,105241,0,0,499,10887,0,0;QS=3,0;MQSB=0.929991;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,203:7:0 0,18,175:6:0 +X 573 . A <*> 0 . DP=31;I16=18,12,0,0,1057,38473,0,0,1769,105241,0,0,501,10975,0,0;QS=3,0;MQSB=0.929991;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,199:7:0 0,18,178:6:0 +X 574 . C A,<*> 0 . DP=31;I16=18,11,0,1,1088,41328,15,225,1740,104400,29,841,478,10422,25,625;QS=2.94071,0.0592885,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.929991;BQB=1;MQ0F=0 PL:DP:DV 0,48,255,48,255,255:16:0 0,9,170,21,173,177:8:1 0,18,173,18,173,173:6:0 +X 575 . T <*> 0 . DP=30;I16=16,10,0,0,1024,41260,0,0,1560,93600,0,0,448,9842,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,21,209:7:0 0,15,163:5:0 +X 576 . G <*> 0 . DP=30;I16=17,12,0,0,1047,40077,0,0,1709,101641,0,0,507,11087,0,0;QS=3,0;MQSB=0.931617;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,208:8:0 0,15,151:5:0 +X 577 . G <*> 0 . DP=30;I16=16,12,0,0,999,37747,0,0,1649,98041,0,0,489,10755,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,24,204:8:0 0,15,146:5:0 +X 578 . G <*> 0 . DP=29;I16=16,13,0,0,975,34803,0,0,1709,101641,0,0,520,11286,0,0;QS=3,0;MQSB=0.940317;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,198:8:0 0,15,151:5:0 +X 579 . G <*> 0 . DP=30;I16=15,13,0,0,1028,38752,0,0,1649,98041,0,0,484,10514,0,0;QS=3,0;MQSB=0.942064;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,224:8:0 0,12,145:4:0 +X 580 . A C,<*> 0 . DP=30;I16=15,14,1,0,1060,39178,16,256,1709,101641,60,3600,510,11078,17,289;QS=2.97338,0.0266223,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.946202;BQB=1;MQ0F=0 PL:DP:DV 0,34,255,48,255,255:17:1 0,24,221,24,221,221:8:0 0,15,155,15,155,155:5:0 +X 581 . A <*> 0 . DP=31;I16=16,15,0,0,1083,39215,0,0,1829,108841,0,0,530,11384,0,0;QS=3,0;MQSB=0.951229;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,24,223:8:0 0,15,153:5:0 +X 582 . C <*> 0 . DP=31;I16=15,15,0,0,1080,39870,0,0,1769,105241,0,0,519,11211,0,0;QS=3,0;MQSB=0.952765;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,207:8:0 0,15,151:5:0 +X 583 . T <*> 0 . DP=30;I16=16,14,0,0,1136,43996,0,0,1769,105241,0,0,539,11523,0,0;QS=3,0;MQSB=0.946202;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,238:8:0 0,15,163:5:0 +X 584 . C <*> 0 . DP=31;I16=16,13,0,0,1051,39351,0,0,1709,101641,0,0,499,10619,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,207:7:0 0,15,157:5:0 +X 585 . A <*> 0 . DP=31;I16=17,14,0,0,1096,39866,0,0,1798,106082,0,0,549,11751,0,0;QS=3,0;MQSB=0.998229;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,24,211:8:0 0,15,157:5:0 +X 586 . T <*> 0 . DP=31;I16=16,14,0,0,1081,39839,0,0,1738,102482,0,0,546,11796,0,0;QS=3,0;MQSB=0.999136;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,212:8:0 0,15,156:5:0 +X 587 . C <*> 0 . DP=31;I16=17,13,0,0,1070,39402,0,0,1769,105241,0,0,532,11350,0,0;QS=3,0;MQSB=0.963674;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,201:7:0 0,15,155:5:0 +X 588 . A <*> 0 . DP=31;I16=17,14,0,0,1126,41642,0,0,1798,106082,0,0,562,12140,0,0;QS=3,0;MQSB=0.998229;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,24,222:8:0 0,15,164:5:0 +X 589 . A <*> 0 . DP=31;I16=17,14,0,0,1157,43973,0,0,1798,106082,0,0,568,12340,0,0;QS=3,0;MQSB=0.998229;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,24,236:8:0 0,15,165:5:0 +X 590 . C <*> 0 . DP=32;I16=16,14,0,0,1094,41302,0,0,1769,105241,0,0,549,11951,0,0;QS=3,0;MQSB=0.958545;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,192:6:0 0,18,175:6:0 +X 591 . A <*> 0 . DP=31;I16=16,15,0,0,1165,44163,0,0,1798,106082,0,0,579,12695,0,0;QS=3,0;MQSB=0.999805;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,209:7:0 0,18,188:6:0 +X 592 . A <*> 0 . DP=31;I16=15,15,0,0,1114,42144,0,0,1738,102482,0,0,571,12651,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,215:7:0 0,18,182:6:0 +X 593 . C <*> 0 . DP=31;I16=15,14,0,0,1065,39889,0,0,1709,101641,0,0,550,12132,0,0;QS=3,0;MQSB=0.954405;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,191:6:0 0,18,174:6:0 +X 594 . A <*> 0 . DP=33;I16=16,16,0,0,1163,42917,0,0,1858,109682,0,0,572,12672,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,205:7:0 0,24,212:8:0 +X 595 . A <*> 0 . DP=33;I16=17,16,0,0,1130,39996,0,0,1918,113282,0,0,589,12905,0,0;QS=3,0;MQSB=0.999838;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,198:7:0 0,24,213:8:0 +X 596 . A <*> 0 . DP=33;I16=16,16,0,0,1059,37039,0,0,1858,109682,0,0,590,12952,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,169:7:0 0,24,230:8:0 +X 597 . C <*> 0 . DP=33;I16=17,16,0,0,1196,44890,0,0,1918,113282,0,0,592,12990,0,0;QS=3,0;MQSB=0.999838;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,204:7:0 0,24,220:8:0 +X 598 . T <*> 0 . DP=33;I16=16,16,0,0,1214,47104,0,0,1858,109682,0,0,593,13013,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,217:7:0 0,24,239:8:0 +X 599 . T <*> 0 . DP=33;I16=16,17,0,0,1183,43669,0,0,1918,113282,0,0,599,13095,0,0;QS=3,0;MQSB=0.999838;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,197:7:0 0,27,247:9:0 +X 600 . G <*> 0 . DP=32;I16=15,17,0,0,1174,44066,0,0,1858,109682,0,0,601,13145,0,0;QS=3,0;MQSB=0.999287;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,194:7:0 0,24,232:8:0 +X 601 . T <*> 0 . DP=32;I16=15,17,0,0,1114,39954,0,0,1858,109682,0,0,603,13227,0,0;QS=3,0;MQSB=0.999287;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,188:7:0 0,24,235:8:0 +X 602 . G <*> 0 . DP=32;I16=15,15,0,0,1090,40326,0,0,1769,105241,0,0,555,12091,0,0;QS=3,0;MQSB=0.952765;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,185:6:0 0,24,229:8:0 +X 603 . G <*> 0 . DP=31;I16=15,16,0,0,1052,37460,0,0,1798,106082,0,0,607,13437,0,0;QS=3,0;MQSB=0.999805;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,186:7:0 0,24,219:8:0 +X 604 . T <*> 0 . DP=31;I16=14,16,0,0,1009,35893,0,0,1769,105241,0,0,564,12540,0,0;QS=3,0;MQSB=0.958545;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,24,195:8:0 0,21,212:7:0 +X 605 . T <*> 0 . DP=31;I16=12,15,0,0,1001,37741,0,0,1589,94441,0,0,514,11258,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,200:7:0 0,21,214:7:0 +X 606 . T <*> 0 . DP=31;I16=13,16,0,0,992,35202,0,0,1709,101641,0,0,587,13125,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,21,189:7:0 0,24,217:8:0 +X 607 . A <*> 0 . DP=31;I16=14,16,0,0,1027,36129,0,0,1738,102482,0,0,607,13577,0,0;QS=3,0;MQSB=0.999136;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,176:7:0 0,24,222:8:0 +X 608 . C <*> 0 . DP=32;I16=15,15,0,0,983,33775,0,0,1769,105241,0,0,564,12564,0,0;QS=3,0;MQSB=0.952765;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,21,178:7:0 0,27,214:9:0 +X 609 . C <*> 0 . DP=32;I16=14,17,0,0,1074,38220,0,0,1798,106082,0,0,606,13678,0,0;QS=3,0;MQSB=0.998229;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,190:7:0 0,27,238:9:0 +X 610 . C <*> 0 . DP=32;I16=15,16,0,0,1158,44218,0,0,1829,108841,0,0,594,13444,0,0;QS=3,0;MQSB=0.951229;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,211:8:0 0,27,246:9:0 +X 611 . A <*> 0 . DP=32;I16=15,16,0,0,1080,39204,0,0,1798,106082,0,0,590,13260,0,0;QS=3,0;MQSB=0.999805;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,27,220:9:0 0,27,246:9:0 +X 612 . C <*> 0 . DP=33;I16=16,17,0,0,1175,43305,0,0,1918,113282,0,0,617,13993,0,0;QS=3,0;MQSB=0.999838;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,27,214:9:0 0,27,250:9:0 +X 613 . A <*> 0 . DP=34;I16=16,17,0,0,1131,40011,0,0,1949,116041,0,0,604,13874,0,0;QS=3,0;MQSB=0.954207;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,27,223:9:0 0,27,239:9:0 +X 614 . C <*> 0 . DP=34;I16=16,17,0,0,1183,43743,0,0,1949,116041,0,0,608,14022,0,0;QS=3,0;MQSB=0.954207;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,27,223:9:0 0,27,245:9:0 +X 615 . A <*> 0 . DP=34;I16=16,18,0,0,1199,43809,0,0,1978,116882,0,0,626,14394,0,0;QS=3,0;MQSB=0.999405;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,30,240:10:0 0,27,254:9:0 +X 616 . A <*> 0 . DP=34;I16=16,17,0,0,1190,44024,0,0,1949,116041,0,0,615,14351,0,0;QS=3,0;MQSB=0.954207;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,27,247:9:0 0,27,255:9:0 +X 617 . T <*> 0 . DP=33;I16=15,18,0,0,1170,43066,0,0,1918,113282,0,0,630,14624,0,0;QS=3,0;MQSB=0.998531;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,30,241:10:0 0,27,255:9:0 +X 618 . G <*> 0 . DP=34;I16=15,19,0,0,1166,41452,0,0,1978,116882,0,0,632,14706,0,0;QS=3,0;MQSB=0.997597;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,30,248:10:0 0,27,240:9:0 +X 619 . G <*> 0 . DP=32;I16=14,18,0,0,1153,42591,0,0,1858,109682,0,0,638,14816,0,0;QS=3,0;MQSB=0.997118;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,30,254:10:0 0,27,247:9:0 +X 620 . A <*> 0 . DP=32;I16=14,17,0,0,1083,39757,0,0,1798,106082,0,0,616,14176,0,0;QS=3,0;MQSB=0.998229;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,30,248:10:0 0,27,255:9:0 +X 621 . A <*> 0 . DP=32;I16=13,18,0,0,1170,45248,0,0,1798,106082,0,0,627,14519,0,0;QS=3,0;MQSB=0.995005;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,27,255:9:0 0,27,255:9:0 +X 622 . G <*> 0 . DP=32;I16=12,18,0,0,1060,39160,0,0,1769,105241,0,0,604,13888,0,0;QS=3,0;MQSB=0.968257;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,236:9:0 0,27,249:9:0 +X 623 . A T,<*> 0 . DP=32;I16=10,18,1,0,1010,37414,15,225,1649,98041,60,3600,563,12953,25,625;QS=2.96144,0.0385604,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.969907;BQB=1;MQ0F=0 PL:DP:DV 0,20,241,33,244,246:12:1 0,24,213,24,213,213:8:0 0,27,255,27,255,255:9:0 +X 624 . C <*> 0 . DP=32;I16=13,17,0,0,1034,37292,0,0,1738,102482,0,0,607,13887,0,0;QS=3,0;MQSB=0.996503;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,220:9:0 0,27,242:9:0 +X 625 . C <*> 0 . DP=32;I16=13,18,0,0,1108,41138,0,0,1798,106082,0,0,632,14470,0,0;QS=3,0;MQSB=0.995005;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,27,234:9:0 0,27,249:9:0 +X 626 . A <*> 0 . DP=32;I16=13,17,0,0,1090,40718,0,0,1738,102482,0,0,607,13827,0,0;QS=3,0;MQSB=0.996503;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,237:9:0 0,27,247:9:0 +X 627 . C <*> 0 . DP=32;I16=12,18,0,0,1146,44452,0,0,1769,105241,0,0,607,13833,0,0;QS=3,0;MQSB=0.968257;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,244:9:0 0,27,255:9:0 +X 628 . T <*> 0 . DP=32;I16=11,19,0,0,1124,43114,0,0,1769,105241,0,0,608,13862,0,0;QS=3,0;MQSB=0.972375;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,27,249:9:0 0,24,249:8:0 +X 629 . T <*> 0 . DP=32;I16=12,19,0,0,1114,41138,0,0,1798,106082,0,0,634,14490,0,0;QS=3,0;MQSB=0.989977;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,247:9:0 0,24,226:8:0 +X 630 . A <*> 0 . DP=31;I16=11,18,0,0,1101,42885,0,0,1740,104400,0,0,610,13844,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,24,242:8:0 0,24,235:8:0 +X 631 . G <*> 0 . DP=31;I16=12,18,0,0,1083,40525,0,0,1769,105241,0,0,636,14474,0,0;QS=3,0;MQSB=0.929991;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,233:8:0 0,24,223:8:0 +X 632 . C <*> 0 . DP=31;I16=11,18,0,0,1105,42665,0,0,1740,104400,0,0,612,13880,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,24,233:8:0 0,24,224:8:0 +X 633 . A <*> 0 . DP=31;I16=12,18,0,0,1056,38190,0,0,1769,105241,0,0,638,14562,0,0;QS=3,0;MQSB=0.929991;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,218:8:0 0,24,214:8:0 +X 634 . A <*> 0 . DP=31;I16=12,18,0,0,1110,42208,0,0,1769,105241,0,0,638,14594,0,0;QS=3,0;MQSB=0.929991;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,238:8:0 0,24,229:8:0 +X 635 . C <*> 0 . DP=31;I16=11,18,0,0,1031,37871,0,0,1740,104400,0,0,613,14025,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,24,220:8:0 0,24,229:8:0 +X 636 . A <*> 0 . DP=31;I16=11,18,0,0,1115,43327,0,0,1740,104400,0,0,611,14005,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,24,228:8:0 0,24,243:8:0 +X 637 . A <*> 0 . DP=31;I16=12,18,0,0,1152,44602,0,0,1769,105241,0,0,634,14634,0,0;QS=3,0;MQSB=0.929991;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,238:8:0 0,24,242:8:0 +X 638 . A <*> 0 . DP=31;I16=12,18,0,0,1118,42406,0,0,1769,105241,0,0,631,14611,0,0;QS=3,0;MQSB=0.929991;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,235:8:0 0,24,238:8:0 +X 639 . A <*> 0 . DP=30;I16=11,18,0,0,1037,38233,0,0,1709,101641,0,0,602,13934,0,0;QS=3,0;MQSB=0.921439;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,24,230:8:0 0,24,227:8:0 +X 640 . A <*> 0 . DP=31;I16=11,19,0,0,1154,45368,0,0,1769,105241,0,0,596,13804,0,0;QS=3,0;MQSB=0.91982;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,242:8:0 0,24,240:8:0 +X 641 . G <*> 0 . DP=31;I16=11,19,0,0,1018,36496,0,0,1769,105241,0,0,590,13650,0,0;QS=3,0;MQSB=0.91982;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,214:8:0 0,24,218:8:0 +X 642 . G <*> 0 . DP=30;I16=11,19,0,0,1057,38459,0,0,1769,105241,0,0,610,14148,0,0;QS=3,0;MQSB=0.91982;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,187:7:0 0,24,221:8:0 +X 643 . A <*> 0 . DP=29;I16=11,17,0,0,969,35477,0,0,1649,98041,0,0,585,13605,0,0;QS=3,0;MQSB=0.923174;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,199:7:0 0,24,237:8:0 +X 644 . C A,<*> 0 . DP=29;I16=9,18,1,0,898,30864,17,289,1620,97200,60,3600,549,12567,25,625;QS=2.95685,0.0431472,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=1;BQB=1;MQ0F=0 PL:DP:DV 0,22,236,36,239,243:13:1 0,21,195,21,195,195:7:0 0,24,204,24,204,204:8:0 +X 645 . C <*> 0 . DP=30;I16=10,19,0,0,1067,40337,0,0,1709,101641,0,0,584,13274,0,0;QS=3,0;MQSB=0.909373;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,21,198:7:0 0,24,226:8:0 +X 646 . A T,<*> 0 . DP=31;I16=9,20,1,0,1044,38174,14,196,1740,104400,60,3600,553,12499,25,625;QS=2.97113,0.028866,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=1;BQB=1;MQ0F=0 PL:DP:DV 0,27,255,39,255,255:14:1 0,21,197,21,197,197:7:0 0,27,229,27,229,229:9:0 +X 647 . A <*> 0 . DP=33;I16=10,21,0,0,1041,35883,0,0,1829,108841,0,0,573,12999,0,0;QS=3,0;MQSB=0.906252;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,21,189:7:0 0,30,213:10:0 +X 648 . A <*> 0 . DP=33;I16=11,22,0,0,1030,34122,0,0,1949,116041,0,0,594,13478,0,0;QS=3,0;MQSB=0.915545;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,188:7:0 0,30,194:10:0 +X 649 . C <*> 0 . DP=32;I16=10,21,0,0,1099,39879,0,0,1860,111600,0,0,566,12738,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,188:7:0 0,27,217:9:0 +X 650 . T <*> 0 . DP=31;I16=11,18,0,0,1006,37114,0,0,1709,101641,0,0,549,12407,0,0;QS=3,0;MQSB=0.921439;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,187:6:0 0,24,226:8:0 +X 651 . C <*> 0 . DP=32;I16=11,20,0,0,1117,41181,0,0,1829,108841,0,0,581,13107,0,0;QS=3,0;MQSB=0.918304;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,186:6:0 0,27,229:9:0 +X 652 . C <*> 0 . DP=32;I16=9,21,0,0,1126,43084,0,0,1769,105241,0,0,557,12423,0,0;QS=3,0;MQSB=0.893237;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,196:6:0 0,24,213:8:0 +X 653 . T <*> 0 . DP=33;I16=9,23,0,0,1141,42631,0,0,1889,112441,0,0,556,12382,0,0;QS=3,0;MQSB=0.890331;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,198:6:0 0,24,225:8:0 +X 654 . G <*> 0 . DP=33;I16=10,23,0,0,1171,43025,0,0,1949,116041,0,0,578,12798,0,0;QS=3,0;MQSB=0.903508;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,191:6:0 0,24,223:8:0 +X 655 . G <*> 0 . DP=32;I16=10,22,0,0,1118,40202,0,0,1889,112441,0,0,575,12573,0,0;QS=3,0;MQSB=0.904837;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,181:6:0 0,24,213:8:0 +X 656 . T <*> 0 . DP=32;I16=10,22,0,0,1090,38566,0,0,1889,112441,0,0,571,12333,0,0;QS=3,0;MQSB=0.904837;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,185:6:0 0,24,213:8:0 +X 657 . A <*> 0 . DP=32;I16=10,21,0,0,1100,40006,0,0,1829,108841,0,0,557,12029,0,0;QS=3,0;MQSB=0.906252;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,183:6:0 0,24,191:8:0 +X 658 . C <*> 0 . DP=32;I16=10,21,0,0,1115,41039,0,0,1829,108841,0,0,542,11520,0,0;QS=3,0;MQSB=0.906252;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,168:5:0 0,24,211:8:0 +X 659 . A <*> 0 . DP=32;I16=10,21,0,0,1141,42897,0,0,1829,108841,0,0,547,11685,0,0;QS=3,0;MQSB=0.906252;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,191:6:0 0,24,216:8:0 +X 660 . T <*> 0 . DP=33;I16=10,22,0,0,1139,41887,0,0,1889,112441,0,0,553,11659,0,0;QS=3,0;MQSB=0.904837;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,186:6:0 0,24,214:8:0 +X 661 . G <*> 0 . DP=32;I16=9,22,0,0,1107,41531,0,0,1829,108841,0,0,549,11549,0,0;QS=3,0;MQSB=0.891738;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,191:6:0 0,21,188:7:0 +X 662 . C <*> 0 . DP=32;I16=8,22,0,0,1087,40811,0,0,1800,108000,0,0,523,10991,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,192:6:0 0,21,187:7:0 +X 663 . A <*> 0 . DP=32;I16=9,22,0,0,1036,36816,0,0,1829,108841,0,0,540,11388,0,0;QS=3,0;MQSB=0.891738;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,192:6:0 0,21,186:7:0 +X 664 . A <*> 0 . DP=32;I16=9,23,0,0,1125,40759,0,0,1889,112441,0,0,552,11628,0,0;QS=3,0;MQSB=0.890331;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,188:6:0 0,21,184:7:0 +X 665 . C <*> 0 . DP=30;I16=9,21,0,0,1075,39697,0,0,1769,105241,0,0,550,11650,0,0;QS=3,0;MQSB=0.893237;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,186:6:0 0,21,184:7:0 +X 666 . T <*> 0 . DP=29;I16=9,20,0,0,1096,41946,0,0,1709,101641,0,0,547,11607,0,0;QS=3,0;MQSB=0.894839;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,171:5:0 0,21,194:7:0 +X 667 . G <*> 0 . DP=31;I16=11,19,0,0,1037,37627,0,0,1769,105241,0,0,524,11198,0,0;QS=3,0;MQSB=0.91982;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,189:6:0 0,21,188:7:0 +X 668 . A <*> 0 . DP=31;I16=11,20,0,0,1102,39980,0,0,1829,108841,0,0,543,11625,0,0;QS=3,0;MQSB=0.918304;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,190:6:0 0,21,187:7:0 +X 669 . C <*> 0 . DP=30;I16=10,19,0,0,1051,38869,0,0,1740,104400,0,0,528,11464,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,182:6:0 0,21,189:7:0 +X 670 . A <*> 0 . DP=30;I16=11,19,0,0,1121,43423,0,0,1769,105241,0,0,540,11642,0,0;QS=3,0;MQSB=0.91982;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,194:6:0 0,21,205:7:0 +X 671 . G <*> 0 . DP=30;I16=11,19,0,0,1101,41035,0,0,1769,105241,0,0,537,11637,0,0;QS=3,0;MQSB=0.91982;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,181:6:0 0,21,191:7:0 +X 672 . A <*> 0 . DP=30;I16=10,19,0,0,1031,37795,0,0,1740,104400,0,0,521,11479,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,185:6:0 0,21,185:7:0 +X 673 . T <*> 0 . DP=29;I16=8,19,0,0,954,34984,0,0,1589,94441,0,0,497,10885,0,0;QS=3,0;MQSB=0.880529;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,126:4:0 0,21,192:7:0 +X 674 . G <*> 0 . DP=29;I16=10,18,0,0,974,35736,0,0,1649,98041,0,0,497,10827,0,0;QS=3,0;MQSB=0.911099;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,146:5:0 0,21,185:7:0 +X 675 . A <*> 0 . DP=28;I16=9,19,0,0,996,36338,0,0,1649,98041,0,0,517,11389,0,0;QS=3,0;MQSB=0.896555;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,124:4:0 0,21,189:7:0 +X 676 . A <*> 0 . DP=29;I16=8,19,0,0,988,36578,0,0,1589,94441,0,0,462,10106,0,0;QS=3,0;MQSB=0.880529;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,128:4:0 0,21,186:7:0 +X 677 . T <*> 0 . DP=29;I16=9,20,0,0,1006,36126,0,0,1709,101641,0,0,507,11303,0,0;QS=3,0;MQSB=0.894839;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,12,120:4:0 0,21,192:7:0 +X 678 . C <*> 0 . DP=29;I16=9,20,0,0,1020,36984,0,0,1709,101641,0,0,502,11280,0,0;QS=3,0;MQSB=0.894839;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,12,117:4:0 0,21,191:7:0 +X 679 . T <*> 0 . DP=27;I16=6,19,0,0,902,33612,0,0,1469,87241,0,0,460,10414,0,0;QS=3,0;MQSB=0.833024;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,96:3:0 0,21,195:7:0 +X 680 . C <*> 0 . DP=26;I16=7,18,0,0,879,32295,0,0,1469,87241,0,0,468,10482,0,0;QS=3,0;MQSB=0.862128;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,98:3:0 0,21,181:7:0 +X 681 . A <*> 0 . DP=27;I16=7,17,0,0,844,30190,0,0,1409,83641,0,0,465,10425,0,0;QS=3,0;MQSB=0.864405;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,106:3:0 0,21,174:7:0 +X 682 . A <*> 0 . DP=27;I16=7,20,0,0,919,32179,0,0,1589,94441,0,0,500,11096,0,0;QS=3,0;MQSB=0.858077;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,145:5:0 0,21,176:7:0 +X 683 . A <*> 0 . DP=29;I16=8,21,0,0,949,32735,0,0,1709,101641,0,0,499,11103,0,0;QS=3,0;MQSB=0.876998;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,172:6:0 0,21,167:7:0 +X 684 . C <*> 0 . DP=29;I16=6,21,0,0,802,24468,0,0,1589,94441,0,0,473,10459,0,0;QS=3,0;MQSB=0.829029;MQ0F=0 PL:DP:DV 0,45,251:15:0 0,15,118:5:0 0,21,145:7:0 +X 685 . G <*> 0 . DP=28;I16=6,21,0,0,908,32092,0,0,1620,97200,0,0,498,11090,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,130:5:0 0,21,175:7:0 +X 686 . C <*> 0 . DP=28;I16=7,21,0,0,977,35493,0,0,1680,100800,0,0,500,11080,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,170:6:0 0,21,180:7:0 +X 687 . A <*> 0 . DP=28;I16=6,20,0,0,900,31952,0,0,1560,93600,0,0,475,10469,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,175:6:0 0,21,174:7:0 +X 688 . T <*> 0 . DP=27;I16=6,21,0,0,937,33971,0,0,1620,97200,0,0,501,11135,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,153:6:0 0,21,187:7:0 +X 689 . T A,<*> 0 . DP=27;I16=5,20,1,0,829,28967,13,169,1500,90000,60,3600,463,10359,25,625;QS=2.97105,0.0289532,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=1;BQB=1;MQ0F=0 PL:DP:DV 0,28,231,39,234,234:14:1 0,15,116,15,116,116:5:0 0,21,185,21,185,185:7:0 +X 690 . C <*> 0 . DP=27;I16=6,20,0,0,935,34553,0,0,1560,93600,0,0,486,10974,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,146:5:0 0,21,165:7:0 +X 691 . C <*> 0 . DP=26;I16=5,18,0,0,842,31906,0,0,1380,82800,0,0,446,10166,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,129:4:0 0,18,161:6:0 +X 692 . T <*> 0 . DP=26;I16=6,19,0,0,886,32434,0,0,1500,90000,0,0,486,11082,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,146:5:0 0,18,164:6:0 +X 693 . C <*> 0 . DP=27;I16=6,20,0,0,891,31839,0,0,1560,93600,0,0,483,11007,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,141:5:0 0,21,172:7:0 +X 694 . C <*> 0 . DP=27;I16=6,21,0,0,808,25004,0,0,1620,97200,0,0,498,11248,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,242:14:0 0,18,136:6:0 0,21,146:7:0 +X 695 . G <*> 0 . DP=25;I16=4,20,0,0,807,28037,0,0,1440,86400,0,0,476,10692,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,246:13:0 0,18,145:6:0 0,15,124:5:0 +X 696 . T <*> 0 . DP=25;I16=5,20,0,0,896,32870,0,0,1500,90000,0,0,499,11129,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,150:6:0 0,15,141:5:0 +X 697 . G <*> 0 . DP=26;I16=5,19,0,0,852,30594,0,0,1409,83641,0,0,450,9858,0,0;QS=3,0;MQSB=0.796124;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,142:5:0 0,15,120:5:0 +X 698 . T <*> 0 . DP=27;I16=6,20,0,0,917,33201,0,0,1529,90841,0,0,502,11114,0,0;QS=3,0;MQSB=0.83095;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,154:6:0 0,15,131:5:0 +X 699 . G <*> 0 . DP=28;I16=5,21,0,0,923,34103,0,0,1529,90841,0,0,498,10884,0,0;QS=3,0;MQSB=0.79189;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,163:6:0 0,15,132:5:0 +X 700 . A <*> 0 . DP=28;I16=6,22,0,0,989,35833,0,0,1618,95282,0,0,530,11626,0,0;QS=3,0;MQSB=0.904554;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,169:7:0 0,18,148:6:0 +X 701 . A <*> 0 . DP=29;I16=5,23,0,0,992,35956,0,0,1618,95282,0,0,517,11459,0,0;QS=3,0;MQSB=0.864394;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,186:7:0 0,18,144:6:0 +X 702 . A <*> 0 . DP=29;I16=5,23,0,0,1103,44105,0,0,1618,95282,0,0,520,11508,0,0;QS=3,0;MQSB=0.864394;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,204:7:0 0,18,159:6:0 +X 703 . G <*> 0 . DP=29;I16=5,23,0,0,1014,37508,0,0,1618,95282,0,0,522,11534,0,0;QS=3,0;MQSB=0.864394;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,172:7:0 0,18,144:6:0 +X 704 . A T,<*> 0 . DP=29;I16=4,23,1,0,954,34200,16,256,1558,91682,60,3600,499,10963,13,169;QS=2.97064,0.0293578,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.864394;BQB=1;MQ0F=0 PL:DP:DV 0,31,255,45,255,255:16:1 0,18,154,18,154,154:6:0 0,18,139,18,139,139:6:0 +X 705 . A <*> 0 . DP=29;I16=6,22,0,0,1042,39930,0,0,1618,95282,0,0,513,11189,0,0;QS=3,0;MQSB=0.904554;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,189:7:0 0,18,157:6:0 +X 706 . G <*> 0 . DP=30;I16=6,23,0,0,1029,37763,0,0,1678,98882,0,0,513,11225,0,0;QS=3,0;MQSB=0.900586;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,170:7:0 0,18,131:6:0 +X 707 . C <*> 0 . DP=30;I16=5,22,0,0,944,34494,0,0,1558,91682,0,0,464,10040,0,0;QS=3,0;MQSB=0.868709;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,131:5:0 0,18,134:6:0 +X 708 . C <*> 0 . DP=30;I16=6,24,0,0,898,27574,0,0,1738,102482,0,0,540,12010,0,0;QS=3,0;MQSB=0.896846;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,153:8:0 0,18,110:6:0 +X 709 . G <*> 0 . DP=29;I16=5,22,0,0,968,36130,0,0,1558,91682,0,0,507,11343,0,0;QS=3,0;MQSB=0.868709;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,178:8:0 0,15,132:5:0 +X 710 . G <*> 0 . DP=29;I16=5,23,0,0,961,34825,0,0,1618,95282,0,0,533,12029,0,0;QS=3,0;MQSB=0.864394;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,24,174:8:0 0,15,122:5:0 +X 711 . A <*> 0 . DP=29;I16=6,23,0,0,996,35700,0,0,1647,96123,0,0,565,12723,0,0;QS=3,0;MQSB=0.957107;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,171:7:0 0,18,142:6:0 +X 712 . C <*> 0 . DP=29;I16=6,23,0,0,1069,40863,0,0,1647,96123,0,0,565,12767,0,0;QS=3,0;MQSB=0.957107;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,156:7:0 0,18,146:6:0 +X 713 . T <*> 0 . DP=29;I16=6,23,0,0,1072,40426,0,0,1647,96123,0,0,565,12835,0,0;QS=3,0;MQSB=0.957107;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,187:7:0 0,18,149:6:0 +X 714 . C <*> 0 . DP=28;I16=6,21,0,0,988,37236,0,0,1558,91682,0,0,541,12301,0,0;QS=3,0;MQSB=0.90877;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,153:6:0 0,15,125:5:0 +X 715 . A <*> 0 . DP=28;I16=6,20,0,0,884,31414,0,0,1498,88082,0,0,522,12004,0,0;QS=3,0;MQSB=0.913254;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,138:6:0 0,15,120:5:0 +X 716 . C <*> 0 . DP=29;I16=4,23,0,0,998,37756,0,0,1527,88923,0,0,547,12501,0,0;QS=3,0;MQSB=0.877203;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,141:5:0 0,18,145:6:0 +X 717 . A <*> 0 . DP=31;I16=8,23,0,0,1136,42928,0,0,1767,103323,0,0,574,13254,0,0;QS=3,0;MQSB=0.987595;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,212:8:0 0,18,153:6:0 +X 718 . G <*> 0 . DP=29;I16=7,22,0,0,1066,40006,0,0,1647,96123,0,0,579,13407,0,0;QS=3,0;MQSB=0.979435;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,24,223:8:0 0,18,139:6:0 +X 719 . G <*> 0 . DP=29;I16=7,19,0,0,952,35868,0,0,1529,90841,0,0,510,11756,0,0;QS=3,0;MQSB=0.860025;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,204:8:0 0,12,120:4:0 +X 720 . G <*> 0 . DP=28;I16=6,20,0,0,986,37838,0,0,1467,85323,0,0,552,12940,0,0;QS=3,0;MQSB=0.970805;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,216:8:0 0,18,147:6:0 +X 721 . C <*> 0 . DP=28;I16=6,21,0,0,989,36901,0,0,1527,88923,0,0,567,13183,0,0;QS=3,0;MQSB=0.966147;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,24,197:8:0 0,18,147:6:0 +X 722 . A <*> 0 . DP=28;I16=6,21,0,0,949,33837,0,0,1527,88923,0,0,569,13225,0,0;QS=3,0;MQSB=0.966147;MQ0F=0 PL:DP:DV 0,39,244:13:0 0,24,205:8:0 0,18,143:6:0 +X 723 . A <*> 0 . DP=28;I16=6,19,0,0,925,34825,0,0,1438,84482,0,0,530,12366,0,0;QS=3,0;MQSB=0.918029;MQ0F=0 PL:DP:DV 0,36,253:12:0 0,24,206:8:0 0,15,135:5:0 +X 724 . C <*> 0 . DP=28;I16=5,22,0,0,967,35983,0,0,1527,88923,0,0,566,13028,0,0;QS=3,0;MQSB=0.932273;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,21,161:7:0 0,18,140:6:0 +X 725 . A <*> 0 . DP=28;I16=6,21,0,0,911,31971,0,0,1527,88923,0,0,565,12987,0,0;QS=3,0;MQSB=0.966147;MQ0F=0 PL:DP:DV 0,42,246:14:0 0,21,168:7:0 0,18,137:6:0 +X 726 . C <*> 0 . DP=28;I16=6,21,0,0,947,34531,0,0,1527,88923,0,0,563,12919,0,0;QS=3,0;MQSB=0.966147;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,21,166:7:0 0,18,136:6:0 +X 727 . A C,<*> 0 . DP=28;I16=6,20,0,1,904,32194,17,289,1498,88082,29,841,535,12199,25,625;QS=2.90811,0.0918919,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.966147;BQB=1;MQ0F=0 PL:DP:DV 0,42,247,42,247,247:14:0 0,21,191,21,191,191:7:0 0,1,109,15,112,119:6:1 +X 728 . C <*> 0 . DP=29;I16=6,22,0,0,1018,37990,0,0,1587,92523,0,0,557,12701,0,0;QS=3,0;MQSB=0.961573;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,208:8:0 0,18,142:6:0 +X 729 . T <*> 0 . DP=29;I16=7,22,0,0,1063,39315,0,0,1647,96123,0,0,581,13227,0,0;QS=3,0;MQSB=0.979435;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,244:9:0 0,18,142:6:0 +X 730 . A <*> 0 . DP=29;I16=7,21,0,0,993,35883,0,0,1618,95282,0,0,555,12529,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,219:9:0 0,15,135:5:0 +X 731 . T <*> 0 . DP=29;I16=7,22,0,0,1024,37312,0,0,1647,96123,0,0,578,13058,0,0;QS=3,0;MQSB=0.979435;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,210:9:0 0,18,148:6:0 +X 732 . C <*> 0 . DP=29;I16=7,21,0,0,1006,37058,0,0,1618,95282,0,0,550,12314,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,219:9:0 0,15,129:5:0 +X 733 . T <*> 0 . DP=29;I16=7,21,0,0,985,35497,0,0,1618,95282,0,0,547,12221,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,222:9:0 0,15,134:5:0 +X 734 . G <*> 0 . DP=29;I16=7,21,0,0,997,36453,0,0,1587,92523,0,0,544,12154,0,0;QS=3,0;MQSB=0.982906;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,204:8:0 0,18,139:6:0 +X 735 . A <*> 0 . DP=30;I16=7,21,0,0,963,33993,0,0,1618,95282,0,0,515,11437,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,190:8:0 0,18,148:6:0 +X 736 . C <*> 0 . DP=30;I16=8,20,0,0,1042,39326,0,0,1618,95282,0,0,512,11320,0,0;QS=3,0;MQSB=0.954515;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,218:8:0 0,18,152:6:0 +X 737 . T <*> 0 . DP=30;I16=8,22,0,0,1071,39825,0,0,1707,99723,0,0,560,12480,0,0;QS=3,0;MQSB=0.990151;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,243:9:0 0,21,149:7:0 +X 738 . G <*> 0 . DP=30;I16=8,21,0,0,1016,36816,0,0,1678,98882,0,0,533,11793,0,0;QS=3,0;MQSB=0.950946;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,210:9:0 0,18,141:6:0 +X 739 . T <*> 0 . DP=30;I16=7,22,0,0,1020,37326,0,0,1647,96123,0,0,534,11900,0,0;QS=3,0;MQSB=0.979435;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,202:8:0 0,21,155:7:0 +X 740 . T <*> 0 . DP=29;I16=7,21,0,0,1011,37465,0,0,1587,92523,0,0,532,11848,0,0;QS=3,0;MQSB=0.982906;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,24,232:8:0 0,21,155:7:0 +X 741 . T <*> 0 . DP=29;I16=7,21,0,0,984,36052,0,0,1587,92523,0,0,528,11722,0,0;QS=3,0;MQSB=0.982906;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,24,224:8:0 0,21,151:7:0 +X 742 . C <*> 0 . DP=30;I16=8,21,0,0,1046,39056,0,0,1678,98882,0,0,525,11671,0,0;QS=3,0;MQSB=0.950946;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,243:9:0 0,18,136:6:0 +X 743 . A <*> 0 . DP=30;I16=8,21,0,0,1026,37156,0,0,1678,98882,0,0,520,11500,0,0;QS=3,0;MQSB=0.950946;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,239:9:0 0,18,131:6:0 +X 744 . T <*> 0 . DP=30;I16=8,22,0,0,1100,41010,0,0,1707,99723,0,0,540,11984,0,0;QS=3,0;MQSB=0.990151;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,247:9:0 0,21,154:7:0 +X 745 . G <*> 0 . DP=31;I16=9,22,0,0,1078,38890,0,0,1767,103323,0,0,535,11873,0,0;QS=3,0;MQSB=0.996219;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,227:9:0 0,24,178:8:0 +X 746 . G <*> 0 . DP=31;I16=9,21,0,0,1001,35191,0,0,1707,99723,0,0,531,11793,0,0;QS=3,0;MQSB=0.997698;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,27,201:9:0 0,24,178:8:0 +X 747 . G <*> 0 . DP=30;I16=9,20,0,0,1017,36831,0,0,1647,96123,0,0,509,11343,0,0;QS=3,0;MQSB=0.99889;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,201:8:0 0,21,174:7:0 +X 748 . A <*> 0 . DP=30;I16=10,20,0,0,1046,37438,0,0,1707,99723,0,0,529,11721,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,27,242:9:0 0,18,159:6:0 +X 749 . A <*> 0 . DP=31;I16=10,21,0,0,1077,38303,0,0,1767,103323,0,0,530,11728,0,0;QS=3,0;MQSB=0.999777;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,27,240:9:0 0,18,164:6:0 +X 750 . A <*> 0 . DP=32;I16=10,20,0,0,1129,43093,0,0,1738,102482,0,0,500,11252,0,0;QS=3,0;MQSB=0.976097;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,232:8:0 0,15,161:5:0 +X 751 . G <*> 0 . DP=31;I16=11,20,0,0,1065,37955,0,0,1767,103323,0,0,535,11787,0,0;QS=3,0;MQSB=0.999148;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,27,206:9:0 0,18,150:6:0 +X 752 . T <*> 0 . DP=31;I16=11,20,0,0,1034,35786,0,0,1767,103323,0,0,537,11793,0,0;QS=3,0;MQSB=0.999148;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,27,223:9:0 0,18,143:6:0 +X 753 . C <*> 0 . DP=31;I16=12,19,0,0,1073,38779,0,0,1767,103323,0,0,540,11834,0,0;QS=3,0;MQSB=0.994873;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,30,227:10:0 0,18,158:6:0 +X 754 . T <*> 0 . DP=31;I16=12,19,0,0,1135,42527,0,0,1767,103323,0,0,542,11808,0,0;QS=3,0;MQSB=0.994873;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,30,255:10:0 0,18,172:6:0 +X 755 . G <*> 0 . DP=31;I16=12,19,0,0,1157,43695,0,0,1767,103323,0,0,544,11814,0,0;QS=3,0;MQSB=0.994873;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,30,255:10:0 0,18,162:6:0 +X 756 . G <*> 0 . DP=30;I16=12,17,0,0,1002,35566,0,0,1647,96123,0,0,539,11753,0,0;QS=3,0;MQSB=0.988062;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,30,242:10:0 0,18,157:6:0 +X 757 . A <*> 0 . DP=30;I16=12,17,0,0,1035,37723,0,0,1678,98882,0,0,523,11197,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,30,248:10:0 0,15,152:5:0 +X 758 . A <*> 0 . DP=30;I16=12,18,0,0,1015,35685,0,0,1707,99723,0,0,549,11825,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,30,247:10:0 0,18,156:6:0 +X 759 . A <*> 0 . DP=30;I16=12,16,0,0,998,36498,0,0,1618,95282,0,0,526,11472,0,0;QS=3,0;MQSB=0.995699;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,242:9:0 0,15,151:5:0 +X 760 . C <*> 0 . DP=31;I16=12,18,0,0,916,29466,0,0,1707,99723,0,0,547,11741,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,30,217:10:0 0,18,128:6:0 +X 761 . G <*> 0 . DP=30;I16=11,16,0,0,932,32884,0,0,1589,94441,0,0,512,11028,0,0;QS=3,0;MQSB=0.925036;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,27,220:9:0 0,15,153:5:0 +X 762 . G <*> 0 . DP=29;I16=11,18,0,0,1012,36984,0,0,1647,96123,0,0,541,11629,0,0;QS=3,0;MQSB=0.995968;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,27,220:9:0 0,21,173:7:0 +X 763 . C A,<*> 0 . DP=29;I16=11,16,0,1,948,35124,15,225,1558,91682,29,841,527,11473,2,4;QS=2.93697,0.0630252,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.993109;BQB=1;MQ0F=0 PL:DP:DV 0,39,255,39,255,255:13:0 0,24,193,24,193,193:8:0 0,6,158,18,161,165:7:1 +X 764 . A <*> 0 . DP=31;I16=12,18,0,0,1051,37737,0,0,1738,102482,0,0,516,11020,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,30,250:10:0 0,18,163:6:0 +X 765 . A <*> 0 . DP=32;I16=12,18,0,0,1071,39369,0,0,1738,102482,0,0,525,11379,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,30,254:10:0 0,18,169:6:0 +X 766 . C <*> 0 . DP=31;I16=13,18,0,0,1065,38285,0,0,1798,106082,0,0,547,11797,0,0;QS=3,0;MQSB=0.995005;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,33,235:11:0 0,18,164:6:0 +X 767 . A <*> 0 . DP=30;I16=12,18,0,0,996,34692,0,0,1738,102482,0,0,552,11926,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,33,244:11:0 0,18,148:6:0 +X 768 . C <*> 0 . DP=30;I16=12,18,0,0,1095,40739,0,0,1738,102482,0,0,556,12038,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,33,255:11:0 0,18,173:6:0 +X 769 . C <*> 0 . DP=30;I16=12,18,0,0,1110,42272,0,0,1738,102482,0,0,559,12133,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,33,255:11:0 0,18,173:6:0 +X 770 . A <*> 0 . DP=30;I16=12,18,0,0,1098,40852,0,0,1738,102482,0,0,562,12262,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,33,255:11:0 0,18,171:6:0 +X 771 . T <*> 0 . DP=30;I16=12,18,0,0,1111,41771,0,0,1738,102482,0,0,563,12325,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,33,255:11:0 0,18,177:6:0 +X 772 . T <*> 0 . DP=30;I16=12,18,0,0,1107,41429,0,0,1738,102482,0,0,563,12373,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,33,255:11:0 0,18,176:6:0 +X 773 . G <*> 0 . DP=30;I16=12,18,0,0,1123,42761,0,0,1738,102482,0,0,562,12406,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,33,255:11:0 0,18,175:6:0 +X 774 . A <*> 0 . DP=30;I16=12,18,0,0,1151,44801,0,0,1738,102482,0,0,560,12422,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,33,255:11:0 0,18,179:6:0 +X 775 . G <*> 0 . DP=30;I16=12,18,0,0,1136,43766,0,0,1738,102482,0,0,557,12419,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,33,255:11:0 0,18,177:6:0 +X 776 . A <*> 0 . DP=29;I16=12,17,0,0,1053,38865,0,0,1678,98882,0,0,553,12345,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,30,255:10:0 0,18,169:6:0 +X 777 . C <*> 0 . DP=28;I16=12,16,0,0,1019,37631,0,0,1618,95282,0,0,550,12298,0,0;QS=3,0;MQSB=0.995699;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,27,229:9:0 0,18,165:6:0 +X 778 . A <*> 0 . DP=28;I16=12,16,0,0,1079,42041,0,0,1618,95282,0,0,547,12277,0,0;QS=3,0;MQSB=0.995699;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,27,241:9:0 0,18,181:6:0 +X 779 . G <*> 0 . DP=28;I16=12,16,0,0,1025,38825,0,0,1618,95282,0,0,543,12231,0,0;QS=3,0;MQSB=0.995699;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,27,231:9:0 0,18,170:6:0 +X 780 . A <*> 0 . DP=28;I16=12,16,0,0,1005,36773,0,0,1618,95282,0,0,538,12160,0,0;QS=3,0;MQSB=0.995699;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,27,242:9:0 0,18,166:6:0 +X 781 . A <*> 0 . DP=28;I16=12,15,0,0,965,35857,0,0,1589,94441,0,0,519,11889,0,0;QS=3,0;MQSB=0.935229;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,222:8:0 0,15,159:5:0 +X 782 . A <*> 0 . DP=28;I16=12,16,0,0,1003,37315,0,0,1618,95282,0,0,530,12044,0,0;QS=3,0;MQSB=0.995699;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,229:8:0 0,18,171:6:0 +X 783 . A <*> 0 . DP=28;I16=12,16,0,0,989,36477,0,0,1618,95282,0,0,527,12001,0,0;QS=3,0;MQSB=0.995699;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,24,230:8:0 0,21,178:7:0 +X 784 . C <*> 0 . DP=26;I16=11,15,0,0,967,36387,0,0,1498,88082,0,0,527,11983,0,0;QS=3,0;MQSB=0.994627;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,207:7:0 0,21,178:7:0 +X 785 . A <*> 0 . DP=26;I16=11,15,0,0,989,38499,0,0,1498,88082,0,0,527,11989,0,0;QS=3,0;MQSB=0.994627;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,213:7:0 0,21,187:7:0 +X 786 . G <*> 0 . DP=26;I16=11,14,0,0,938,35698,0,0,1438,84482,0,0,501,11343,0,0;QS=3,0;MQSB=0.996634;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,211:7:0 0,21,180:7:0 +X 787 . G <*> 0 . DP=26;I16=11,15,0,0,914,33428,0,0,1498,88082,0,0,525,11969,0,0;QS=3,0;MQSB=0.994627;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,189:7:0 0,21,175:7:0 +X 788 . T <*> 0 . DP=26;I16=11,15,0,0,913,33357,0,0,1498,88082,0,0,524,11992,0,0;QS=3,0;MQSB=0.994627;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,180:7:0 0,21,188:7:0 +X 789 . G <*> 0 . DP=26;I16=11,15,0,0,963,36645,0,0,1498,88082,0,0,523,12037,0,0;QS=3,0;MQSB=0.994627;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,193:7:0 0,21,183:7:0 +X 790 . A <*> 0 . DP=26;I16=11,15,0,0,999,39113,0,0,1498,88082,0,0,520,12002,0,0;QS=3,0;MQSB=0.994627;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,198:7:0 0,21,201:7:0 +X 791 . G <*> 0 . DP=26;I16=11,15,0,0,934,34208,0,0,1498,88082,0,0,516,11934,0,0;QS=3,0;MQSB=0.994627;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,180:7:0 0,21,172:7:0 +X 792 . T <*> 0 . DP=26;I16=11,15,0,0,895,32009,0,0,1498,88082,0,0,511,11833,0,0;QS=3,0;MQSB=0.994627;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,184:7:0 0,21,172:7:0 +X 793 . G <*> 0 . DP=27;I16=11,15,0,0,965,36389,0,0,1498,88082,0,0,504,11652,0,0;QS=3,0;MQSB=0.994627;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,193:7:0 0,21,170:7:0 +X 794 . G <*> 0 . DP=26;I16=11,15,0,0,888,31804,0,0,1498,88082,0,0,508,11592,0,0;QS=3,0;MQSB=0.994627;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,198:8:0 0,18,161:6:0 +X 795 . T <*> 0 . DP=26;I16=9,15,0,0,859,31399,0,0,1409,83641,0,0,472,10908,0,0;QS=3,0;MQSB=0.96464;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,211:7:0 0,18,160:6:0 +X 796 . T <*> 0 . DP=27;I16=11,16,0,0,907,31641,0,0,1558,91682,0,0,499,11375,0,0;QS=3,0;MQSB=0.992419;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,27,221:9:0 0,15,150:5:0 +X 797 . G <*> 0 . DP=26;I16=11,15,0,0,882,31700,0,0,1529,90841,0,0,498,11298,0,0;QS=3,0;MQSB=0.927041;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,27,215:9:0 0,12,135:4:0 +X 798 . C <*> 0 . DP=26;I16=9,15,0,0,806,28552,0,0,1440,86400,0,0,466,10582,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,207:8:0 0,12,126:4:0 +X 799 . C <*> 0 . DP=26;I16=10,15,0,0,947,36407,0,0,1500,90000,0,0,491,11185,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,234:9:0 0,12,137:4:0 +X 800 . T <*> 0 . DP=26;I16=11,15,0,0,993,38475,0,0,1529,90841,0,0,495,11199,0,0;QS=3,0;MQSB=0.927041;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,27,255:9:0 0,12,139:4:0 +X 801 . G <*> 0 . DP=25;I16=11,14,0,0,938,35854,0,0,1469,87241,0,0,495,11209,0,0;QS=3,0;MQSB=0.929204;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,240:9:0 0,12,145:4:0 +X 802 . G <*> 0 . DP=25;I16=11,14,0,0,892,32802,0,0,1469,87241,0,0,495,11239,0,0;QS=3,0;MQSB=0.929204;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,229:9:0 0,12,137:4:0 +X 803 . G <*> 0 . DP=25;I16=11,14,0,0,906,33502,0,0,1469,87241,0,0,495,11289,0,0;QS=3,0;MQSB=0.929204;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,237:9:0 0,12,136:4:0 +X 804 . G <*> 0 . DP=25;I16=11,12,0,0,868,33326,0,0,1349,80041,0,0,466,10846,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,223:8:0 0,12,138:4:0 +X 805 . C <*> 0 . DP=24;I16=9,14,0,0,810,29684,0,0,1380,82800,0,0,482,11208,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,220:8:0 0,12,128:4:0 +X 806 . C <*> 0 . DP=25;I16=9,14,0,0,814,29856,0,0,1380,82800,0,0,483,11293,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,214:8:0 0,12,122:4:0 +X 807 . A <*> 0 . DP=25;I16=10,15,0,0,939,35997,0,0,1500,90000,0,0,503,11525,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,242:9:0 0,12,146:4:0 +X 808 . G <*> 0 . DP=25;I16=10,15,0,0,918,34720,0,0,1500,90000,0,0,505,11591,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,238:9:0 0,12,136:4:0 +X 809 . G <*> 0 . DP=25;I16=10,15,0,0,926,34932,0,0,1500,90000,0,0,506,11626,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,226:9:0 0,12,136:4:0 +X 810 . G C,<*> 0 . DP=25;I16=10,13,0,1,824,30436,14,196,1380,82800,60,3600,480,11288,14,196;QS=2.96552,0.0344828,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=1;BQB=1;MQ0F=0 PL:DP:DV 0,21,255,33,255,255:12:1 0,24,216,24,216,216:8:0 0,12,132,12,132,132:4:0 +X 811 . A <*> 0 . DP=25;I16=9,14,0,0,808,29404,0,0,1380,82800,0,0,484,11294,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,204:7:0 0,12,139:4:0 +X 812 . A <*> 0 . DP=25;I16=10,15,0,0,831,29515,0,0,1500,90000,0,0,500,11392,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,216:9:0 0,12,139:4:0 +X 813 . C <*> 0 . DP=25;I16=10,15,0,0,915,34093,0,0,1500,90000,0,0,497,11307,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,239:9:0 0,12,138:4:0 +X 814 . T <*> 0 . DP=25;I16=10,15,0,0,987,39343,0,0,1500,90000,0,0,494,11244,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,255:9:0 0,12,148:4:0 +X 815 . T <*> 0 . DP=25;I16=10,15,0,0,894,32670,0,0,1500,90000,0,0,491,11203,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,235:9:0 0,12,143:4:0 +X 816 . T <*> 0 . DP=25;I16=10,15,0,0,898,32990,0,0,1500,90000,0,0,488,11184,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,239:9:0 0,12,136:4:0 +X 817 . C <*> 0 . DP=24;I16=10,14,0,0,898,34256,0,0,1440,86400,0,0,485,11137,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,235:9:0 0,12,124:4:0 +X 818 . T <*> 0 . DP=23;I16=9,14,0,0,883,34371,0,0,1380,82800,0,0,484,11110,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,225:8:0 0,12,143:4:0 +X 819 . G <*> 0 . DP=23;I16=9,13,0,0,832,31932,0,0,1320,79200,0,0,461,10573,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,24,217:8:0 0,12,142:4:0 +X 820 . G <*> 0 . DP=24;I16=10,14,0,0,844,30848,0,0,1440,86400,0,0,484,11114,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,230:9:0 0,12,135:4:0 +X 821 . G <*> 0 . DP=24;I16=10,14,0,0,852,31572,0,0,1440,86400,0,0,484,11098,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,234:9:0 0,12,142:4:0 +X 822 . G <*> 0 . DP=25;I16=10,15,0,0,879,31785,0,0,1500,90000,0,0,481,10955,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,220:9:0 0,12,127:4:0 +X 823 . T <*> 0 . DP=25;I16=10,15,0,0,844,29686,0,0,1500,90000,0,0,478,10786,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,217:9:0 0,12,127:4:0 +X 824 . C <*> 0 . DP=25;I16=9,14,0,0,824,30252,0,0,1380,82800,0,0,427,9477,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,215:9:0 0,9,98:3:0 +X 825 . A <*> 0 . DP=25;I16=10,15,0,0,881,31665,0,0,1500,90000,0,0,467,10277,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,234:9:0 0,12,116:4:0 +X 826 . T <*> 0 . DP=25;I16=10,15,0,0,826,28364,0,0,1500,90000,0,0,461,10039,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,250:12:0 0,27,232:9:0 0,12,117:4:0 +X 827 . A <*> 0 . DP=25;I16=10,15,0,0,851,29477,0,0,1500,90000,0,0,455,9829,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,227:9:0 0,12,123:4:0 +X 828 . T C,<*> 0 . DP=25;I16=2,4,8,11,199,6917,656,23340,360,21600,1140,68400,116,2716,333,6931;QS=0.597777,2.40222,0;VDB=0.842082;SGB=-4.20907;RPB=0.950652;MQB=1;MQSB=1;BQB=0.929717;MQ0F=0 PL:DP:DV 211,0,35,217,65,255:12:10 116,0,91,128,106,213:9:5 120,12,0,120,12,120:4:4 +X 829 . T <*> 0 . DP=24;I16=10,13,0,0,863,32931,0,0,1380,82800,0,0,418,8818,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,242:8:0 0,12,132:4:0 +X 830 . C <*> 0 . DP=24;I16=10,14,0,0,910,34966,0,0,1440,86400,0,0,437,9267,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,220:8:0 0,12,134:4:0 +X 831 . T <*> 0 . DP=24;I16=10,14,0,0,906,34886,0,0,1440,86400,0,0,431,9119,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,243:8:0 0,12,133:4:0 +X 832 . C <*> 0 . DP=24;I16=10,14,0,0,888,33634,0,0,1440,86400,0,0,425,8999,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,220:8:0 0,12,123:4:0 +X 833 . T <*> 0 . DP=25;I16=10,14,0,0,820,29920,0,0,1440,86400,0,0,418,8856,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,224:8:0 0,12,113:4:0 +X 834 . G A,<*> 0 . DP=25;I16=2,3,7,10,164,5898,590,21124,300,18000,1020,61200,104,2296,305,6441;QS=0.520056,2.47994,0;VDB=0.788006;SGB=-4.01214;RPB=0.999233;MQB=1;MQSB=1;BQB=0.821668;MQ0F=0 PL:DP:DV 185,0,46,191,73,246:11:9 128,0,59,137,74,193:8:5 89,9,0,89,9,89:3:3 +X 835 . T <*> 0 . DP=26;I16=9,15,0,0,767,26675,0,0,1440,86400,0,0,406,8652,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,240:12:0 0,24,213:8:0 0,12,98:4:0 +X 836 . G <*> 0 . DP=23;I16=8,15,0,0,833,30561,0,0,1380,82800,0,0,403,8541,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,243:11:0 0,24,214:8:0 0,12,130:4:0 +X 837 . T <*> 0 . DP=23;I16=8,15,0,0,843,31499,0,0,1380,82800,0,0,400,8456,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,241:11:0 0,24,221:8:0 0,12,143:4:0 +X 838 . T <*> 0 . DP=23;I16=8,15,0,0,870,33172,0,0,1380,82800,0,0,397,8397,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,252:11:0 0,24,224:8:0 0,12,134:4:0 +X 839 . G <*> 0 . DP=24;I16=8,15,0,0,862,32774,0,0,1380,82800,0,0,393,8315,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,249:11:0 0,24,212:8:0 0,12,142:4:0 +X 840 . A <*> 0 . DP=25;I16=9,15,0,0,876,32682,0,0,1440,86400,0,0,375,7731,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,243:11:0 0,21,196:7:0 0,18,180:6:0 +X 841 . T <*> 0 . DP=25;I16=9,16,0,0,861,30879,0,0,1500,90000,0,0,396,8260,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,213:11:0 0,24,226:8:0 0,18,185:6:0 +X 842 . T <*> 0 . DP=24;I16=9,15,0,0,872,31990,0,0,1440,86400,0,0,393,8199,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,227:10:0 0,24,231:8:0 0,18,175:6:0 +X 843 . C <*> 0 . DP=24;I16=9,15,0,0,844,30604,0,0,1440,86400,0,0,390,8172,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,228:10:0 0,24,229:8:0 0,18,160:6:0 +X 844 . T <*> 0 . DP=24;I16=9,15,0,0,900,34094,0,0,1440,86400,0,0,386,8128,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,227:10:0 0,24,238:8:0 0,18,189:6:0 +X 845 . G <*> 0 . DP=25;I16=10,15,0,0,916,33866,0,0,1500,90000,0,0,382,8116,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,239:10:0 0,24,225:8:0 0,21,196:7:0 +X 846 . G <*> 0 . DP=24;I16=9,14,0,0,802,28414,0,0,1380,82800,0,0,354,7460,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,223:9:0 0,24,208:8:0 0,18,164:6:0 +X 847 . T <*> 0 . DP=24;I16=8,15,0,0,809,29007,0,0,1380,82800,0,0,377,8083,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,210:9:0 0,24,219:8:0 0,18,149:6:0 +X 848 . G <*> 0 . DP=23;I16=8,15,0,0,829,30351,0,0,1380,82800,0,0,384,8138,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,199:8:0 0,27,243:9:0 0,18,167:6:0 +X 849 . G <*> 0 . DP=22;I16=8,12,0,0,684,23844,0,0,1200,72000,0,0,349,7517,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,160:6:0 0,27,233:9:0 0,15,140:5:0 +X 850 . T <*> 0 . DP=21;I16=6,14,0,0,706,25508,0,0,1200,72000,0,0,360,7568,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,153:6:0 0,24,226:8:0 0,18,147:6:0 +X 851 . G <*> 0 . DP=21;I16=7,14,0,0,707,24667,0,0,1260,75600,0,0,386,8254,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,140:6:0 0,27,233:9:0 0,18,156:6:0 +X 852 . G <*> 0 . DP=21;I16=7,13,0,0,687,24223,0,0,1200,72000,0,0,368,7976,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,147:6:0 0,27,222:9:0 0,15,146:5:0 +X 853 . A <*> 0 . DP=21;I16=7,14,0,0,721,25603,0,0,1260,75600,0,0,388,8442,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,146:6:0 0,27,223:9:0 0,18,166:6:0 +X 854 . A <*> 0 . DP=21;I16=7,14,0,0,725,25843,0,0,1260,75600,0,0,389,8517,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,179:7:0 0,24,209:8:0 0,18,168:6:0 +X 855 . A <*> 0 . DP=21;I16=7,14,0,0,683,23803,0,0,1260,75600,0,0,391,8611,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,171:7:0 0,24,204:8:0 0,18,152:6:0 +X 856 . C <*> 0 . DP=21;I16=7,14,0,0,763,28293,0,0,1260,75600,0,0,392,8676,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,192:7:0 0,24,222:8:0 0,18,172:6:0 +X 857 . A <*> 0 . DP=22;I16=8,14,0,0,786,28480,0,0,1320,79200,0,0,393,8763,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,182:7:0 0,24,220:8:0 0,21,194:7:0 +X 858 . A <*> 0 . DP=22;I16=8,14,0,0,816,31358,0,0,1320,79200,0,0,395,8873,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,192:7:0 0,24,236:8:0 0,21,198:7:0 +X 859 . G <*> 0 . DP=22;I16=8,14,0,0,824,31356,0,0,1320,79200,0,0,395,8907,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,202:7:0 0,24,223:8:0 0,21,203:7:0 +X 860 . A <*> 0 . DP=22;I16=8,13,0,0,743,26985,0,0,1260,75600,0,0,369,8291,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,184:7:0 0,21,202:7:0 0,21,190:7:0 +X 861 . C <*> 0 . DP=22;I16=8,14,0,0,770,28376,0,0,1320,79200,0,0,393,8899,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,206:8:0 0,24,216:8:0 0,18,161:6:0 +X 862 . T <*> 0 . DP=22;I16=8,14,0,0,762,27500,0,0,1320,79200,0,0,393,8905,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,188:8:0 0,24,213:8:0 0,18,177:6:0 +X 863 . G <*> 0 . DP=23;I16=9,14,0,0,836,30660,0,0,1380,82800,0,0,393,8935,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,228:9:0 0,24,221:8:0 0,18,180:6:0 +X 864 . T <*> 0 . DP=22;I16=9,13,0,0,795,29085,0,0,1320,79200,0,0,395,8989,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,215:8:0 0,24,221:8:0 0,18,180:6:0 +X 865 . C <*> 0 . DP=22;I16=8,14,0,0,785,28475,0,0,1320,79200,0,0,397,9015,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,227:9:0 0,21,193:7:0 0,18,177:6:0 +X 866 . C <*> 0 . DP=21;I16=7,13,0,0,694,24890,0,0,1200,72000,0,0,395,8985,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,220:8:0 0,18,149:6:0 0,18,177:6:0 +X 867 . C <*> 0 . DP=21;I16=7,14,0,0,761,28443,0,0,1260,75600,0,0,403,9023,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,223:9:0 0,18,182:6:0 0,18,187:6:0 +X 868 . A <*> 0 . DP=21;I16=7,14,0,0,799,31183,0,0,1260,75600,0,0,406,9054,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,228:9:0 0,18,189:6:0 0,18,202:6:0 +X 869 . G <*> 0 . DP=21;I16=7,14,0,0,795,30733,0,0,1260,75600,0,0,409,9103,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,236:9:0 0,18,190:6:0 0,18,187:6:0 +X 870 . C <*> 0 . DP=21;I16=7,13,0,0,758,29080,0,0,1200,72000,0,0,403,9089,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,226:8:0 0,18,183:6:0 0,18,187:6:0 +X 871 . C <*> 0 . DP=21;I16=7,14,0,0,769,29383,0,0,1260,75600,0,0,413,9155,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,232:9:0 0,18,176:6:0 0,18,192:6:0 +X 872 . T <*> 0 . DP=21;I16=7,14,0,0,785,29879,0,0,1260,75600,0,0,413,9109,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,228:9:0 0,18,187:6:0 0,18,188:6:0 +X 873 . G <*> 0 . DP=21;I16=7,14,0,0,768,28506,0,0,1260,75600,0,0,413,9083,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,233:9:0 0,18,172:6:0 0,18,182:6:0 +X 874 . G <*> 0 . DP=21;I16=7,12,0,0,700,26434,0,0,1140,68400,0,0,374,8234,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,227:8:0 0,15,143:5:0 0,18,189:6:0 +X 875 . G <*> 0 . DP=21;I16=7,14,0,0,717,25659,0,0,1260,75600,0,0,411,8995,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,227:9:0 0,18,163:6:0 0,18,159:6:0 +X 876 . T <*> 0 . DP=21;I16=7,14,0,0,719,25261,0,0,1260,75600,0,0,410,8984,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,222:9:0 0,18,156:6:0 0,18,173:6:0 +X 877 . G <*> 0 . DP=21;I16=7,14,0,0,747,27419,0,0,1260,75600,0,0,409,8995,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,235:9:0 0,18,162:6:0 0,18,176:6:0 +X 878 . A <*> 0 . DP=21;I16=7,13,0,0,738,27650,0,0,1200,72000,0,0,391,8739,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,216:8:0 0,18,172:6:0 0,18,191:6:0 +X 879 . T <*> 0 . DP=21;I16=7,13,0,0,731,26927,0,0,1200,72000,0,0,389,8759,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,214:8:0 0,18,175:6:0 0,18,184:6:0 +X 880 . A <*> 0 . DP=21;I16=7,14,0,0,737,26481,0,0,1260,75600,0,0,405,9109,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,227:9:0 0,18,165:6:0 0,18,172:6:0 +X 881 . C <*> 0 . DP=20;I16=7,13,0,0,742,27898,0,0,1200,72000,0,0,404,9154,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,231:8:0 0,18,164:6:0 0,18,183:6:0 +X 882 . A <*> 0 . DP=20;I16=7,13,0,0,776,30564,0,0,1200,72000,0,0,403,9217,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,225:8:0 0,18,188:6:0 0,18,200:6:0 +X 883 . G <*> 0 . DP=20;I16=7,13,0,0,702,25898,0,0,1200,72000,0,0,401,9247,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,214:8:0 0,18,175:6:0 0,18,176:6:0 +X 884 . C <*> 0 . DP=19;I16=7,12,0,0,629,21449,0,0,1140,68400,0,0,400,9292,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,201:8:0 0,18,155:6:0 0,15,144:5:0 +X 885 . G <*> 0 . DP=18;I16=7,11,0,0,605,20851,0,0,1080,64800,0,0,400,9350,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,215:8:0 0,15,140:5:0 0,15,130:5:0 +X 886 . A <*> 0 . DP=18;I16=7,11,0,0,681,26145,0,0,1080,64800,0,0,400,9420,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,222:8:0 0,15,164:5:0 0,15,163:5:0 +X 887 . G <*> 0 . DP=18;I16=7,11,0,0,631,22891,0,0,1080,64800,0,0,399,9451,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,222:8:0 0,15,138:5:0 0,15,149:5:0 +X 888 . A <*> 0 . DP=18;I16=7,10,0,0,593,21563,0,0,1020,61200,0,0,373,8867,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,216:8:0 0,15,132:5:0 0,12,127:4:0 +X 889 . C <*> 0 . DP=18;I16=7,11,0,0,624,22732,0,0,1080,64800,0,0,396,9492,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,213:8:0 0,15,134:5:0 0,15,160:5:0 +X 890 . C <*> 0 . DP=19;I16=7,11,0,0,616,22426,0,0,1080,64800,0,0,368,8826,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,215:8:0 0,15,138:5:0 0,15,152:5:0 +X 891 . C <*> 0 . DP=19;I16=7,11,0,0,661,24891,0,0,1080,64800,0,0,365,8745,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,227:8:0 0,15,141:5:0 0,15,165:5:0 +X 892 . C <*> 0 . DP=19;I16=7,12,0,0,691,25761,0,0,1140,68400,0,0,387,9299,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,230:9:0 0,15,146:5:0 0,15,167:5:0 +X 893 . A <*> 0 . DP=19;I16=7,12,0,0,673,24521,0,0,1140,68400,0,0,384,9238,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,221:9:0 0,15,142:5:0 0,15,166:5:0 +X 894 . T <*> 0 . DP=19;I16=7,12,0,0,670,24268,0,0,1140,68400,0,0,380,9138,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,225:9:0 0,15,134:5:0 0,15,165:5:0 +X 895 . C <*> 0 . DP=20;I16=8,12,0,0,712,26186,0,0,1200,72000,0,0,376,9050,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,248:10:0 0,15,149:5:0 0,15,162:5:0 +X 896 . T <*> 0 . DP=19;I16=8,10,0,0,684,26696,0,0,1080,64800,0,0,348,8300,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,238:9:0 0,12,141:4:0 0,15,180:5:0 +X 897 . C <*> 0 . DP=18;I16=8,10,0,0,693,27001,0,0,1080,64800,0,0,370,8764,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,12,131:4:0 0,15,166:5:0 +X 898 . T <*> 0 . DP=18;I16=8,10,0,0,674,25656,0,0,1080,64800,0,0,367,8617,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,243:9:0 0,12,125:4:0 0,15,172:5:0 +X 899 . A <*> 0 . DP=18;I16=9,8,0,0,597,21451,0,0,1020,61200,0,0,340,7858,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,239:9:0 0,9,99:3:0 0,15,145:5:0 +X 900 . C <*> 0 . DP=18;I16=9,9,0,0,658,24550,0,0,1080,64800,0,0,364,8362,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,98:3:0 0,15,166:5:0 +X 901 . C <*> 0 . DP=18;I16=9,9,0,0,680,26004,0,0,1080,64800,0,0,363,8255,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,99:3:0 0,15,169:5:0 +X 902 . A <*> 0 . DP=18;I16=9,9,0,0,681,26253,0,0,1080,64800,0,0,362,8162,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,253:10:0 0,9,115:3:0 0,15,174:5:0 +X 903 . A <*> 0 . DP=18;I16=9,8,0,0,645,24625,0,0,1020,61200,0,0,336,7458,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,250:9:0 0,9,101:3:0 0,15,171:5:0 +X 904 . A <*> 0 . DP=18;I16=9,9,0,0,640,23412,0,0,1080,64800,0,0,359,7969,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,249:10:0 0,9,85:3:0 0,15,174:5:0 +X 905 . A <*> 0 . DP=18;I16=9,9,0,0,675,25673,0,0,1080,64800,0,0,357,7871,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,103:3:0 0,15,172:5:0 +X 906 . A <*> 0 . DP=18;I16=9,9,0,0,669,25193,0,0,1080,64800,0,0,355,7789,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,102:3:0 0,15,166:5:0 +X 907 . A <*> 0 . DP=18;I16=9,9,0,0,661,24541,0,0,1080,64800,0,0,353,7723,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,94:3:0 0,15,165:5:0 +X 908 . T <*> 0 . DP=18;I16=9,9,0,0,673,25579,0,0,1080,64800,0,0,351,7673,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,83:3:0 0,15,168:5:0 +X 909 . T <*> 0 . DP=18;I16=9,9,0,0,653,23847,0,0,1080,64800,0,0,348,7590,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,95:3:0 0,15,161:5:0 +X 910 . A <*> 0 . DP=18;I16=9,9,0,0,652,23790,0,0,1080,64800,0,0,344,7476,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,248:10:0 0,9,104:3:0 0,15,162:5:0 +X 911 . A <*> 0 . DP=18;I16=9,9,0,0,688,26440,0,0,1080,64800,0,0,340,7382,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,109:3:0 0,15,168:5:0 +X 912 . A <*> 0 . DP=18;I16=9,9,0,0,691,26705,0,0,1080,64800,0,0,336,7308,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,115:3:0 0,15,173:5:0 +X 913 . A <*> 0 . DP=19;I16=9,10,0,0,692,25762,0,0,1140,68400,0,0,332,7254,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,109:3:0 0,15,171:5:0 +X 914 . A <*> 0 . DP=19;I16=9,10,0,0,712,26966,0,0,1140,68400,0,0,329,7221,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,109:3:0 0,15,164:5:0 +X 915 . T <*> 0 . DP=18;I16=9,9,0,0,638,23228,0,0,1080,64800,0,0,326,7160,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,247:10:0 0,9,99:3:0 0,15,163:5:0 +X 916 . T <*> 0 . DP=19;I16=9,8,0,0,626,23136,0,0,1020,61200,0,0,296,6396,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,241:9:0 0,9,103:3:0 0,15,164:5:0 +X 917 . A <*> 0 . DP=19;I16=9,10,0,0,726,27962,0,0,1117,66169,0,0,318,6908,0,0;QS=3,0;MQSB=0.934728;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,125:4:0 0,15,171:5:0 +X 918 . G <*> 0 . DP=19;I16=9,10,0,0,688,25456,0,0,1117,66169,0,0,314,6818,0,0;QS=3,0;MQSB=0.934728;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,129:4:0 0,15,147:5:0 +X 919 . C <*> 0 . DP=18;I16=8,10,0,0,672,25786,0,0,1057,62569,0,0,311,6751,0,0;QS=3,0;MQSB=0.938795;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,92:3:0 0,15,152:5:0 +X 920 . T <*> 0 . DP=18;I16=8,10,0,0,681,26113,0,0,1057,62569,0,0,308,6706,0,0;QS=3,0;MQSB=0.938795;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,95:3:0 0,15,171:5:0 +X 921 . G <*> 0 . DP=17;I16=7,10,0,0,617,22841,0,0,997,58969,0,0,304,6582,0,0;QS=3,0;MQSB=0.943335;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,6,47:2:0 0,15,164:5:0 +X 922 . G <*> 0 . DP=16;I16=7,8,0,0,560,21156,0,0,877,51769,0,0,276,5852,0,0;QS=3,0;MQSB=0.921243;MQ0F=0 PL:DP:DV 0,24,243:8:0 0,6,64:2:0 0,15,151:5:0 +X 923 . G <*> 0 . DP=16;I16=7,8,0,0,562,21350,0,0,877,51769,0,0,273,5765,0,0;QS=3,0;MQSB=0.921243;MQ0F=0 PL:DP:DV 0,24,245:8:0 0,6,65:2:0 0,15,144:5:0 +X 924 . C <*> 0 . DP=16;I16=7,9,0,0,603,22955,0,0,937,55369,0,0,295,6321,0,0;QS=3,0;MQSB=0.933674;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,6,57:2:0 0,15,157:5:0 +X 925 . A <*> 0 . DP=16;I16=7,9,0,0,576,21618,0,0,937,55369,0,0,291,6219,0,0;QS=3,0;MQSB=0.933674;MQ0F=0 PL:DP:DV 0,27,244:9:0 0,6,58:2:0 0,15,163:5:0 +X 926 . T <*> 0 . DP=16;I16=7,9,0,0,585,22015,0,0,937,55369,0,0,287,6133,0,0;QS=3,0;MQSB=0.933674;MQ0F=0 PL:DP:DV 0,27,241:9:0 0,6,63:2:0 0,15,161:5:0 +X 927 . G <*> 0 . DP=17;I16=7,10,0,0,641,24481,0,0,997,58969,0,0,283,6063,0,0;QS=3,0;MQSB=0.943335;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,9,82:3:0 0,15,158:5:0 +X 928 . G <*> 0 . DP=17;I16=7,10,0,0,625,23195,0,0,997,58969,0,0,280,6010,0,0;QS=3,0;MQSB=0.943335;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,9,84:3:0 0,15,150:5:0 +X 929 . T <*> 0 . DP=16;I16=7,9,0,0,580,21580,0,0,937,55369,0,0,277,5925,0,0;QS=3,0;MQSB=0.933674;MQ0F=0 PL:DP:DV 0,27,248:9:0 0,9,79:3:0 0,12,128:4:0 +X 930 . G <*> 0 . DP=16;I16=7,8,0,0,565,21561,0,0,877,51769,0,0,249,5233,0,0;QS=3,0;MQSB=0.921243;MQ0F=0 PL:DP:DV 0,24,247:8:0 0,9,82:3:0 0,12,127:4:0 +X 931 . G <*> 0 . DP=16;I16=7,9,0,0,553,19935,0,0,937,55369,0,0,271,5809,0,0;QS=3,0;MQSB=0.933674;MQ0F=0 PL:DP:DV 0,27,244:9:0 0,9,80:3:0 0,12,113:4:0 +X 932 . T <*> 0 . DP=16;I16=7,9,0,0,558,20128,0,0,937,55369,0,0,268,5778,0,0;QS=3,0;MQSB=0.933674;MQ0F=0 PL:DP:DV 0,27,229:9:0 0,9,89:3:0 0,12,122:4:0 +X 933 . G <*> 0 . DP=16;I16=7,8,0,0,558,20926,0,0,877,51769,0,0,239,5091,0,0;QS=3,0;MQSB=0.921243;MQ0F=0 PL:DP:DV 0,24,241:8:0 0,9,94:3:0 0,12,116:4:0 +X 934 . C <*> 0 . DP=15;I16=7,8,0,0,548,20256,0,0,877,51769,0,0,261,5673,0,0;QS=3,0;MQSB=0.921243;MQ0F=0 PL:DP:DV 0,27,244:9:0 0,9,83:3:0 0,9,99:3:0 +X 935 . A <*> 0 . DP=15;I16=7,8,0,0,534,19780,0,0,846,49010,0,0,259,5647,0,0;QS=3,0;MQSB=0.720273;MQ0F=0 PL:DP:DV 0,27,233:9:0 0,9,86:3:0 0,9,101:3:0 +X 936 . T <*> 0 . DP=15;I16=7,8,0,0,579,22499,0,0,846,49010,0,0,257,5589,0,0;QS=3,0;MQSB=0.720273;MQ0F=0 PL:DP:DV 0,27,252:9:0 0,9,91:3:0 0,9,100:3:0 +X 937 . G <*> 0 . DP=16;I16=8,7,0,0,550,20650,0,0,846,49010,0,0,232,5022,0,0;QS=3,0;MQSB=0.651439;MQ0F=0 PL:DP:DV 0,24,228:8:0 0,9,84:3:0 0,12,115:4:0 +X 938 . C <*> 0 . DP=16;I16=8,7,0,0,553,20669,0,0,846,49010,0,0,231,5001,0,0;QS=3,0;MQSB=0.651439;MQ0F=0 PL:DP:DV 0,24,234:8:0 0,9,77:3:0 0,12,119:4:0 +X 939 . C <*> 0 . DP=16;I16=8,8,0,0,582,22100,0,0,906,52610,0,0,250,5392,0,0;QS=3,0;MQSB=0.702619;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,9,71:3:0 0,12,115:4:0 +X 940 . T <*> 0 . DP=15;I16=8,7,0,0,583,23339,0,0,846,49010,0,0,248,5320,0,0;QS=3,0;MQSB=0.651439;MQ0F=0 PL:DP:DV 0,27,252:9:0 0,6,71:2:0 0,12,124:4:0 +X 941 . G <*> 0 . DP=14;I16=7,7,0,0,501,18707,0,0,786,45410,0,0,246,5216,0,0;QS=3,0;MQSB=0.714506;MQ0F=0 PL:DP:DV 0,27,240:9:0 0,6,59:2:0 0,9,93:3:0 +X 942 . T <*> 0 . DP=14;I16=7,7,0,0,525,19799,0,0,786,45410,0,0,244,5128,0,0;QS=3,0;MQSB=0.714506;MQ0F=0 PL:DP:DV 0,27,237:9:0 0,6,70:2:0 0,9,94:3:0 +X 943 . A <*> 0 . DP=14;I16=7,7,0,0,545,21399,0,0,786,45410,0,0,242,5056,0,0;QS=3,0;MQSB=0.714506;MQ0F=0 PL:DP:DV 0,27,248:9:0 0,6,71:2:0 0,9,93:3:0 +X 944 . G <*> 0 . DP=14;I16=7,7,0,0,529,20143,0,0,786,45410,0,0,240,5000,0,0;QS=3,0;MQSB=0.714506;MQ0F=0 PL:DP:DV 0,27,249:9:0 0,6,65:2:0 0,9,95:3:0 +X 945 . T <*> 0 . DP=14;I16=7,7,0,0,523,19621,0,0,786,45410,0,0,238,4960,0,0;QS=3,0;MQSB=0.714506;MQ0F=0 PL:DP:DV 0,27,239:9:0 0,6,70:2:0 0,9,95:3:0 +X 946 . C <*> 0 . DP=13;I16=6,6,0,0,455,17581,0,0,666,38210,0,0,223,4739,0,0;QS=3,0;MQSB=0.660716;MQ0F=0 PL:DP:DV 0,24,240:8:0 0,6,56:2:0 0,6,70:2:0 +X 947 . C <*> 0 . DP=14;I16=7,7,0,0,509,19007,0,0,755,42651,0,0,238,4928,0,0;QS=3,0;MQSB=0.925999;MQ0F=0 PL:DP:DV 0,27,251:9:0 0,9,83:3:0 0,6,66:2:0 +X 948 . C <*> 0 . DP=14;I16=7,7,0,0,520,20050,0,0,755,42651,0,0,237,4887,0,0;QS=3,0;MQSB=0.925999;MQ0F=0 PL:DP:DV 0,27,254:9:0 0,9,78:3:0 0,6,69:2:0 +X 949 . A <*> 0 . DP=15;I16=7,8,0,0,547,20705,0,0,815,46251,0,0,236,4864,0,0;QS=3,0;MQSB=0.959011;MQ0F=0 PL:DP:DV 0,30,250:10:0 0,9,90:3:0 0,6,72:2:0 +X 950 . G <*> 0 . DP=15;I16=6,8,0,0,563,22871,0,0,786,45410,0,0,231,4835,0,0;QS=3,0;MQSB=0.740818;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,6,71:2:0 0,6,72:2:0 +X 951 . C <*> 0 . DP=16;I16=7,8,0,0,554,21080,0,0,846,49010,0,0,230,4840,0,0;QS=3,0;MQSB=0.720273;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,65:2:0 0,6,73:2:0 +X 952 . T <*> 0 . DP=16;I16=8,8,0,0,595,22565,0,0,875,49851,0,0,237,4913,0,0;QS=3,0;MQSB=0.934676;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,93:3:0 0,6,73:2:0 +X 953 . A <*> 0 . DP=16;I16=8,8,0,0,567,20515,0,0,875,49851,0,0,237,4921,0,0;QS=3,0;MQSB=0.934676;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,91:3:0 0,6,69:2:0 +X 954 . T <*> 0 . DP=15;I16=7,8,0,0,544,20412,0,0,815,46251,0,0,238,4948,0,0;QS=3,0;MQSB=0.959011;MQ0F=0 PL:DP:DV 0,30,249:10:0 0,9,94:3:0 0,6,69:2:0 +X 955 . T <*> 0 . DP=15;I16=7,8,0,0,543,19953,0,0,815,46251,0,0,239,4993,0,0;QS=3,0;MQSB=0.959011;MQ0F=0 PL:DP:DV 0,30,246:10:0 0,9,95:3:0 0,6,68:2:0 +X 956 . C <*> 0 . DP=15;I16=6,8,0,0,543,21255,0,0,786,45410,0,0,229,4935,0,0;QS=3,0;MQSB=0.740818;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,6,62:2:0 0,6,70:2:0 +X 957 . A <*> 0 . DP=15;I16=7,8,0,0,504,17684,0,0,815,46251,0,0,241,5137,0,0;QS=3,0;MQSB=0.959011;MQ0F=0 PL:DP:DV 0,30,240:10:0 0,9,74:3:0 0,6,67:2:0 +X 958 . C <*> 0 . DP=14;I16=6,8,0,0,505,18981,0,0,755,42651,0,0,243,5235,0,0;QS=3,0;MQSB=0.981425;MQ0F=0 PL:DP:DV 0,30,253:10:0 0,9,78:3:0 0,3,39:1:0 +X 959 . A <*> 0 . DP=14;I16=5,8,0,0,519,20885,0,0,726,41810,0,0,231,5153,0,0;QS=3,0;MQSB=0.765017;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,6,72:2:0 0,3,38:1:0 +X 960 . G <*> 0 . DP=15;I16=6,9,0,0,539,19901,0,0,815,46251,0,0,247,5479,0,0;QS=3,0;MQSB=0.99308;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,106:4:0 0,3,41:1:0 +X 961 . T <*> 0 . DP=14;I16=6,8,0,0,523,19835,0,0,755,42651,0,0,250,5574,0,0;QS=3,0;MQSB=0.981425;MQ0F=0 PL:DP:DV 0,27,248:9:0 0,12,114:4:0 0,3,39:1:0 +X 962 . G <*> 0 . DP=14;I16=5,8,0,0,498,19194,0,0,726,41810,0,0,236,5394,0,0;QS=3,0;MQSB=0.765017;MQ0F=0 PL:DP:DV 0,27,253:9:0 0,9,91:3:0 0,3,36:1:0 +X 963 . C <*> 0 . DP=13;I16=5,8,0,0,500,19610,0,0,695,39051,0,0,256,5754,0,0;QS=3,0;MQSB=0.997325;MQ0F=0 PL:DP:DV 0,24,234:8:0 0,12,118:4:0 0,3,40:1:0 +X 964 . T <*> 0 . DP=13;I16=5,8,0,0,512,20430,0,0,695,39051,0,0,259,5835,0,0;QS=3,0;MQSB=0.997325;MQ0F=0 PL:DP:DV 0,24,227:8:0 0,12,128:4:0 0,3,42:1:0 +X 965 . G <*> 0 . DP=13;I16=4,8,0,0,467,18429,0,0,666,38210,0,0,241,5477,0,0;QS=3,0;MQSB=0.793923;MQ0F=0 PL:DP:DV 0,24,228:8:0 0,9,93:3:0 0,3,40:1:0 +X 966 . A <*> 0 . DP=13;I16=4,8,0,0,443,16785,0,0,666,38210,0,0,242,5490,0,0;QS=3,0;MQSB=0.793923;MQ0F=0 PL:DP:DV 0,24,212:8:0 0,9,95:3:0 0,3,40:1:0 +X 967 . G <*> 0 . DP=13;I16=4,8,0,0,464,18036,0,0,666,38210,0,0,243,5513,0,0;QS=3,0;MQSB=0.793923;MQ0F=0 PL:DP:DV 0,24,230:8:0 0,9,91:3:0 0,3,41:1:0 +X 968 . G <*> 0 . DP=13;I16=4,8,0,0,441,16549,0,0,666,38210,0,0,244,5546,0,0;QS=3,0;MQSB=0.793923;MQ0F=0 PL:DP:DV 0,24,218:8:0 0,9,87:3:0 0,3,42:1:0 +X 969 . T <*> 0 . DP=13;I16=4,8,0,0,450,16970,0,0,666,38210,0,0,245,5589,0,0;QS=3,0;MQSB=0.793923;MQ0F=0 PL:DP:DV 0,24,220:8:0 0,9,98:3:0 0,3,31:1:0 +X 970 . G <*> 0 . DP=13;I16=4,7,0,0,413,15579,0,0,629,36841,0,0,220,4968,0,0;QS=3,0;MQSB=0.924449;MQ0F=0 PL:DP:DV 0,24,221:8:0 0,6,71:2:0 0,3,33:1:0 +X 971 . G <*> 0 . DP=13;I16=4,8,0,0,459,17711,0,0,666,38210,0,0,245,5609,0,0;QS=3,0;MQSB=0.793923;MQ0F=0 PL:DP:DV 0,24,223:8:0 0,9,93:3:0 0,3,38:1:0 +X 972 . G <*> 0 . DP=13;I16=4,8,0,0,446,17192,0,0,666,38210,0,0,245,5637,0,0;QS=3,0;MQSB=0.793923;MQ0F=0 PL:DP:DV 0,24,210:8:0 0,9,96:3:0 0,3,39:1:0 +X 973 . A <*> 0 . DP=12;I16=4,7,0,0,402,15018,0,0,606,34610,0,0,246,5676,0,0;QS=3,0;MQSB=0.763675;MQ0F=0 PL:DP:DV 0,21,192:7:0 0,9,89:3:0 0,3,42:1:0 +X 974 . A <*> 0 . DP=12;I16=4,7,0,0,417,16273,0,0,606,34610,0,0,247,5725,0,0;QS=3,0;MQSB=0.763675;MQ0F=0 PL:DP:DV 0,21,198:7:0 0,9,96:3:0 0,3,42:1:0 +X 975 . G <*> 0 . DP=13;I16=4,8,0,0,454,17560,0,0,666,38210,0,0,247,5733,0,0;QS=3,0;MQSB=0.793923;MQ0F=0 PL:DP:DV 0,24,213:8:0 0,9,95:3:0 0,3,42:1:0 +X 976 . A <*> 0 . DP=13;I16=4,8,0,0,431,16083,0,0,666,38210,0,0,248,5750,0,0;QS=3,0;MQSB=0.793923;MQ0F=0 PL:DP:DV 0,24,227:8:0 0,9,70:3:0 0,3,41:1:0 +X 977 . T <*> 0 . DP=13;I16=4,8,0,0,438,16316,0,0,666,38210,0,0,248,5726,0,0;QS=3,0;MQSB=0.793923;MQ0F=0 PL:DP:DV 0,24,210:8:0 0,9,93:3:0 0,3,37:1:0 +X 978 . G <*> 0 . DP=12;I16=4,8,0,0,430,16060,0,0,666,38210,0,0,248,5710,0,0;QS=3,0;MQSB=0.793923;MQ0F=0 PL:DP:DV 0,24,224:8:0 0,9,75:3:0 0,3,40:1:0 +X 979 . C <*> 0 . DP=13;I16=4,8,0,0,453,17461,0,0,689,40441,0,0,223,5077,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,27,232:9:0 0,6,72:2:0 0,3,41:1:0 +X 980 . T <*> 0 . DP=13;I16=4,8,0,0,438,16412,0,0,689,40441,0,0,224,5078,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,27,220:9:0 0,6,76:2:0 0,3,43:1:0 +X 981 . T <*> 0 . DP=13;I16=4,9,0,0,484,18602,0,0,726,41810,0,0,250,5714,0,0;QS=3,0;MQSB=0.826565;MQ0F=0 PL:DP:DV 0,27,224:9:0 0,9,97:3:0 0,3,41:1:0 +X 982 . G <*> 0 . DP=14;I16=4,10,0,0,520,20128,0,0,786,45410,0,0,250,5686,0,0;QS=3,0;MQSB=0.852144;MQ0F=0 PL:DP:DV 0,30,237:10:0 0,9,99:3:0 0,3,40:1:0 +X 983 . A <*> 0 . DP=14;I16=4,10,0,0,570,23360,0,0,786,45410,0,0,251,5671,0,0;QS=3,0;MQSB=0.852144;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,101:3:0 0,3,42:1:0 +X 984 . G <*> 0 . DP=15;I16=4,10,0,0,529,20459,0,0,786,45410,0,0,252,5670,0,0;QS=3,0;MQSB=0.852144;MQ0F=0 PL:DP:DV 0,30,253:10:0 0,9,88:3:0 0,3,43:1:0 +X 985 . C <*> 0 . DP=17;I16=4,13,0,0,580,20280,0,0,966,56210,0,0,261,5747,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,33,246:11:0 0,12,100:4:0 0,6,65:2:0 +X 986 . C A,<*> 0 . DP=17;I16=3,12,0,1,519,18353,13,169,846,49010,60,3600,235,5101,4,16;QS=2.95873,0.0412698,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.921781;BQB=1;MQ0F=0 PL:DP:DV 0,16,197,27,200,201:10:1 0,12,108,12,108,108:4:0 0,6,69,6,69,69:2:0 +X 987 . C <*> 0 . DP=17;I16=4,13,0,0,634,23914,0,0,966,56210,0,0,267,5755,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,107:4:0 0,6,69:2:0 +X 988 . A <*> 0 . DP=17;I16=4,13,0,0,633,24341,0,0,966,56210,0,0,269,5737,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,111:4:0 0,6,82:2:0 +X 989 . G <*> 0 . DP=17;I16=4,13,0,0,635,24149,0,0,966,56210,0,0,271,5739,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,114:4:0 0,6,80:2:0 +X 990 . G <*> 0 . DP=16;I16=4,12,0,0,591,22177,0,0,906,52610,0,0,274,5760,0,0;QS=3,0;MQSB=0.88901;MQ0F=0 PL:DP:DV 0,30,246:10:0 0,12,105:4:0 0,6,83:2:0 +X 991 . A <*> 0 . DP=16;I16=3,11,0,0,548,21542,0,0,809,47641,0,0,227,4549,0,0;QS=3,0;MQSB=0.973096;MQ0F=0 PL:DP:DV 0,27,232:9:0 0,9,100:3:0 0,6,80:2:0 +X 992 . G <*> 0 . DP=16;I16=4,12,0,0,562,20436,0,0,906,52610,0,0,278,5760,0,0;QS=3,0;MQSB=0.88901;MQ0F=0 PL:DP:DV 0,30,240:10:0 0,12,102:4:0 0,6,76:2:0 +X 993 . T <*> 0 . DP=16;I16=4,12,0,0,564,20752,0,0,906,52610,0,0,280,5790,0,0;QS=3,0;MQSB=0.88901;MQ0F=0 PL:DP:DV 0,30,222:10:0 0,12,121:4:0 0,6,73:2:0 +X 994 . T <*> 0 . DP=17;I16=5,11,0,0,597,22625,0,0,906,52610,0,0,270,5696,0,0;QS=3,0;MQSB=0.851779;MQ0F=0 PL:DP:DV 0,27,227:9:0 0,12,123:4:0 0,9,103:3:0 +X 995 . C <*> 0 . DP=16;I16=4,11,0,0,588,23228,0,0,846,49010,0,0,273,5741,0,0;QS=3,0;MQSB=0.872525;MQ0F=0 PL:DP:DV 0,24,216:8:0 0,12,119:4:0 0,9,110:3:0 +X 996 . A <*> 0 . DP=16;I16=4,12,0,0,562,20416,0,0,906,52610,0,0,290,6000,0,0;QS=3,0;MQSB=0.88901;MQ0F=0 PL:DP:DV 0,27,207:9:0 0,12,107:4:0 0,9,113:3:0 +X 997 . A <*> 0 . DP=16;I16=4,12,0,0,600,23520,0,0,906,52610,0,0,294,6110,0,0;QS=3,0;MQSB=0.88901;MQ0F=0 PL:DP:DV 0,27,209:9:0 0,12,123:4:0 0,9,121:3:0 +X 998 . G <*> 0 . DP=17;I16=4,13,0,0,603,22299,0,0,966,56210,0,0,298,6240,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,30,226:10:0 0,12,99:4:0 0,9,115:3:0 +X 999 . G <*> 0 . DP=17;I16=4,12,0,0,575,21519,0,0,906,52610,0,0,302,6390,0,0;QS=3,0;MQSB=0.88901;MQ0F=0 PL:DP:DV 0,27,202:9:0 0,12,118:4:0 0,9,111:3:0 +X 1000 . C <*> 0 . DP=17;I16=4,13,0,0,637,24465,0,0,966,56210,0,0,308,6564,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,30,235:10:0 0,12,118:4:0 0,9,109:3:0 +X 1001 . T <*> 0 . DP=17;I16=4,13,0,0,647,24907,0,0,966,56210,0,0,312,6708,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,30,228:10:0 0,12,120:4:0 0,9,122:3:0 +X 1002 . G <*> 0 . DP=17;I16=4,13,0,0,627,23691,0,0,966,56210,0,0,316,6872,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,30,220:10:0 0,12,123:4:0 0,9,109:3:0 +X 1003 . C T,<*> 0 . DP=18;I16=4,13,0,1,633,23953,22,484,966,56210,60,3600,297,6515,21,441;QS=2.9375,0.0625,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.913725;BQB=1;MQ0F=0 PL:DP:DV 0,8,207,27,211,220:10:1 0,15,132,15,132,132:5:0 0,9,102,9,102,102:3:0 +X 1004 . A <*> 0 . DP=19;I16=5,14,0,0,653,23107,0,0,1086,63410,0,0,321,7061,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,33,231:11:0 0,15,131:5:0 0,9,98:3:0 +X 1005 . A <*> 0 . DP=19;I16=5,14,0,0,670,24380,0,0,1086,63410,0,0,324,7138,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,33,231:11:0 0,15,132:5:0 0,9,113:3:0 +X 1006 . T <*> 0 . DP=19;I16=4,14,0,0,659,24869,0,0,1026,59810,0,0,327,7237,0,0;QS=3,0;MQSB=0.913725;MQ0F=0 PL:DP:DV 0,30,220:10:0 0,15,134:5:0 0,9,115:3:0 +X 1007 . G <*> 0 . DP=18;I16=4,13,0,0,651,25373,0,0,966,56210,0,0,306,6732,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,27,225:9:0 0,15,138:5:0 0,9,113:3:0 +X 1008 . A <*> 0 . DP=18;I16=4,13,0,0,667,27041,0,0,966,56210,0,0,309,6821,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,27,222:9:0 0,15,147:5:0 0,9,118:3:0 +X 1009 . G <*> 0 . DP=18;I16=4,13,0,0,635,24431,0,0,966,56210,0,0,312,6928,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,27,213:9:0 0,15,139:5:0 0,9,116:3:0 +X 1010 . C <*> 0 . DP=18;I16=4,14,0,0,661,25289,0,0,1026,59810,0,0,339,7629,0,0;QS=3,0;MQSB=0.913725;MQ0F=0 PL:DP:DV 0,30,234:10:0 0,15,126:5:0 0,9,114:3:0 +X 1011 . T <*> 0 . DP=18;I16=4,14,0,0,671,25325,0,0,1026,59810,0,0,339,7623,0,0;QS=3,0;MQSB=0.913725;MQ0F=0 PL:DP:DV 0,30,226:10:0 0,15,131:5:0 0,9,118:3:0 +X 1012 . A <*> 0 . DP=19;I16=5,14,0,0,639,22891,0,0,1063,61179,0,0,339,7633,0,0;QS=3,0;MQSB=0.990403;MQ0F=0 PL:DP:DV 0,30,201:10:0 0,18,154:6:0 0,9,113:3:0 +X 1013 . T <*> 0 . DP=18;I16=5,12,0,0,623,23913,0,0,943,53979,0,0,325,7385,0,0;QS=3,0;MQSB=0.998612;MQ0F=0 PL:DP:DV 0,24,202:8:0 0,18,161:6:0 0,9,115:3:0 +X 1014 . G <*> 0 . DP=18;I16=5,13,0,0,656,24596,0,0,1003,57579,0,0,341,7605,0,0;QS=3,0;MQSB=0.995153;MQ0F=0 PL:DP:DV 0,27,218:9:0 0,18,159:6:0 0,9,113:3:0 +X 1015 . A <*> 0 . DP=18;I16=5,13,0,0,646,23878,0,0,1003,57579,0,0,342,7618,0,0;QS=3,0;MQSB=0.995153;MQ0F=0 PL:DP:DV 0,27,209:9:0 0,18,164:6:0 0,9,109:3:0 +X 1016 . T <*> 0 . DP=17;I16=4,12,0,0,588,22114,0,0,929,54841,0,0,340,7632,0,0;QS=3,0;MQSB=0.971017;MQ0F=0 PL:DP:DV 0,27,212:9:0 0,12,124:4:0 0,9,101:3:0 +X 1017 . T <*> 0 . DP=18;I16=5,13,0,0,635,23433,0,0,1026,59810,0,0,346,7694,0,0;QS=3,0;MQSB=0.942222;MQ0F=0 PL:DP:DV 0,27,213:9:0 0,18,155:6:0 0,9,105:3:0 +X 1018 . G <*> 0 . DP=18;I16=5,13,0,0,650,24550,0,0,1026,59810,0,0,349,7757,0,0;QS=3,0;MQSB=0.942222;MQ0F=0 PL:DP:DV 0,27,215:9:0 0,18,179:6:0 0,9,91:3:0 +X 1019 . C <*> 0 . DP=18;I16=5,12,0,0,555,18561,0,0,966,56210,0,0,327,7213,0,0;QS=3,0;MQSB=0.951229;MQ0F=0 PL:DP:DV 0,24,181:8:0 0,18,143:6:0 0,9,104:3:0 +X 1020 . G <*> 0 . DP=19;I16=6,12,0,0,625,22287,0,0,1026,59810,0,0,332,7402,0,0;QS=3,0;MQSB=0.97296;MQ0F=0 PL:DP:DV 0,27,228:9:0 0,18,157:6:0 0,9,87:3:0 +X 1021 . C <*> 0 . DP=19;I16=5,13,0,0,625,22761,0,0,1026,59810,0,0,332,7326,0,0;QS=3,0;MQSB=0.942222;MQ0F=0 PL:DP:DV 0,27,220:9:0 0,18,153:6:0 0,9,92:3:0 +X 1022 . C <*> 0 . DP=19;I16=6,13,0,0,727,27975,0,0,1086,63410,0,0,360,8034,0,0;QS=3,0;MQSB=0.965977;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,168:6:0 0,9,110:3:0 +X 1023 . A <*> 0 . DP=19;I16=6,12,0,0,647,23997,0,0,1026,59810,0,0,338,7510,0,0;QS=3,0;MQSB=0.97296;MQ0F=0 PL:DP:DV 0,27,216:9:0 0,18,168:6:0 0,9,112:3:0 +X 1024 . C <*> 0 . DP=20;I16=7,13,0,0,729,27471,0,0,1146,67010,0,0,364,8154,0,0;QS=3,0;MQSB=0.980568;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,169:6:0 0,9,106:3:0 +X 1025 . T <*> 0 . DP=20;I16=7,13,0,0,757,29387,0,0,1146,67010,0,0,366,8192,0,0;QS=3,0;MQSB=0.980568;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,181:6:0 0,9,117:3:0 +X 1026 . G <*> 0 . DP=20;I16=7,13,0,0,747,28435,0,0,1146,67010,0,0,367,8201,0,0;QS=3,0;MQSB=0.980568;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,169:6:0 0,9,113:3:0 +X 1027 . C <*> 0 . DP=20;I16=7,13,0,0,720,26688,0,0,1146,67010,0,0,368,8232,0,0;QS=3,0;MQSB=0.980568;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,145:6:0 0,9,110:3:0 +X 1028 . A <*> 0 . DP=19;I16=6,12,0,0,645,23681,0,0,1026,59810,0,0,348,7800,0,0;QS=3,0;MQSB=0.97296;MQ0F=0 PL:DP:DV 0,30,238:10:0 0,15,146:5:0 0,9,99:3:0 +X 1029 . C <*> 0 . DP=19;I16=7,12,0,0,699,26817,0,0,1086,63410,0,0,371,8305,0,0;QS=3,0;MQSB=0.985816;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,138:5:0 0,9,111:3:0 +X 1030 . T <*> 0 . DP=19;I16=7,12,0,0,749,29789,0,0,1086,63410,0,0,371,8293,0,0;QS=3,0;MQSB=0.985816;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,158:5:0 0,9,122:3:0 +X 1031 . T <*> 0 . DP=21;I16=9,12,0,0,748,27726,0,0,1206,70610,0,0,371,8297,0,0;QS=3,0;MQSB=0.997478;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,144:5:0 0,9,113:3:0 +X 1032 . T <*> 0 . DP=21;I16=9,12,0,0,761,28033,0,0,1206,70610,0,0,373,8319,0,0;QS=3,0;MQSB=0.997478;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,156:5:0 0,9,111:3:0 +X 1033 . G <*> 0 . DP=22;I16=10,12,0,0,773,28227,0,0,1266,74210,0,0,375,8361,0,0;QS=3,0;MQSB=0.999457;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,169:6:0 0,9,101:3:0 +X 1034 . G <*> 0 . DP=22;I16=8,12,0,0,703,25617,0,0,1169,69241,0,0,340,7684,0,0;QS=3,0;MQSB=0.953497;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,149:5:0 0,9,102:3:0 +X 1035 . C <*> 0 . DP=21;I16=10,11,0,0,719,26103,0,0,1237,73369,0,0,382,8508,0,0;QS=3,0;MQSB=0.927743;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,163:6:0 0,9,94:3:0 +X 1036 . C <*> 0 . DP=22;I16=11,10,0,0,756,28390,0,0,1237,73369,0,0,360,7938,0,0;QS=3,0;MQSB=0.939898;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,175:6:0 0,12,135:4:0 +X 1037 . T <*> 0 . DP=22;I16=11,11,0,0,839,32737,0,0,1297,76969,0,0,389,8641,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,188:6:0 0,12,138:4:0 +X 1038 . G <*> 0 . DP=21;I16=10,10,0,0,752,28750,0,0,1177,69769,0,0,368,8066,0,0;QS=3,0;MQSB=0.931063;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,184:6:0 0,9,107:3:0 +X 1039 . G <*> 0 . DP=21;I16=10,11,0,0,775,29373,0,0,1237,73369,0,0,397,8761,0,0;QS=3,0;MQSB=0.927743;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,189:6:0 0,9,111:3:0 +X 1040 . A <*> 0 . DP=21;I16=10,11,0,0,759,28007,0,0,1237,73369,0,0,401,8851,0,0;QS=3,0;MQSB=0.927743;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,177:6:0 0,9,107:3:0 +X 1041 . C <*> 0 . DP=21;I16=8,11,0,0,713,27117,0,0,1140,68400,0,0,371,8255,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,155:5:0 0,9,110:3:0 +X 1042 . A <*> 0 . DP=23;I16=12,10,0,0,800,29464,0,0,1297,76969,0,0,384,8466,0,0;QS=3,0;MQSB=0.947103;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,185:6:0 0,15,145:5:0 +X 1043 . A <*> 0 . DP=23;I16=12,11,0,0,850,32160,0,0,1357,80569,0,0,414,9192,0,0;QS=3,0;MQSB=0.944319;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,188:6:0 0,15,159:5:0 +X 1044 . C <*> 0 . DP=23;I16=12,10,0,0,812,30758,0,0,1297,76969,0,0,394,8690,0,0;QS=3,0;MQSB=0.947103;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,181:6:0 0,15,150:5:0 +X 1045 . A <*> 0 . DP=23;I16=12,11,0,0,887,34519,0,0,1357,80569,0,0,424,9460,0,0;QS=3,0;MQSB=0.944319;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,197:6:0 0,15,156:5:0 +X 1046 . G <*> 0 . DP=23;I16=12,11,0,0,862,33240,0,0,1357,80569,0,0,428,9576,0,0;QS=3,0;MQSB=0.944319;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,183:6:0 0,15,158:5:0 +X 1047 . A <*> 0 . DP=23;I16=12,11,0,0,890,34804,0,0,1357,80569,0,0,432,9712,0,0;QS=3,0;MQSB=0.944319;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,198:6:0 0,15,165:5:0 +X 1048 . G <*> 0 . DP=23;I16=12,10,0,0,846,33054,0,0,1297,76969,0,0,411,9243,0,0;QS=3,0;MQSB=0.947103;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,195:6:0 0,15,156:5:0 +X 1049 . C <*> 0 . DP=22;I16=12,10,0,0,808,30644,0,0,1297,76969,0,0,441,10043,0,0;QS=3,0;MQSB=0.947103;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,182:6:0 0,15,160:5:0 +X 1050 . A <*> 0 . DP=22;I16=11,10,0,0,808,31334,0,0,1237,73369,0,0,430,9940,0,0;QS=3,0;MQSB=0.939898;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,193:6:0 0,12,138:4:0 +X 1051 . A <*> 0 . DP=21;I16=11,9,0,0,731,27495,0,0,1177,69769,0,0,423,9621,0,0;QS=3,0;MQSB=0.943233;MQ0F=0 PL:DP:DV 0,27,238:9:0 0,18,187:6:0 0,15,150:5:0 +X 1052 . A <*> 0 . DP=21;I16=11,9,0,0,759,29327,0,0,1177,69769,0,0,427,9747,0,0;QS=3,0;MQSB=0.943233;MQ0F=0 PL:DP:DV 0,27,247:9:0 0,18,190:6:0 0,15,150:5:0 +X 1053 . A <*> 0 . DP=21;I16=11,8,0,0,674,25210,0,0,1117,66169,0,0,406,9264,0,0;QS=3,0;MQSB=0.946915;MQ0F=0 PL:DP:DV 0,24,224:8:0 0,18,161:6:0 0,15,149:5:0 +X 1054 . C <*> 0 . DP=21;I16=11,10,0,0,791,30157,0,0,1237,73369,0,0,459,10623,0,0;QS=3,0;MQSB=0.939898;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,189:6:0 0,15,153:5:0 +X 1055 . C <*> 0 . DP=22;I16=12,10,0,0,818,31448,0,0,1297,76969,0,0,462,10750,0,0;QS=3,0;MQSB=0.947103;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,191:6:0 0,15,157:5:0 +X 1056 . C <*> 0 . DP=22;I16=12,9,0,0,793,31265,0,0,1237,73369,0,0,441,10271,0,0;QS=3,0;MQSB=0.950149;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,195:6:0 0,15,161:5:0 +X 1057 . T <*> 0 . DP=23;I16=12,10,0,0,821,31667,0,0,1297,76969,0,0,467,10911,0,0;QS=3,0;MQSB=0.947103;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,196:6:0 0,15,159:5:0 +X 1058 . G <*> 0 . DP=23;I16=12,11,0,0,863,32871,0,0,1357,80569,0,0,493,11569,0,0;QS=3,0;MQSB=0.944319;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,197:7:0 0,15,155:5:0 +X 1059 . T <*> 0 . DP=23;I16=12,10,0,0,797,29803,0,0,1297,76969,0,0,468,10944,0,0;QS=3,0;MQSB=0.947103;MQ0F=0 PL:DP:DV 0,30,249:10:0 0,21,202:7:0 0,15,152:5:0 +X 1060 . C <*> 0 . DP=23;I16=12,11,0,0,829,31041,0,0,1357,80569,0,0,492,11536,0,0;QS=3,0;MQSB=0.944319;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,178:7:0 0,15,163:5:0 +X 1061 . T <*> 0 . DP=22;I16=12,9,0,0,810,31840,0,0,1237,73369,0,0,465,10797,0,0;QS=3,0;MQSB=0.950149;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,175:5:0 0,15,158:5:0 +X 1062 . C A,<*> 0 . DP=22;I16=12,9,0,1,826,32780,33,1089,1237,73369,60,3600,462,10652,25,625;QS=2.85398,0.146018,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.947103;BQB=1;MQ0F=0 PL:DP:DV 0,33,255,33,255,255:11:0 15,0,151,30,154,176:6:1 0,15,164,15,164,164:5:0 +X 1063 . T <*> 0 . DP=22;I16=12,9,0,0,820,32460,0,0,1237,73369,0,0,459,10525,0,0;QS=3,0;MQSB=0.950149;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,183:6:0 0,15,166:5:0 +X 1064 . A <*> 0 . DP=23;I16=12,9,0,0,793,30355,0,0,1237,73369,0,0,464,10752,0,0;QS=3,0;MQSB=0.950149;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,180:6:0 0,15,162:5:0 +X 1065 . A <*> 0 . DP=23;I16=12,9,0,0,814,31978,0,0,1237,73369,0,0,462,10694,0,0;QS=3,0;MQSB=0.950149;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,186:6:0 0,15,174:5:0 +X 1066 . A <*> 0 . DP=27;I16=15,9,0,0,890,34378,0,0,1417,84169,0,0,460,10652,0,0;QS=3,0;MQSB=0.96464;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,198:7:0 0,18,181:6:0 +X 1067 . A <*> 0 . DP=27;I16=15,10,0,0,913,35031,0,0,1477,87769,0,0,470,10600,0,0;QS=3,0;MQSB=0.962269;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,208:7:0 0,18,182:6:0 +X 1068 . A <*> 0 . DP=27;I16=15,9,0,0,898,34580,0,0,1417,84169,0,0,456,10342,0,0;QS=3,0;MQSB=0.96464;MQ0F=0 PL:DP:DV 0,30,253:10:0 0,24,218:8:0 0,18,181:6:0 +X 1069 . A <*> 0 . DP=28;I16=16,10,0,0,914,33888,0,0,1537,91369,0,0,481,10925,0,0;QS=3,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,207:8:0 0,21,177:7:0 +X 1070 . A <*> 0 . DP=28;I16=15,11,0,0,955,36445,0,0,1537,91369,0,0,467,10351,0,0;QS=3,0;MQSB=0.960078;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,223:8:0 0,21,188:7:0 +X 1071 . G <*> 0 . DP=28;I16=16,10,0,0,974,37570,0,0,1537,91369,0,0,466,10284,0,0;QS=3,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,192:7:0 0,21,191:7:0 +X 1072 . A <*> 0 . DP=28;I16=16,11,0,0,1007,38205,0,0,1597,94969,0,0,490,10868,0,0;QS=3,0;MQSB=0.96384;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,239:8:0 0,21,195:7:0 +X 1073 . A <*> 0 . DP=28;I16=16,10,0,0,976,37822,0,0,1537,91369,0,0,463,10177,0,0;QS=3,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,33,254:11:0 0,24,236:8:0 0,21,199:7:0 +X 1074 . A <*> 0 . DP=28;I16=16,11,0,0,1003,38097,0,0,1597,94969,0,0,484,10664,0,0;QS=3,0;MQSB=0.96384;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,232:8:0 0,21,203:7:0 +X 1075 . A <*> 0 . DP=28;I16=16,10,0,0,964,36762,0,0,1537,91369,0,0,476,10564,0,0;QS=3,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,222:8:0 0,21,200:7:0 +X 1076 . G <*> 0 . DP=28;I16=16,10,0,0,966,37048,0,0,1537,91369,0,0,476,10536,0,0;QS=3,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,209:8:0 0,21,183:7:0 +X 1077 . A <*> 0 . DP=29;I16=17,11,0,0,1038,39240,0,0,1657,98569,0,0,480,10548,0,0;QS=3,0;MQSB=0.967085;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,231:8:0 0,24,209:8:0 +X 1078 . A <*> 0 . DP=29;I16=17,11,0,0,1053,40425,0,0,1657,98569,0,0,480,10562,0,0;QS=3,0;MQSB=0.967085;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,234:8:0 0,24,214:8:0 +X 1079 . A <*> 0 . DP=28;I16=17,10,0,0,1019,39007,0,0,1597,94969,0,0,479,10505,0,0;QS=3,0;MQSB=0.968979;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,223:8:0 0,24,206:8:0 +X 1080 . A <*> 0 . DP=29;I16=18,10,0,0,1049,40827,0,0,1657,98569,0,0,478,10478,0,0;QS=3,0;MQSB=0.971673;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,246:9:0 0,24,218:8:0 +X 1081 . G <*> 0 . DP=30;I16=19,8,0,0,988,37392,0,0,1597,94969,0,0,436,9550,0,0;QS=3,0;MQSB=0.977696;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,24,210:8:0 0,27,210:9:0 +X 1082 . A <*> 0 . DP=30;I16=20,7,0,0,989,37109,0,0,1597,94969,0,0,438,9564,0,0;QS=3,0;MQSB=0.981425;MQ0F=0 PL:DP:DV 0,27,224:9:0 0,27,226:9:0 0,27,217:9:0 +X 1083 . A <*> 0 . DP=30;I16=20,8,0,0,1039,39827,0,0,1657,98569,0,0,455,9803,0,0;QS=3,0;MQSB=0.979523;MQ0F=0 PL:DP:DV 0,30,246:10:0 0,27,233:9:0 0,27,217:9:0 +X 1084 . A <*> 0 . DP=31;I16=21,8,0,0,1049,39097,0,0,1717,102169,0,0,457,9849,0,0;QS=3,0;MQSB=0.981133;MQ0F=0 PL:DP:DV 0,33,253:11:0 0,27,226:9:0 0,27,215:9:0 +X 1085 . A <*> 0 . DP=30;I16=21,8,0,0,1052,39534,0,0,1717,102169,0,0,486,10552,0,0;QS=3,0;MQSB=0.981133;MQ0F=0 PL:DP:DV 0,30,232:10:0 0,30,247:10:0 0,27,214:9:0 +X 1086 . A <*> 0 . DP=28;I16=21,6,0,0,969,36223,0,0,1597,94969,0,0,492,10660,0,0;QS=3,0;MQSB=0.98481;MQ0F=0 PL:DP:DV 0,30,219:10:0 0,27,236:9:0 0,24,179:8:0 +X 1087 . C <*> 0 . DP=28;I16=22,6,0,0,984,36046,0,0,1657,98569,0,0,498,10796,0,0;QS=3,0;MQSB=0.985992;MQ0F=0 PL:DP:DV 0,30,234:10:0 0,27,229:9:0 0,27,173:9:0 +X 1088 . T <*> 0 . DP=29;I16=23,6,0,0,1133,45203,0,0,1717,102169,0,0,503,10863,0,0;QS=3,0;MQSB=0.987041;MQ0F=0 PL:DP:DV 0,30,252:10:0 0,30,250:10:0 0,27,198:9:0 +X 1089 . C <*> 0 . DP=29;I16=23,6,0,0,1093,42347,0,0,1717,102169,0,0,509,10965,0,0;QS=3,0;MQSB=0.987041;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,30,237:10:0 0,27,188:9:0 +X 1090 . A <*> 0 . DP=29;I16=23,6,0,0,1061,39845,0,0,1717,102169,0,0,515,11103,0,0;QS=3,0;MQSB=0.987041;MQ0F=0 PL:DP:DV 0,30,221:10:0 0,30,250:10:0 0,27,183:9:0 +X 1091 . C <*> 0 . DP=29;I16=23,6,0,0,1063,39713,0,0,1717,102169,0,0,521,11277,0,0;QS=3,0;MQSB=0.987041;MQ0F=0 PL:DP:DV 0,30,247:10:0 0,30,244:10:0 0,27,177:9:0 +X 1092 . T <*> 0 . DP=29;I16=23,6,0,0,1121,44489,0,0,1717,102169,0,0,524,11334,0,0;QS=3,0;MQSB=0.987041;MQ0F=0 PL:DP:DV 0,30,244:10:0 0,30,251:10:0 0,27,198:9:0 +X 1093 . G <*> 0 . DP=29;I16=23,6,0,0,1085,41377,0,0,1717,102169,0,0,526,11372,0,0;QS=3,0;MQSB=0.987041;MQ0F=0 PL:DP:DV 0,30,249:10:0 0,30,243:10:0 0,27,184:9:0 +X 1094 . G <*> 0 . DP=29;I16=22,6,0,0,1018,38808,0,0,1657,98569,0,0,521,11393,0,0;QS=3,0;MQSB=0.985992;MQ0F=0 PL:DP:DV 0,30,243:10:0 0,30,232:10:0 0,24,185:8:0 +X 1095 . A <*> 0 . DP=28;I16=22,6,0,0,1023,38551,0,0,1657,98569,0,0,529,11443,0,0;QS=3,0;MQSB=0.985992;MQ0F=0 PL:DP:DV 0,30,236:10:0 0,30,244:10:0 0,24,178:8:0 +X 1096 . T <*> 0 . DP=30;I16=24,5,0,0,1020,37168,0,0,1717,102169,0,0,505,10849,0,0;QS=3,0;MQSB=0.989637;MQ0F=0 PL:DP:DV 0,33,234:11:0 0,27,220:9:0 0,27,178:9:0 +X 1097 . A <*> 0 . DP=30;I16=24,6,0,0,1056,38166,0,0,1777,105769,0,0,533,11537,0,0;QS=3,0;MQSB=0.987976;MQ0F=0 PL:DP:DV 0,33,230:11:0 0,30,237:10:0 0,27,177:9:0 +X 1098 . T <*> 0 . DP=29;I16=24,5,0,0,1081,40557,0,0,1717,102169,0,0,537,11633,0,0;QS=3,0;MQSB=0.989637;MQ0F=0 PL:DP:DV 0,30,210:10:0 0,30,251:10:0 0,27,186:9:0 +X 1099 . G <*> 0 . DP=29;I16=24,5,0,0,1091,41719,0,0,1717,102169,0,0,540,11712,0,0;QS=3,0;MQSB=0.989637;MQ0F=0 PL:DP:DV 0,30,229:10:0 0,30,242:10:0 0,27,182:9:0 +X 1100 . A <*> 0 . DP=29;I16=24,5,0,0,1106,42976,0,0,1717,102169,0,0,543,11825,0,0;QS=3,0;MQSB=0.989637;MQ0F=0 PL:DP:DV 0,30,210:10:0 0,30,255:10:0 0,27,191:9:0 +X 1101 . A <*> 0 . DP=29;I16=24,5,0,0,1154,46420,0,0,1717,102169,0,0,545,11921,0,0;QS=3,0;MQSB=0.989637;MQ0F=0 PL:DP:DV 0,30,222:10:0 0,30,255:10:0 0,27,198:9:0 +X 1102 . T <*> 0 . DP=29;I16=24,4,0,0,1046,39520,0,0,1657,98569,0,0,522,11424,0,0;QS=3,0;MQSB=0.991416;MQ0F=0 PL:DP:DV 0,30,210:10:0 0,27,233:9:0 0,27,186:9:0 +X 1103 . G <*> 0 . DP=30;I16=24,6,0,0,1134,43486,0,0,1777,105769,0,0,548,12158,0,0;QS=3,0;MQSB=0.987976;MQ0F=0 PL:DP:DV 0,30,223:10:0 0,30,255:10:0 0,30,222:10:0 +X 1104 . A <*> 0 . DP=28;I16=23,5,0,0,1089,43067,0,0,1657,98569,0,0,552,12296,0,0;QS=3,0;MQSB=0.988819;MQ0F=0 PL:DP:DV 0,27,213:9:0 0,27,233:9:0 0,30,233:10:0 +X 1105 . T <*> 0 . DP=28;I16=23,5,0,0,1035,38743,0,0,1657,98569,0,0,556,12462,0,0;QS=3,0;MQSB=0.988819;MQ0F=0 PL:DP:DV 0,27,203:9:0 0,27,227:9:0 0,30,222:10:0 +X 1106 . A <*> 0 . DP=29;I16=23,5,0,0,1003,36715,0,0,1657,98569,0,0,532,11882,0,0;QS=3,0;MQSB=0.988819;MQ0F=0 PL:DP:DV 0,30,227:10:0 0,24,198:8:0 0,30,217:10:0 +X 1107 . C <*> 0 . DP=29;I16=23,6,0,0,1093,41509,0,0,1717,102169,0,0,558,12532,0,0;QS=3,0;MQSB=0.987041;MQ0F=0 PL:DP:DV 0,30,244:10:0 0,27,233:9:0 0,30,220:10:0 +X 1108 . A <*> 0 . DP=29;I16=23,6,0,0,1138,44908,0,0,1717,102169,0,0,558,12536,0,0;QS=3,0;MQSB=0.987041;MQ0F=0 PL:DP:DV 0,30,239:10:0 0,27,253:9:0 0,30,227:10:0 +X 1109 . G <*> 0 . DP=29;I16=23,6,0,0,1140,45200,0,0,1717,102169,0,0,557,12519,0,0;QS=3,0;MQSB=0.987041;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,27,240:9:0 0,30,224:10:0 +X 1110 . G <*> 0 . DP=29;I16=23,6,0,0,1086,41054,0,0,1717,102169,0,0,555,12481,0,0;QS=3,0;MQSB=0.987041;MQ0F=0 PL:DP:DV 0,30,242:10:0 0,27,229:9:0 0,30,224:10:0 +X 1111 . T <*> 0 . DP=29;I16=22,6,0,0,1025,37919,0,0,1680,100800,0,0,552,12470,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,227:10:0 0,24,227:8:0 0,30,211:10:0 +X 1112 . T <*> 0 . DP=28;I16=22,6,0,0,1034,38986,0,0,1680,100800,0,0,550,12440,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,226:10:0 0,24,221:8:0 0,30,221:10:0 +X 1113 . G <*> 0 . DP=28;I16=23,5,0,0,1085,42273,0,0,1680,100800,0,0,548,12386,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,202:7:0 0,33,222:11:0 +X 1114 . A <*> 0 . DP=28;I16=23,5,0,0,1079,42279,0,0,1680,100800,0,0,546,12306,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,235:10:0 0,21,209:7:0 0,33,238:11:0 +X 1115 . G <*> 0 . DP=28;I16=23,5,0,0,1114,44550,0,0,1680,100800,0,0,544,12250,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,208:7:0 0,33,234:11:0 +X 1116 . G <*> 0 . DP=29;I16=24,5,0,0,1059,39531,0,0,1740,104400,0,0,542,12218,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,236:10:0 0,24,204:8:0 0,33,226:11:0 +X 1117 . A <*> 0 . DP=29;I16=24,5,0,0,1124,43896,0,0,1740,104400,0,0,541,12211,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,235:10:0 0,24,227:8:0 0,33,234:11:0 +X 1118 . T <*> 0 . DP=29;I16=24,4,0,0,1100,44802,0,0,1680,100800,0,0,539,12131,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,230:10:0 0,21,188:7:0 0,33,248:11:0 +X 1119 . C <*> 0 . DP=29;I16=23,4,0,0,1078,44864,0,0,1620,97200,0,0,526,11958,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,224:9:0 0,21,191:7:0 0,33,255:11:0 +X 1120 . C <*> 0 . DP=29;I16=23,5,0,0,1113,46071,0,0,1680,100800,0,0,536,12054,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,227:9:0 0,24,214:8:0 0,33,255:11:0 +X 1121 . A <*> 0 . DP=30;I16=24,5,0,0,1167,48549,0,0,1740,104400,0,0,536,12056,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,233:9:0 0,24,220:8:0 0,36,255:12:0 +X 1122 . T <*> 0 . DP=32;I16=26,5,0,0,1235,50967,0,0,1860,111600,0,0,535,11985,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,230:10:0 0,27,238:9:0 0,36,255:12:0 +X 1123 . T <*> 0 . DP=32;I16=26,5,0,0,1219,50121,0,0,1860,111600,0,0,535,11893,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,221:10:0 0,27,236:9:0 0,36,255:12:0 +X 1124 . A <*> 0 . DP=31;I16=25,5,0,0,1187,48827,0,0,1800,108000,0,0,536,11832,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,218:9:0 0,27,235:9:0 0,36,255:12:0 +X 1125 . T <*> 0 . DP=31;I16=25,5,0,0,1211,51001,0,0,1800,108000,0,0,537,11801,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,228:9:0 0,27,235:9:0 0,36,255:12:0 +X 1126 . C <*> 0 . DP=31;I16=25,5,0,0,1225,52001,0,0,1800,108000,0,0,538,11800,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,234:9:0 0,27,241:9:0 0,36,255:12:0 +X 1127 . T <*> 0 . DP=31;I16=25,5,0,0,1257,55245,0,0,1800,108000,0,0,539,11829,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,231:9:0 0,27,252:9:0 0,36,255:12:0 +X 1128 . G <*> 0 . DP=31;I16=25,5,0,0,1217,51743,0,0,1800,108000,0,0,540,11888,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,236:9:0 0,27,229:9:0 0,36,255:12:0 +X 1129 . A G,<*> 0 . DP=31;I16=24,4,0,1,1101,45631,32,1024,1680,100800,60,3600,514,11300,25,625;QS=2.93535,0.0646465,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=1;BQB=1;MQ0F=0 PL:DP:DV 0,24,204,24,204,204:8:0 0,27,229,27,229,229:9:0 0,4,198,33,201,219:12:1 +X 1130 . A <*> 0 . DP=31;I16=25,5,0,0,1189,49509,0,0,1800,108000,0,0,539,11943,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,215:9:0 0,27,236:9:0 0,36,255:12:0 +X 1131 . A <*> 0 . DP=29;I16=23,5,0,0,1156,49362,0,0,1680,100800,0,0,540,11988,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,206:7:0 0,27,250:9:0 0,36,255:12:0 +X 1132 . T <*> 0 . DP=29;I16=23,5,0,0,1123,47359,0,0,1680,100800,0,0,540,12008,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,198:7:0 0,27,229:9:0 0,36,255:12:0 +X 1133 . G <*> 0 . DP=30;I16=23,5,0,0,1148,48796,0,0,1680,100800,0,0,540,12052,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,214:7:0 0,27,232:9:0 0,36,255:12:0 +X 1134 . C <*> 0 . DP=29;I16=22,6,0,0,1162,50224,0,0,1680,100800,0,0,547,12155,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,209:7:0 0,27,254:9:0 0,36,255:12:0 +X 1135 . T <*> 0 . DP=29;I16=22,6,0,0,1214,55020,0,0,1680,100800,0,0,549,12257,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,209:7:0 0,27,255:9:0 0,36,255:12:0 +X 1136 . T <*> 0 . DP=29;I16=22,6,0,0,1148,49270,0,0,1680,100800,0,0,551,12383,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,200:7:0 0,27,255:9:0 0,36,255:12:0 +X 1137 . G <*> 0 . DP=28;I16=21,6,0,0,1087,46051,0,0,1620,97200,0,0,554,12532,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,214:7:0 0,27,234:9:0 0,33,254:11:0 +X 1138 . G <*> 0 . DP=28;I16=21,6,0,0,1040,42504,0,0,1620,97200,0,0,557,12703,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,197:7:0 0,27,234:9:0 0,33,246:11:0 +X 1139 . A <*> 0 . DP=28;I16=21,6,0,0,1103,47389,0,0,1620,97200,0,0,559,12845,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,200:7:0 0,27,254:9:0 0,33,255:11:0 +X 1140 . C <*> 0 . DP=28;I16=21,6,0,0,1072,44372,0,0,1620,97200,0,0,561,13007,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,214:7:0 0,27,234:9:0 0,33,250:11:0 +X 1141 . C <*> 0 . DP=28;I16=21,6,0,0,1106,47298,0,0,1620,97200,0,0,562,13140,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,212:7:0 0,27,245:9:0 0,33,255:11:0 +X 1142 . A <*> 0 . DP=28;I16=21,6,0,0,1114,47788,0,0,1620,97200,0,0,560,13146,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,212:7:0 0,27,255:9:0 0,33,251:11:0 +X 1143 . G <*> 0 . DP=26;I16=19,7,0,0,1041,42249,0,0,1560,93600,0,0,585,13799,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,222:7:0 0,27,249:9:0 0,30,253:10:0 +X 1144 . A <*> 0 . DP=26;I16=19,7,0,0,1018,40154,0,0,1560,93600,0,0,585,13847,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,205:7:0 0,27,250:9:0 0,30,255:10:0 +X 1145 . T <*> 0 . DP=26;I16=19,7,0,0,1016,39852,0,0,1560,93600,0,0,584,13866,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,206:7:0 0,27,250:9:0 0,30,249:10:0 +X 1146 . G <*> 0 . DP=26;I16=19,7,0,0,1011,39743,0,0,1560,93600,0,0,582,13856,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,210:7:0 0,27,246:9:0 0,30,254:10:0 +X 1147 . T <*> 0 . DP=27;I16=20,6,0,0,1010,39730,0,0,1560,93600,0,0,579,13815,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,207:8:0 0,24,234:8:0 0,30,255:10:0 +X 1148 . T <*> 0 . DP=26;I16=20,6,0,0,1002,39214,0,0,1560,93600,0,0,576,13690,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,196:8:0 0,24,237:8:0 0,30,255:10:0 +X 1149 . T <*> 0 . DP=26;I16=20,6,0,0,1022,40532,0,0,1560,93600,0,0,573,13579,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,205:8:0 0,24,231:8:0 0,30,255:10:0 +X 1150 . T <*> 0 . DP=26;I16=20,6,0,0,1032,41212,0,0,1560,93600,0,0,569,13433,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,208:8:0 0,24,236:8:0 0,30,255:10:0 +X 1151 . G <*> 0 . DP=26;I16=20,6,0,0,1021,40285,0,0,1560,93600,0,0,565,13303,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,220:8:0 0,24,231:8:0 0,30,248:10:0 +X 1152 . A <*> 0 . DP=27;I16=20,7,0,0,1040,40772,0,0,1620,97200,0,0,561,13189,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,202:8:0 0,24,230:8:0 0,33,255:11:0 +X 1153 . A <*> 0 . DP=27;I16=20,7,0,0,1039,40717,0,0,1620,97200,0,0,557,13043,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,202:8:0 0,24,233:8:0 0,33,255:11:0 +X 1154 . T <*> 0 . DP=28;I16=21,7,0,0,1073,41861,0,0,1680,100800,0,0,552,12866,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,212:9:0 0,24,236:8:0 0,33,255:11:0 +X 1155 . T <*> 0 . DP=27;I16=20,7,0,0,1074,43046,0,0,1620,97200,0,0,549,12707,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,211:8:0 0,24,236:8:0 0,33,255:11:0 +X 1156 . T <*> 0 . DP=28;I16=19,8,0,0,1065,42533,0,0,1620,97200,0,0,520,11892,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,210:8:0 0,24,239:8:0 0,33,255:11:0 +X 1157 . T <*> 0 . DP=28;I16=20,8,0,0,1094,43108,0,0,1680,100800,0,0,541,12299,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,230:9:0 0,24,230:8:0 0,33,255:11:0 +X 1158 . G <*> 0 . DP=28;I16=20,8,0,0,1098,43584,0,0,1680,100800,0,0,536,12056,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,240:9:0 0,24,224:8:0 0,33,255:11:0 +X 1159 . G <*> 0 . DP=28;I16=20,8,0,0,1096,43222,0,0,1680,100800,0,0,530,11790,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,249:9:0 0,24,229:8:0 0,33,255:11:0 +X 1160 . A <*> 0 . DP=30;I16=20,10,0,0,1146,44510,0,0,1800,108000,0,0,524,11552,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,229:9:0 0,24,242:8:0 0,39,255:13:0 +X 1161 . T <*> 0 . DP=30;I16=20,10,0,0,1136,43548,0,0,1800,108000,0,0,520,11344,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,221:9:0 0,24,230:8:0 0,39,255:13:0 +X 1162 . T <*> 0 . DP=30;I16=20,10,0,0,1147,44365,0,0,1800,108000,0,0,516,11168,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,232:9:0 0,24,229:8:0 0,39,255:13:0 +X 1163 . T <*> 0 . DP=31;I16=20,11,0,0,1176,45394,0,0,1860,111600,0,0,511,10975,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,243:10:0 0,24,231:8:0 0,39,255:13:0 +X 1164 . T <*> 0 . DP=31;I16=20,11,0,0,1166,44864,0,0,1860,111600,0,0,506,10768,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,235:10:0 0,24,234:8:0 0,39,255:13:0 +X 1165 . T <*> 0 . DP=31;I16=20,11,0,0,1189,46635,0,0,1860,111600,0,0,501,10599,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,240:10:0 0,24,231:8:0 0,39,255:13:0 +X 1166 . T <*> 0 . DP=30;I16=19,11,0,0,1137,43791,0,0,1800,108000,0,0,497,10467,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,231:9:0 0,24,228:8:0 0,39,255:13:0 +X 1167 . C <*> 0 . DP=28;I16=17,11,0,0,1114,44588,0,0,1680,100800,0,0,495,10369,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,21,216:7:0 0,36,255:12:0 +X 1168 . A <*> 0 . DP=28;I16=17,11,0,0,1074,41862,0,0,1680,100800,0,0,493,10303,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,238:9:0 0,21,203:7:0 0,36,255:12:0 +X 1169 . T <*> 0 . DP=28;I16=17,11,0,0,1089,42589,0,0,1680,100800,0,0,491,10269,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,247:9:0 0,21,212:7:0 0,36,255:12:0 +X 1170 . A <*> 0 . DP=27;I16=16,11,0,0,1033,39891,0,0,1620,97200,0,0,490,10266,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,244:9:0 0,21,214:7:0 0,33,255:11:0 +X 1171 . T <*> 0 . DP=28;I16=17,11,0,0,1086,42472,0,0,1680,100800,0,0,488,10244,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,249:9:0 0,24,223:8:0 0,33,255:11:0 +X 1172 . T <*> 0 . DP=28;I16=17,11,0,0,1086,42598,0,0,1680,100800,0,0,486,10206,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,235:9:0 0,24,228:8:0 0,33,255:11:0 +X 1173 . T <*> 0 . DP=29;I16=18,11,0,0,1126,44348,0,0,1740,104400,0,0,483,10153,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,241:9:0 0,27,241:9:0 0,33,255:11:0 +X 1174 . T <*> 0 . DP=29;I16=18,11,0,0,1098,42352,0,0,1740,104400,0,0,481,10135,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,230:9:0 0,27,238:9:0 0,33,255:11:0 +X 1175 . G <*> 0 . DP=28;I16=18,10,0,0,1063,40975,0,0,1680,100800,0,0,480,10152,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,234:8:0 0,27,234:9:0 0,33,255:11:0 +X 1176 . T <*> 0 . DP=28;I16=18,10,0,0,1045,39823,0,0,1680,100800,0,0,479,10203,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,221:8:0 0,27,233:9:0 0,33,255:11:0 +X 1177 . A <*> 0 . DP=28;I16=18,10,0,0,1040,39006,0,0,1680,100800,0,0,478,10288,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,220:8:0 0,27,228:9:0 0,33,255:11:0 +X 1178 . A <*> 0 . DP=27;I16=17,10,0,0,1006,38238,0,0,1620,97200,0,0,477,10355,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,221:8:0 0,27,227:9:0 0,30,255:10:0 +X 1179 . T <*> 0 . DP=27;I16=17,10,0,0,1012,38396,0,0,1620,97200,0,0,475,10403,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,223:8:0 0,27,224:9:0 0,30,255:10:0 +X 1180 . C <*> 0 . DP=27;I16=16,10,0,0,1006,39508,0,0,1560,93600,0,0,469,10423,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,222:7:0 0,27,224:9:0 0,30,255:10:0 +X 1181 . T <*> 0 . DP=26;I16=16,10,0,0,1021,40581,0,0,1560,93600,0,0,469,10441,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,236:8:0 0,24,229:8:0 0,30,255:10:0 +X 1182 . T <*> 0 . DP=26;I16=14,11,0,0,939,35915,0,0,1500,90000,0,0,457,10347,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,236:9:0 0,21,209:7:0 0,27,255:9:0 +X 1183 . T <*> 0 . DP=25;I16=13,11,0,0,899,34555,0,0,1440,86400,0,0,455,10341,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,239:9:0 0,18,192:6:0 0,27,255:9:0 +X 1184 . G <*> 0 . DP=24;I16=13,11,0,0,916,35398,0,0,1440,86400,0,0,465,10479,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,234:8:0 0,21,201:7:0 0,27,255:9:0 +X 1185 . C <*> 0 . DP=24;I16=13,11,0,0,908,35014,0,0,1440,86400,0,0,465,10541,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,246:8:0 0,21,191:7:0 0,27,250:9:0 +X 1186 . A <*> 0 . DP=24;I16=13,11,0,0,946,37648,0,0,1440,86400,0,0,463,10525,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,240:8:0 0,21,205:7:0 0,27,255:9:0 +X 1187 . G <*> 0 . DP=25;I16=14,11,0,0,908,33870,0,0,1500,90000,0,0,461,10529,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,240:9:0 0,21,205:7:0 0,27,240:9:0 +X 1188 . T <*> 0 . DP=25;I16=14,11,0,0,886,32138,0,0,1500,90000,0,0,461,10553,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,248:10:0 0,21,196:7:0 0,24,216:8:0 +X 1189 . A <*> 0 . DP=25;I16=14,11,0,0,920,34392,0,0,1500,90000,0,0,461,10497,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,174:6:0 0,27,252:9:0 +X 1190 . T <*> 0 . DP=26;I16=14,12,0,0,960,35876,0,0,1560,93600,0,0,462,10462,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,185:6:0 0,27,252:9:0 +X 1191 . A <*> 0 . DP=26;I16=14,12,0,0,928,33922,0,0,1560,93600,0,0,464,10450,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,173:6:0 0,27,245:9:0 +X 1192 . T <*> 0 . DP=26;I16=14,12,0,0,981,37505,0,0,1560,93600,0,0,465,10413,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,191:6:0 0,27,255:9:0 +X 1193 . T <*> 0 . DP=26;I16=14,12,0,0,976,37054,0,0,1560,93600,0,0,466,10402,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,191:6:0 0,27,255:9:0 +X 1194 . T <*> 0 . DP=26;I16=14,12,0,0,951,35219,0,0,1560,93600,0,0,466,10368,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,178:6:0 0,27,249:9:0 +X 1195 . A <*> 0 . DP=26;I16=14,12,0,0,917,33253,0,0,1560,93600,0,0,466,10362,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,177:6:0 0,27,235:9:0 +X 1196 . C <*> 0 . DP=25;I16=13,12,0,0,921,34209,0,0,1500,90000,0,0,466,10334,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,187:6:0 0,27,236:9:0 +X 1197 . C <*> 0 . DP=24;I16=12,12,0,0,906,34862,0,0,1440,86400,0,0,464,10184,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,186:6:0 0,24,233:8:0 +X 1198 . A <*> 0 . DP=24;I16=12,12,0,0,937,36815,0,0,1440,86400,0,0,461,10013,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,190:6:0 0,24,245:8:0 +X 1199 . G <*> 0 . DP=24;I16=12,12,0,0,879,33035,0,0,1440,86400,0,0,457,9821,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,163:6:0 0,24,221:8:0 +X 1200 . T <*> 0 . DP=24;I16=11,12,0,0,895,35141,0,0,1380,82800,0,0,428,9032,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,176:5:0 0,24,247:8:0 +X 1201 . T <*> 0 . DP=24;I16=12,12,0,0,889,33727,0,0,1440,86400,0,0,449,9521,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,177:6:0 0,24,238:8:0 +X 1202 . C <*> 0 . DP=25;I16=13,12,0,0,929,35121,0,0,1500,90000,0,0,445,9413,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,175:6:0 0,24,230:8:0 +X 1203 . A <*> 0 . DP=25;I16=13,12,0,0,943,36107,0,0,1500,90000,0,0,442,9334,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,184:6:0 0,24,241:8:0 +X 1204 . G <*> 0 . DP=24;I16=13,11,0,0,876,33106,0,0,1440,86400,0,0,439,9235,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,174:6:0 0,21,218:7:0 +X 1205 . C <*> 0 . DP=24;I16=13,11,0,0,891,33869,0,0,1440,86400,0,0,436,9166,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,176:6:0 0,21,217:7:0 +X 1206 . A <*> 0 . DP=23;I16=13,10,0,0,846,31744,0,0,1380,82800,0,0,434,9126,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,179:6:0 0,21,212:7:0 +X 1207 . T <*> 0 . DP=23;I16=13,9,0,0,819,30877,0,0,1320,79200,0,0,407,8489,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,254:10:0 0,18,189:6:0 0,18,194:6:0 +X 1208 . C <*> 0 . DP=24;I16=14,10,0,0,910,35236,0,0,1440,86400,0,0,429,9079,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,190:7:0 0,21,217:7:0 +X 1209 . C T,<*> 0 . DP=24;I16=14,9,0,1,869,33481,21,441,1380,82800,60,3600,408,8710,19,361;QS=2.91393,0.0860656,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=1;BQB=1;MQ0F=0 PL:DP:DV 0,30,255,30,255,255:10:0 0,0,153,18,156,166:7:1 0,21,209,21,209,209:7:0 +X 1210 . C <*> 0 . DP=24;I16=14,10,0,0,915,35713,0,0,1440,86400,0,0,425,9091,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,199:7:0 0,21,209:7:0 +X 1211 . T <*> 0 . DP=24;I16=14,10,0,0,905,34669,0,0,1440,86400,0,0,423,9139,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,213:7:0 0,21,214:7:0 +X 1212 . A <*> 0 . DP=24;I16=14,10,0,0,850,30690,0,0,1440,86400,0,0,421,9215,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,246:10:0 0,21,190:7:0 0,21,204:7:0 +X 1213 . A <*> 0 . DP=24;I16=14,10,0,0,852,31192,0,0,1440,86400,0,0,418,9268,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,253:10:0 0,21,197:7:0 0,21,195:7:0 +X 1214 . C <*> 0 . DP=23;I16=13,10,0,0,851,32099,0,0,1380,82800,0,0,415,9295,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,186:7:0 0,18,184:6:0 +X 1215 . T <*> 0 . DP=23;I16=13,9,0,0,839,32475,0,0,1320,79200,0,0,386,8668,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,211:7:0 0,15,172:5:0 +X 1216 . C <*> 0 . DP=23;I16=13,10,0,0,863,32923,0,0,1380,82800,0,0,406,9260,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,196:7:0 0,18,172:6:0 +X 1217 . A <*> 0 . DP=22;I16=12,10,0,0,820,30926,0,0,1320,79200,0,0,402,9244,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,172:6:0 0,18,191:6:0 +X 1218 . A <*> 0 . DP=22;I16=12,10,0,0,764,27286,0,0,1320,79200,0,0,398,9244,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,145:6:0 0,18,184:6:0 +X 1219 . A <*> 0 . DP=21;I16=12,9,0,0,803,31119,0,0,1260,75600,0,0,395,9259,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,175:6:0 0,15,173:5:0 +X 1220 . A <*> 0 . DP=21;I16=12,9,0,0,752,27700,0,0,1260,75600,0,0,392,9288,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,253:10:0 0,18,167:6:0 0,15,167:5:0 +X 1221 . A <*> 0 . DP=20;I16=12,8,0,0,722,26564,0,0,1200,72000,0,0,390,9330,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,147:5:0 0,15,157:5:0 +X 1222 . T <*> 0 . DP=18;I16=10,8,0,0,666,25034,0,0,1080,64800,0,0,389,9333,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,245:9:0 0,15,143:5:0 0,12,142:4:0 +X 1223 . T <*> 0 . DP=17;I16=9,7,0,0,574,21262,0,0,960,57600,0,0,364,8720,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,232:9:0 0,12,122:4:0 0,9,120:3:0 +X 1224 . C <*> 0 . DP=19;I16=10,7,0,0,639,24429,0,0,1020,61200,0,0,364,8740,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,128:4:0 0,9,112:3:0 +X 1225 . A <*> 0 . DP=19;I16=10,9,0,0,713,27139,0,0,1109,65641,0,0,395,9419,0,0;QS=3,0;MQSB=0.920044;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,137:5:0 0,12,145:4:0 +X 1226 . A <*> 0 . DP=19;I16=10,9,0,0,688,25468,0,0,1109,65641,0,0,397,9469,0,0;QS=3,0;MQSB=0.920044;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,127:5:0 0,12,147:4:0 +X 1227 . A <*> 0 . DP=19;I16=10,9,0,0,698,26104,0,0,1109,65641,0,0,399,9531,0,0;QS=3,0;MQSB=0.920044;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,133:5:0 0,12,146:4:0 +X 1228 . A <*> 0 . DP=19;I16=10,9,0,0,705,26721,0,0,1109,65641,0,0,399,9505,0,0;QS=3,0;MQSB=0.920044;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,143:5:0 0,12,145:4:0 +X 1229 . A <*> 0 . DP=18;I16=10,8,0,0,693,26891,0,0,1049,62041,0,0,400,9490,0,0;QS=3,0;MQSB=0.906029;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,123:4:0 0,12,138:4:0 +X 1230 . T <*> 0 . DP=18;I16=10,8,0,0,643,23601,0,0,1049,62041,0,0,401,9485,0,0;QS=3,0;MQSB=0.906029;MQ0F=0 PL:DP:DV 0,30,245:10:0 0,12,115:4:0 0,12,144:4:0 +X 1231 . C <*> 0 . DP=18;I16=10,7,0,0,663,26041,0,0,1020,61200,0,0,390,9320,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,98:3:0 0,12,138:4:0 +X 1232 . T <*> 0 . DP=18;I16=10,8,0,0,683,26261,0,0,1049,62041,0,0,401,9409,0,0;QS=3,0;MQSB=0.906029;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,133:4:0 0,12,129:4:0 +X 1233 . G <*> 0 . DP=18;I16=10,8,0,0,657,24509,0,0,1049,62041,0,0,401,9389,0,0;QS=3,0;MQSB=0.906029;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,124:4:0 0,12,129:4:0 +X 1234 . A <*> 0 . DP=19;I16=10,8,0,0,677,26177,0,0,1080,64800,0,0,386,9134,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,101:3:0 0,12,144:4:0 +X 1235 . A <*> 0 . DP=19;I16=10,9,0,0,697,26363,0,0,1109,65641,0,0,400,9282,0,0;QS=3,0;MQSB=0.920044;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,129:4:0 0,12,140:4:0 +X 1236 . A <*> 0 . DP=19;I16=10,9,0,0,671,24693,0,0,1109,65641,0,0,398,9148,0,0;QS=3,0;MQSB=0.920044;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,103:4:0 0,12,136:4:0 +X 1237 . T <*> 0 . DP=19;I16=9,9,0,0,649,24061,0,0,1049,62041,0,0,370,8356,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,98:3:0 0,12,135:4:0 +X 1238 . C <*> 0 . DP=20;I16=11,9,0,0,733,27709,0,0,1169,69241,0,0,391,8783,0,0;QS=3,0;MQSB=0.916401;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,104:4:0 0,12,145:4:0 +X 1239 . C <*> 0 . DP=20;I16=10,9,0,0,672,24596,0,0,1109,65641,0,0,363,7981,0,0;QS=3,0;MQSB=0.920044;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,76:3:0 0,12,124:4:0 +X 1240 . C <*> 0 . DP=20;I16=11,9,0,0,723,26895,0,0,1169,69241,0,0,385,8451,0,0;QS=3,0;MQSB=0.916401;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,118:4:0 0,12,129:4:0 +X 1241 . A <*> 0 . DP=20;I16=11,9,0,0,719,26575,0,0,1169,69241,0,0,382,8318,0,0;QS=3,0;MQSB=0.916401;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,104:4:0 0,12,141:4:0 +X 1242 . A <*> 0 . DP=21;I16=12,9,0,0,749,27599,0,0,1229,72841,0,0,379,8207,0,0;QS=3,0;MQSB=0.913101;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,109:4:0 0,15,153:5:0 +X 1243 . A <*> 0 . DP=21;I16=12,9,0,0,738,26862,0,0,1229,72841,0,0,377,8119,0,0;QS=3,0;MQSB=0.913101;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,110:4:0 0,15,158:5:0 +X 1244 . C <*> 0 . DP=21;I16=12,8,0,0,670,22952,0,0,1169,69241,0,0,365,7955,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,101:4:0 0,15,148:5:0 +X 1245 . G <*> 0 . DP=21;I16=12,9,0,0,657,21627,0,0,1229,72841,0,0,373,8015,0,0;QS=3,0;MQSB=0.913101;MQ0F=0 PL:DP:DV 0,36,245:12:0 0,12,95:4:0 0,15,158:5:0 +X 1246 . C <*> 0 . DP=21;I16=12,9,0,0,652,21348,0,0,1229,72841,0,0,370,7948,0,0;QS=3,0;MQSB=0.913101;MQ0F=0 PL:DP:DV 0,36,252:12:0 0,12,95:4:0 0,15,146:5:0 +X 1247 . G <*> 0 . DP=20;I16=11,9,0,0,655,22291,0,0,1169,69241,0,0,367,7853,0,0;QS=3,0;MQSB=0.916401;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,87:4:0 0,15,150:5:0 +X 1248 . C <*> 0 . DP=20;I16=10,8,0,0,659,25037,0,0,1080,64800,0,0,314,6530,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,90:3:0 0,15,156:5:0 +X 1249 . C <*> 0 . DP=21;I16=12,9,0,0,772,28954,0,0,1229,72841,0,0,360,7680,0,0;QS=3,0;MQSB=0.913101;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,111:4:0 0,15,166:5:0 +X 1250 . A <*> 0 . DP=21;I16=12,9,0,0,757,27599,0,0,1229,72841,0,0,356,7554,0,0;QS=3,0;MQSB=0.913101;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,114:4:0 0,15,161:5:0 +X 1251 . A <*> 0 . DP=21;I16=12,9,0,0,758,27890,0,0,1229,72841,0,0,352,7452,0,0;QS=3,0;MQSB=0.913101;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,115:4:0 0,15,174:5:0 +X 1252 . T <*> 0 . DP=21;I16=12,9,0,0,758,27574,0,0,1229,72841,0,0,348,7374,0,0;QS=3,0;MQSB=0.913101;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,124:4:0 0,15,159:5:0 +X 1253 . A <*> 0 . DP=20;I16=12,8,0,0,718,26292,0,0,1169,69241,0,0,345,7319,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,127:4:0 0,12,144:4:0 +X 1254 . A <*> 0 . DP=20;I16=12,8,0,0,781,30817,0,0,1169,69241,0,0,342,7286,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,134:4:0 0,12,156:4:0 +X 1255 . G <*> 0 . DP=21;I16=12,9,0,0,785,30039,0,0,1229,72841,0,0,339,7275,0,0;QS=3,0;MQSB=0.913101;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,128:4:0 0,15,169:5:0 +X 1256 . C <*> 0 . DP=20;I16=12,8,0,0,742,27910,0,0,1169,69241,0,0,338,7286,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,116:4:0 0,15,165:5:0 +X 1257 . A <*> 0 . DP=20;I16=12,8,0,0,745,28017,0,0,1169,69241,0,0,337,7319,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,132:4:0 0,15,167:5:0 +X 1258 . T <*> 0 . DP=20;I16=12,8,0,0,753,28507,0,0,1169,69241,0,0,336,7374,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,126:4:0 0,15,170:5:0 +X 1259 . T <*> 0 . DP=20;I16=12,8,0,0,690,24762,0,0,1169,69241,0,0,335,7451,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,33,236:11:0 0,12,128:4:0 0,15,170:5:0 +X 1260 . C <*> 0 . DP=20;I16=12,8,0,0,719,26541,0,0,1169,69241,0,0,333,7499,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,127:4:0 0,15,155:5:0 +X 1261 . C <*> 0 . DP=18;I16=11,6,0,0,602,22374,0,0,989,58441,0,0,308,6940,0,0;QS=3,0;MQSB=0.85832;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,117:4:0 0,9,109:3:0 +X 1262 . C <*> 0 . DP=18;I16=12,6,0,0,653,24345,0,0,1049,62041,0,0,333,7597,0,0;QS=3,0;MQSB=0.85394;MQ0F=0 PL:DP:DV 0,30,253:10:0 0,15,145:5:0 0,9,114:3:0 +X 1263 . T <*> 0 . DP=17;I16=12,5,0,0,654,25656,0,0,989,58441,0,0,335,7645,0,0;QS=3,0;MQSB=0.818731;MQ0F=0 PL:DP:DV 0,27,238:9:0 0,15,158:5:0 0,9,118:3:0 +X 1264 . T <*> 0 . DP=17;I16=12,5,0,0,615,22855,0,0,989,58441,0,0,336,7658,0,0;QS=3,0;MQSB=0.818731;MQ0F=0 PL:DP:DV 0,27,226:9:0 0,15,149:5:0 0,9,114:3:0 +X 1265 . T <*> 0 . DP=17;I16=12,5,0,0,620,23176,0,0,989,58441,0,0,334,7538,0,0;QS=3,0;MQSB=0.818731;MQ0F=0 PL:DP:DV 0,27,232:9:0 0,15,144:5:0 0,9,114:3:0 +X 1266 . G <*> 0 . DP=18;I16=13,5,0,0,675,25765,0,0,1049,62041,0,0,332,7438,0,0;QS=3,0;MQSB=0.814433;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,145:5:0 0,9,114:3:0 +X 1267 . A <*> 0 . DP=18;I16=13,5,0,0,663,24799,0,0,1049,62041,0,0,331,7359,0,0;QS=3,0;MQSB=0.814433;MQ0F=0 PL:DP:DV 0,30,253:10:0 0,15,138:5:0 0,9,114:3:0 +X 1268 . G <*> 0 . DP=18;I16=13,5,0,0,638,23584,0,0,1049,62041,0,0,329,7251,0,0;QS=3,0;MQSB=0.814433;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,112:5:0 0,9,108:3:0 +X 1269 . C <*> 0 . DP=18;I16=13,5,0,0,592,20458,0,0,1049,62041,0,0,327,7163,0,0;QS=3,0;MQSB=0.814433;MQ0F=0 PL:DP:DV 0,30,224:10:0 0,15,130:5:0 0,9,107:3:0 +X 1270 . G <*> 0 . DP=18;I16=13,5,0,0,537,16775,0,0,1049,62041,0,0,325,7095,0,0;QS=3,0;MQSB=0.814433;MQ0F=0 PL:DP:DV 0,30,206:10:0 0,15,104:5:0 0,9,98:3:0 +X 1271 . T <*> 0 . DP=18;I16=12,5,0,0,620,22824,0,0,989,58441,0,0,298,6422,0,0;QS=3,0;MQSB=0.818731;MQ0F=0 PL:DP:DV 0,27,240:9:0 0,15,138:5:0 0,9,109:3:0 +X 1272 . C <*> 0 . DP=17;I16=11,5,0,0,597,22587,0,0,929,54841,0,0,297,6393,0,0;QS=3,0;MQSB=0.823561;MQ0F=0 PL:DP:DV 0,27,251:9:0 0,12,113:4:0 0,9,110:3:0 +X 1273 . A <*> 0 . DP=18;I16=12,6,0,0,633,23063,0,0,1049,62041,0,0,318,6866,0,0;QS=3,0;MQSB=0.85394;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,109:4:0 0,9,113:3:0 +X 1274 . T <*> 0 . DP=17;I16=10,6,0,0,609,23335,0,0,929,54841,0,0,293,6205,0,0;QS=3,0;MQSB=0.863243;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,67:2:0 0,9,115:3:0 +X 1275 . G <*> 0 . DP=17;I16=11,6,0,0,602,21976,0,0,989,58441,0,0,317,6763,0,0;QS=3,0;MQSB=0.85832;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,87:3:0 0,9,112:3:0 +X 1276 . T <*> 0 . DP=17;I16=11,6,0,0,587,20925,0,0,989,58441,0,0,316,6714,0,0;QS=3,0;MQSB=0.85832;MQ0F=0 PL:DP:DV 0,33,248:11:0 0,9,94:3:0 0,9,110:3:0 +X 1277 . C <*> 0 . DP=18;I16=11,7,0,0,590,20126,0,0,1049,62041,0,0,314,6634,0,0;QS=3,0;MQSB=0.883327;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,85:3:0 0,9,106:3:0 +X 1278 . G <*> 0 . DP=18;I16=11,7,0,0,603,20675,0,0,1049,62041,0,0,313,6575,0,0;QS=3,0;MQSB=0.883327;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,77:3:0 0,9,96:3:0 +X 1279 . G <*> 0 . DP=18;I16=11,7,0,0,646,23662,0,0,1049,62041,0,0,312,6538,0,0;QS=3,0;MQSB=0.883327;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,85:3:0 0,9,113:3:0 +X 1280 . T <*> 0 . DP=18;I16=10,7,0,0,558,19192,0,0,989,58441,0,0,296,6298,0,0;QS=3,0;MQSB=0.887766;MQ0F=0 PL:DP:DV 0,33,249:11:0 0,9,86:3:0 0,9,97:3:0 +X 1281 . G <*> 0 . DP=17;I16=10,6,0,0,564,21244,0,0,929,54841,0,0,270,5658,0,0;QS=3,0;MQSB=0.863243;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,85:3:0 0,9,103:3:0 +X 1282 . C <*> 0 . DP=18;I16=10,8,0,0,654,24308,0,0,1049,62041,0,0,294,6286,0,0;QS=3,0;MQSB=0.906029;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,94:3:0 0,12,131:4:0 +X 1283 . T <*> 0 . DP=18;I16=10,8,0,0,677,26313,0,0,1049,62041,0,0,294,6308,0,0;QS=3,0;MQSB=0.906029;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,83:3:0 0,12,154:4:0 +X 1284 . T <*> 0 . DP=18;I16=10,8,0,0,631,22949,0,0,1049,62041,0,0,293,6301,0,0;QS=3,0;MQSB=0.906029;MQ0F=0 PL:DP:DV 0,33,254:11:0 0,9,92:3:0 0,12,145:4:0 +X 1285 . G <*> 0 . DP=18;I16=10,7,0,0,657,25545,0,0,989,58441,0,0,267,5691,0,0;QS=3,0;MQSB=0.887766;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,94:3:0 0,12,145:4:0 +X 1286 . G <*> 0 . DP=18;I16=10,8,0,0,650,24684,0,0,1049,62041,0,0,291,6353,0,0;QS=3,0;MQSB=0.906029;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,78:3:0 0,12,148:4:0 +X 1287 . A <*> 0 . DP=17;I16=9,8,0,0,609,22229,0,0,989,58441,0,0,291,6411,0,0;QS=3,0;MQSB=0.91051;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,91:3:0 0,12,137:4:0 +X 1288 . A <*> 0 . DP=17;I16=9,8,0,0,605,22315,0,0,989,58441,0,0,290,6438,0,0;QS=3,0;MQSB=0.91051;MQ0F=0 PL:DP:DV 0,30,245:10:0 0,9,103:3:0 0,12,140:4:0 +X 1289 . T <*> 0 . DP=18;I16=10,8,0,0,637,23207,0,0,1049,62041,0,0,289,6483,0,0;QS=3,0;MQSB=0.906029;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,99:3:0 0,12,141:4:0 +X 1290 . G <*> 0 . DP=15;I16=9,6,0,0,559,21163,0,0,869,51241,0,0,292,6544,0,0;QS=3,0;MQSB=0.868815;MQ0F=0 PL:DP:DV 0,27,242:9:0 0,9,97:3:0 0,9,106:3:0 +X 1291 . T <*> 0 . DP=15;I16=9,6,0,0,547,20303,0,0,869,51241,0,0,295,6619,0,0;QS=3,0;MQSB=0.868815;MQ0F=0 PL:DP:DV 0,27,225:9:0 0,9,91:3:0 0,9,117:3:0 +X 1292 . T <*> 0 . DP=15;I16=9,6,0,0,559,21121,0,0,869,51241,0,0,297,6657,0,0;QS=3,0;MQSB=0.868815;MQ0F=0 PL:DP:DV 0,27,236:9:0 0,9,95:3:0 0,9,113:3:0 +X 1293 . T <*> 0 . DP=15;I16=9,6,0,0,578,22428,0,0,869,51241,0,0,299,6707,0,0;QS=3,0;MQSB=0.868815;MQ0F=0 PL:DP:DV 0,27,242:9:0 0,9,100:3:0 0,9,116:3:0 +X 1294 . G <*> 0 . DP=16;I16=9,7,0,0,606,23572,0,0,929,54841,0,0,301,6769,0,0;QS=3,0;MQSB=0.892753;MQ0F=0 PL:DP:DV 0,27,254:9:0 0,12,110:4:0 0,9,119:3:0 +X 1295 . G <*> 0 . DP=16;I16=9,7,0,0,567,21419,0,0,929,54841,0,0,304,6844,0,0;QS=3,0;MQSB=0.892753;MQ0F=0 PL:DP:DV 0,27,244:9:0 0,12,102:4:0 0,9,114:3:0 +X 1296 . G <*> 0 . DP=16;I16=8,7,0,0,518,19300,0,0,869,51241,0,0,294,6740,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,27,227:9:0 0,9,89:3:0 0,9,114:3:0 +X 1297 . G <*> 0 . DP=18;I16=9,8,0,0,551,19323,0,0,958,55682,0,0,322,7444,0,0;QS=3,0;MQSB=0.998843;MQ0F=0 PL:DP:DV 0,30,219:10:0 0,9,86:3:0 0,12,133:4:0 +X 1298 . T <*> 0 . DP=18;I16=10,8,0,0,615,22371,0,0,1018,59282,0,0,336,7638,0,0;QS=3,0;MQSB=0.99606;MQ0F=0 PL:DP:DV 0,30,233:10:0 0,12,105:4:0 0,12,138:4:0 +X 1299 . T <*> 0 . DP=18;I16=9,8,0,0,619,23135,0,0,958,55682,0,0,328,7548,0,0;QS=3,0;MQSB=0.998843;MQ0F=0 PL:DP:DV 0,30,242:10:0 0,9,97:3:0 0,12,136:4:0 +X 1300 . T <*> 0 . DP=18;I16=10,8,0,0,631,23107,0,0,1018,59282,0,0,338,7638,0,0;QS=3,0;MQSB=0.99606;MQ0F=0 PL:DP:DV 0,30,235:10:0 0,12,121:4:0 0,12,136:4:0 +X 1301 . T G,<*> 0 . DP=18;I16=8,8,1,0,599,22623,18,324,929,54841,29,841,314,7040,25,625;QS=2.9434,0.0566038,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.998843;BQB=1;MQ0F=0 PL:DP:DV 0,9,213,24,216,222:9:1 0,12,126,12,126,126:4:0 0,12,135,12,135,135:4:0 +X 1302 . G <*> 0 . DP=17;I16=9,8,0,0,624,23544,0,0,958,55682,0,0,341,7709,0,0;QS=3,0;MQSB=0.998843;MQ0F=0 PL:DP:DV 0,27,240:9:0 0,12,127:4:0 0,12,140:4:0 +X 1303 . G <*> 0 . DP=17;I16=9,8,0,0,582,21200,0,0,958,55682,0,0,342,7718,0,0;QS=3,0;MQSB=0.998843;MQ0F=0 PL:DP:DV 0,27,217:9:0 0,12,125:4:0 0,12,138:4:0 +X 1304 . A <*> 0 . DP=18;I16=10,8,0,0,652,24124,0,0,1018,59282,0,0,343,7741,0,0;QS=3,0;MQSB=0.99606;MQ0F=0 PL:DP:DV 0,27,218:9:0 0,12,131:4:0 0,15,169:5:0 +X 1305 . T <*> 0 . DP=18;I16=10,8,0,0,685,26381,0,0,1018,59282,0,0,345,7779,0,0;QS=3,0;MQSB=0.99606;MQ0F=0 PL:DP:DV 0,27,241:9:0 0,12,122:4:0 0,15,174:5:0 +X 1306 . T <*> 0 . DP=18;I16=9,8,0,0,644,24628,0,0,958,55682,0,0,345,7829,0,0;QS=3,0;MQSB=0.998843;MQ0F=0 PL:DP:DV 0,27,236:9:0 0,9,106:3:0 0,15,168:5:0 +X 1307 . T <*> 0 . DP=17;I16=9,8,0,0,628,23746,0,0,958,55682,0,0,348,7902,0,0;QS=3,0;MQSB=0.998843;MQ0F=0 PL:DP:DV 0,27,226:9:0 0,9,104:3:0 0,15,167:5:0 +X 1308 . A <*> 0 . DP=19;I16=9,10,0,0,690,25500,0,0,1078,62882,0,0,350,7938,0,0;QS=3,0;MQSB=0.999167;MQ0F=0 PL:DP:DV 0,30,236:10:0 0,12,127:4:0 0,15,173:5:0 +X 1309 . C <*> 0 . DP=19;I16=9,9,0,0,698,27148,0,0,1049,62041,0,0,342,7818,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,106:3:0 0,15,169:5:0 +X 1310 . A <*> 0 . DP=19;I16=9,10,0,0,751,29953,0,0,1078,62882,0,0,356,7958,0,0;QS=3,0;MQSB=0.999167;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,132:4:0 0,15,183:5:0 +X 1311 . G <*> 0 . DP=19;I16=9,10,0,0,742,29384,0,0,1078,62882,0,0,359,7995,0,0;QS=3,0;MQSB=0.999167;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,128:4:0 0,15,174:5:0 +X 1312 . C <*> 0 . DP=19;I16=9,10,0,0,717,27783,0,0,1078,62882,0,0,362,8050,0,0;QS=3,0;MQSB=0.999167;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,115:4:0 0,15,166:5:0 +X 1313 . T <*> 0 . DP=19;I16=9,10,0,0,751,30061,0,0,1078,62882,0,0,364,8074,0,0;QS=3,0;MQSB=0.999167;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,135:4:0 0,15,175:5:0 +X 1314 . T <*> 0 . DP=19;I16=9,10,0,0,707,26983,0,0,1078,62882,0,0,366,8118,0,0;QS=3,0;MQSB=0.999167;MQ0F=0 PL:DP:DV 0,30,245:10:0 0,12,134:4:0 0,15,174:5:0 +X 1315 . T <*> 0 . DP=19;I16=9,10,0,0,717,27491,0,0,1078,62882,0,0,367,8131,0,0;QS=3,0;MQSB=0.999167;MQ0F=0 PL:DP:DV 0,30,250:10:0 0,12,132:4:0 0,15,174:5:0 +X 1316 . G <*> 0 . DP=21;I16=10,11,0,0,776,29502,0,0,1198,70082,0,0,368,8162,0,0;QS=3,0;MQSB=0.99938;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,128:4:0 0,18,188:6:0 +X 1317 . G <*> 0 . DP=21;I16=10,11,0,0,751,27855,0,0,1198,70082,0,0,371,8213,0,0;QS=3,0;MQSB=0.99938;MQ0F=0 PL:DP:DV 0,33,253:11:0 0,12,130:4:0 0,18,179:6:0 +X 1318 . G <*> 0 . DP=21;I16=10,11,0,0,749,27663,0,0,1198,70082,0,0,372,8188,0,0;QS=3,0;MQSB=0.99938;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,130:4:0 0,18,184:6:0 +X 1319 . A <*> 0 . DP=21;I16=10,11,0,0,768,28390,0,0,1198,70082,0,0,373,8189,0,0;QS=3,0;MQSB=0.99938;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,124:4:0 0,18,186:6:0 +X 1320 . C <*> 0 . DP=21;I16=10,11,0,0,728,25496,0,0,1198,70082,0,0,373,8165,0,0;QS=3,0;MQSB=0.99938;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,113:4:0 0,18,161:6:0 +X 1321 . G <*> 0 . DP=22;I16=10,12,0,0,762,27412,0,0,1289,76441,0,0,374,8164,0,0;QS=3,0;MQSB=0.924723;MQ0F=0 PL:DP:DV 0,33,244:11:0 0,9,104:3:0 0,24,208:8:0 +X 1322 . C <*> 0 . DP=22;I16=10,12,0,0,852,33528,0,0,1289,76441,0,0,377,8187,0,0;QS=3,0;MQSB=0.924723;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,111:3:0 0,24,225:8:0 +X 1323 . T <*> 0 . DP=22;I16=10,12,0,0,874,35152,0,0,1289,76441,0,0,379,8185,0,0;QS=3,0;MQSB=0.924723;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,112:3:0 0,24,237:8:0 +X 1324 . C <*> 0 . DP=21;I16=9,12,0,0,793,30585,0,0,1229,72841,0,0,381,8157,0,0;QS=3,0;MQSB=0.913101;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,109:3:0 0,24,218:8:0 +X 1325 . A <*> 0 . DP=21;I16=9,12,0,0,782,29430,0,0,1229,72841,0,0,383,8153,0,0;QS=3,0;MQSB=0.913101;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,105:3:0 0,24,218:8:0 +X 1326 . A <*> 0 . DP=21;I16=9,12,0,0,791,30479,0,0,1229,72841,0,0,385,8173,0,0;QS=3,0;MQSB=0.913101;MQ0F=0 PL:DP:DV 0,30,249:10:0 0,9,108:3:0 0,24,230:8:0 +X 1327 . C <*> 0 . DP=23;I16=11,12,0,0,834,31048,0,0,1349,80041,0,0,387,8217,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,99:3:0 0,27,237:9:0 +X 1328 . C <*> 0 . DP=23;I16=11,12,0,0,878,33972,0,0,1349,80041,0,0,391,8287,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,105:3:0 0,27,254:9:0 +X 1329 . T <*> 0 . DP=23;I16=11,12,0,0,882,34756,0,0,1349,80041,0,0,395,8385,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,112:3:0 0,27,255:9:0 +X 1330 . G <*> 0 . DP=23;I16=11,12,0,0,856,32638,0,0,1349,80041,0,0,398,8460,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,101:3:0 0,27,241:9:0 +X 1331 . T <*> 0 . DP=23;I16=11,12,0,0,847,31785,0,0,1349,80041,0,0,400,8512,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,106:3:0 0,27,247:9:0 +X 1332 . A <*> 0 . DP=23;I16=11,12,0,0,826,30264,0,0,1349,80041,0,0,402,8592,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,33,252:11:0 0,9,104:3:0 0,27,238:9:0 +X 1333 . C <*> 0 . DP=23;I16=11,12,0,0,836,30928,0,0,1349,80041,0,0,404,8700,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,101:3:0 0,27,236:9:0 +X 1334 . C <*> 0 . DP=22;I16=11,11,0,0,830,32380,0,0,1289,76441,0,0,405,8733,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,107:3:0 0,27,238:9:0 +X 1335 . T <*> 0 . DP=22;I16=11,11,0,0,877,35371,0,0,1289,76441,0,0,406,8788,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,113:3:0 0,27,253:9:0 +X 1336 . C <*> 0 . DP=25;I16=12,12,0,0,890,33648,0,0,1378,80882,0,0,398,8784,0,0;QS=3,0;MQSB=0.786628;MQ0F=0 PL:DP:DV 0,33,250:11:0 0,12,131:4:0 0,27,237:9:0 +X 1337 . A <*> 0 . DP=26;I16=13,13,0,0,941,34611,0,0,1498,88082,0,0,411,8967,0,0;QS=3,0;MQSB=0.800737;MQ0F=0 PL:DP:DV 0,33,249:11:0 0,15,152:5:0 0,30,247:10:0 +X 1338 . A <*> 0 . DP=26;I16=12,14,0,0,982,37358,0,0,1498,88082,0,0,416,9048,0,0;QS=3,0;MQSB=0.771623;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,153:5:0 0,30,255:10:0 +X 1339 . T <*> 0 . DP=27;I16=12,15,0,0,989,36855,0,0,1558,91682,0,0,422,9160,0,0;QS=3,0;MQSB=0.765017;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,151:5:0 0,33,255:11:0 +X 1340 . A <*> 0 . DP=27;I16=11,15,0,0,937,34141,0,0,1498,88082,0,0,425,9289,0,0;QS=3,0;MQSB=0.738577;MQ0F=0 PL:DP:DV 0,30,250:10:0 0,15,149:5:0 0,33,254:11:0 +X 1341 . A <*> 0 . DP=27;I16=12,14,0,0,929,33961,0,0,1498,88082,0,0,410,8810,0,0;QS=3,0;MQSB=0.771623;MQ0F=0 PL:DP:DV 0,30,245:10:0 0,15,141:5:0 0,33,255:11:0 +X 1342 . A <*> 0 . DP=27;I16=12,15,0,0,951,34575,0,0,1558,91682,0,0,439,9499,0,0;QS=3,0;MQSB=0.765017;MQ0F=0 PL:DP:DV 0,33,254:11:0 0,15,159:5:0 0,33,249:11:0 +X 1343 . C <*> 0 . DP=25;I16=10,15,0,0,902,33364,0,0,1469,87241,0,0,445,9593,0,0;QS=3,0;MQSB=0.9171;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,140:5:0 0,30,233:10:0 +X 1344 . C <*> 0 . DP=26;I16=10,16,0,0,985,37915,0,0,1529,90841,0,0,451,9715,0,0;QS=3,0;MQSB=0.914947;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,163:6:0 0,30,238:10:0 +X 1345 . T <*> 0 . DP=26;I16=10,16,0,0,1004,39262,0,0,1529,90841,0,0,458,9866,0,0;QS=3,0;MQSB=0.914947;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,182:6:0 0,30,242:10:0 +X 1346 . G <*> 0 . DP=26;I16=10,16,0,0,1003,38983,0,0,1529,90841,0,0,465,10047,0,0;QS=3,0;MQSB=0.914947;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,172:6:0 0,30,239:10:0 +X 1347 . A <*> 0 . DP=26;I16=10,16,0,0,995,38409,0,0,1529,90841,0,0,470,10156,0,0;QS=3,0;MQSB=0.914947;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,177:6:0 0,30,243:10:0 +X 1348 . T <*> 0 . DP=26;I16=10,16,0,0,988,38126,0,0,1529,90841,0,0,474,10242,0,0;QS=3,0;MQSB=0.914947;MQ0F=0 PL:DP:DV 0,30,252:10:0 0,18,185:6:0 0,30,251:10:0 +X 1349 . T <*> 0 . DP=26;I16=9,15,0,0,905,34409,0,0,1409,83641,0,0,454,9730,0,0;QS=3,0;MQSB=0.904837;MQ0F=0 PL:DP:DV 0,24,225:8:0 0,18,176:6:0 0,30,248:10:0 +X 1350 . T <*> 0 . DP=26;I16=10,16,0,0,975,36909,0,0,1498,88082,0,0,485,10495,0,0;QS=3,0;MQSB=0.700784;MQ0F=0 PL:DP:DV 0,27,242:9:0 0,21,195:7:0 0,30,249:10:0 +X 1351 . T <*> 0 . DP=26;I16=10,16,0,0,956,35602,0,0,1498,88082,0,0,491,10663,0,0;QS=3,0;MQSB=0.700784;MQ0F=0 PL:DP:DV 0,27,238:9:0 0,21,193:7:0 0,30,240:10:0 +X 1352 . A <*> 0 . DP=26;I16=10,16,0,0,901,31965,0,0,1498,88082,0,0,496,10810,0,0;QS=3,0;MQSB=0.700784;MQ0F=0 PL:DP:DV 0,27,250:9:0 0,21,180:7:0 0,30,211:10:0 +X 1353 . A <*> 0 . DP=26;I16=10,16,0,0,927,33583,0,0,1498,88082,0,0,499,10885,0,0;QS=3,0;MQSB=0.700784;MQ0F=0 PL:DP:DV 0,27,240:9:0 0,21,187:7:0 0,30,224:10:0 +X 1354 . A <*> 0 . DP=26;I16=10,16,0,0,927,33621,0,0,1498,88082,0,0,502,10986,0,0;QS=3,0;MQSB=0.700784;MQ0F=0 PL:DP:DV 0,27,237:9:0 0,21,190:7:0 0,30,223:10:0 +X 1355 . A <*> 0 . DP=26;I16=10,16,0,0,924,33736,0,0,1498,88082,0,0,505,11113,0,0;QS=3,0;MQSB=0.700784;MQ0F=0 PL:DP:DV 0,27,239:9:0 0,21,186:7:0 0,30,227:10:0 +X 1356 . A <*> 0 . DP=25;I16=10,15,0,0,916,34050,0,0,1438,84482,0,0,509,11265,0,0;QS=3,0;MQSB=0.707404;MQ0F=0 PL:DP:DV 0,27,249:9:0 0,21,178:7:0 0,27,226:9:0 +X 1357 . A <*> 0 . DP=25;I16=9,15,0,0,949,38007,0,0,1378,80882,0,0,488,10816,0,0;QS=3,0;MQSB=0.67032;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,21,193:7:0 0,24,217:8:0 +X 1358 . G <*> 0 . DP=25;I16=9,15,0,0,873,32435,0,0,1378,80882,0,0,491,10967,0,0;QS=3,0;MQSB=0.67032;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,21,172:7:0 0,24,188:8:0 +X 1359 . T <*> 0 . DP=25;I16=9,15,0,0,857,31139,0,0,1378,80882,0,0,494,11144,0,0;QS=3,0;MQSB=0.67032;MQ0F=0 PL:DP:DV 0,27,232:9:0 0,21,184:7:0 0,24,196:8:0 +X 1360 . T <*> 0 . DP=25;I16=9,15,0,0,879,32419,0,0,1378,80882,0,0,497,11347,0,0;QS=3,0;MQSB=0.67032;MQ0F=0 PL:DP:DV 0,27,248:9:0 0,21,184:7:0 0,24,192:8:0 +X 1361 . T <*> 0 . DP=27;I16=9,17,0,0,936,34238,0,0,1498,88082,0,0,500,11576,0,0;QS=3,0;MQSB=0.657209;MQ0F=0 PL:DP:DV 0,27,234:9:0 0,24,201:8:0 0,27,206:9:0 +X 1362 . G <*> 0 . DP=26;I16=9,17,0,0,973,36785,0,0,1498,88082,0,0,502,11680,0,0;QS=3,0;MQSB=0.657209;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,24,202:8:0 0,27,207:9:0 +X 1363 . G <*> 0 . DP=25;I16=8,17,0,0,936,35390,0,0,1438,84482,0,0,504,11756,0,0;QS=3,0;MQSB=0.612391;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,21,181:7:0 0,27,202:9:0 +X 1364 . G <*> 0 . DP=25;I16=8,17,0,0,902,32840,0,0,1438,84482,0,0,504,11752,0,0;QS=3,0;MQSB=0.612391;MQ0F=0 PL:DP:DV 0,27,233:9:0 0,21,184:7:0 0,27,200:9:0 +X 1365 . G <*> 0 . DP=26;I16=9,17,0,0,946,35224,0,0,1498,88082,0,0,503,11717,0,0;QS=3,0;MQSB=0.657209;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,24,190:8:0 0,27,202:9:0 +X 1366 . G <*> 0 . DP=25;I16=8,15,0,0,840,31058,0,0,1318,77282,0,0,454,10450,0,0;QS=3,0;MQSB=0.625784;MQ0F=0 PL:DP:DV 0,21,215:7:0 0,21,181:7:0 0,27,199:9:0 +X 1367 . G C,<*> 0 . DP=25;I16=7,16,0,1,836,30888,27,729,1349,80041,60,3600,472,11152,15,225;QS=2.91641,0.0835913,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.864405;BQB=1;MQ0F=0 PL:DP:DV 0,24,236,24,236,236:8:0 0,21,179,21,179,179:7:0 0,0,171,24,174,189:9:1 +X 1368 . A <*> 0 . DP=26;I16=8,17,0,0,869,30839,0,0,1438,84482,0,0,481,11095,0,0;QS=3,0;MQSB=0.612391;MQ0F=0 PL:DP:DV 0,27,240:9:0 0,21,180:7:0 0,27,197:9:0 +X 1369 . T <*> 0 . DP=26;I16=8,18,0,0,902,32160,0,0,1498,88082,0,0,508,11758,0,0;QS=3,0;MQSB=0.606531;MQ0F=0 PL:DP:DV 0,27,242:9:0 0,24,197:8:0 0,27,194:9:0 +X 1370 . T <*> 0 . DP=27;I16=8,17,0,0,926,34736,0,0,1438,84482,0,0,458,10466,0,0;QS=3,0;MQSB=0.612391;MQ0F=0 PL:DP:DV 0,27,238:9:0 0,21,195:7:0 0,27,215:9:0 +X 1371 . C <*> 0 . DP=27;I16=8,19,0,0,929,33255,0,0,1558,91682,0,0,509,11695,0,0;QS=3,0;MQSB=0.601139;MQ0F=0 PL:DP:DV 0,27,241:9:0 0,24,196:8:0 0,30,196:10:0 +X 1372 . C <*> 0 . DP=27;I16=8,19,0,0,954,34882,0,0,1558,91682,0,0,510,11696,0,0;QS=3,0;MQSB=0.601139;MQ0F=0 PL:DP:DV 0,27,251:9:0 0,24,198:8:0 0,30,200:10:0 +X 1373 . C <*> 0 . DP=26;I16=8,17,0,0,892,32692,0,0,1438,84482,0,0,486,11044,0,0;QS=3,0;MQSB=0.612391;MQ0F=0 PL:DP:DV 0,24,243:8:0 0,21,186:7:0 0,30,195:10:0 +X 1374 . C <*> 0 . DP=26;I16=8,17,0,0,953,36553,0,0,1438,84482,0,0,487,11039,0,0;QS=3,0;MQSB=0.612391;MQ0F=0 PL:DP:DV 0,24,249:8:0 0,21,193:7:0 0,30,211:10:0 +X 1375 . T <*> 0 . DP=27;I16=9,18,0,0,1011,38377,0,0,1558,91682,0,0,512,11630,0,0;QS=3,0;MQSB=0.651439;MQ0F=0 PL:DP:DV 0,27,243:9:0 0,24,215:8:0 0,30,215:10:0 +X 1376 . A <*> 0 . DP=27;I16=9,17,0,0,912,32444,0,0,1498,88082,0,0,488,10992,0,0;QS=3,0;MQSB=0.657209;MQ0F=0 PL:DP:DV 0,27,234:9:0 0,21,198:7:0 0,30,195:10:0 +X 1377 . A <*> 0 . DP=26;I16=9,17,0,0,994,38518,0,0,1498,88082,0,0,515,11625,0,0;QS=3,0;MQSB=0.657209;MQ0F=0 PL:DP:DV 0,24,228:8:0 0,24,221:8:0 0,30,228:10:0 +X 1378 . G <*> 0 . DP=26;I16=9,17,0,0,910,33180,0,0,1498,88082,0,0,517,11653,0,0;QS=3,0;MQSB=0.657209;MQ0F=0 PL:DP:DV 0,24,234:8:0 0,24,199:8:0 0,30,197:10:0 +X 1379 . C <*> 0 . DP=26;I16=9,17,0,0,891,31779,0,0,1498,88082,0,0,519,11701,0,0;QS=3,0;MQSB=0.657209;MQ0F=0 PL:DP:DV 0,24,228:8:0 0,24,198:8:0 0,30,193:10:0 +X 1380 . C <*> 0 . DP=26;I16=9,17,0,0,925,33925,0,0,1498,88082,0,0,520,11720,0,0;QS=3,0;MQSB=0.657209;MQ0F=0 PL:DP:DV 0,24,226:8:0 0,24,202:8:0 0,30,209:10:0 +X 1381 . C <*> 0 . DP=28;I16=10,18,0,0,878,28560,0,0,1618,95282,0,0,521,11761,0,0;QS=3,0;MQSB=0.689069;MQ0F=0 PL:DP:DV 0,24,211:8:0 0,24,177:8:0 0,36,208:12:0 +X 1382 . G <*> 0 . DP=28;I16=8,18,0,0,905,32553,0,0,1529,90841,0,0,482,10912,0,0;QS=3,0;MQSB=0.882497;MQ0F=0 PL:DP:DV 0,24,213:8:0 0,18,152:6:0 0,36,243:12:0 +X 1383 . C <*> 0 . DP=27;I16=10,16,0,0,897,32373,0,0,1498,88082,0,0,502,11242,0,0;QS=3,0;MQSB=0.700784;MQ0F=0 PL:DP:DV 0,24,225:8:0 0,21,163:7:0 0,33,241:11:0 +X 1384 . C <*> 0 . DP=28;I16=11,17,0,0,980,35558,0,0,1618,95282,0,0,529,11885,0,0;QS=3,0;MQSB=0.726331;MQ0F=0 PL:DP:DV 0,27,248:9:0 0,24,184:8:0 0,33,239:11:0 +X 1385 . A <*> 0 . DP=30;I16=11,18,0,0,949,33215,0,0,1678,98882,0,0,508,11356,0,0;QS=3,0;MQSB=0.720887;MQ0F=0 PL:DP:DV 0,30,232:10:0 0,27,185:9:0 0,30,234:10:0 +X 1386 . C <*> 0 . DP=30;I16=11,19,0,0,1088,39938,0,0,1738,102482,0,0,537,12011,0,0;QS=3,0;MQSB=0.715831;MQ0F=0 PL:DP:DV 0,30,248:10:0 0,27,218:9:0 0,33,255:11:0 +X 1387 . C <*> 0 . DP=31;I16=12,19,0,0,1101,40297,0,0,1798,106082,0,0,540,12022,0,0;QS=3,0;MQSB=0.743137;MQ0F=0 PL:DP:DV 0,33,250:11:0 0,27,219:9:0 0,33,252:11:0 +X 1388 . C <*> 0 . DP=31;I16=11,19,0,0,999,34081,0,0,1769,105241,0,0,519,11439,0,0;QS=3,0;MQSB=0.91982;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,185:8:0 0,33,211:11:0 +X 1389 . G <*> 0 . DP=31;I16=11,19,0,0,1065,39119,0,0,1738,102482,0,0,535,11941,0,0;QS=3,0;MQSB=0.715831;MQ0F=0 PL:DP:DV 0,27,234:9:0 0,30,234:10:0 0,33,255:11:0 +X 1390 . G <*> 0 . DP=31;I16=12,19,0,0,1152,43744,0,0,1798,106082,0,0,555,12241,0,0;QS=3,0;MQSB=0.743137;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,30,245:10:0 0,33,255:11:0 +X 1391 . A <*> 0 . DP=31;I16=12,19,0,0,1241,50255,0,0,1798,106082,0,0,560,12326,0,0;QS=3,0;MQSB=0.743137;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,30,255:10:0 0,33,255:11:0 +X 1392 . G <*> 0 . DP=31;I16=12,19,0,0,1160,44364,0,0,1798,106082,0,0,564,12392,0,0;QS=3,0;MQSB=0.743137;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,30,250:10:0 0,33,255:11:0 +X 1393 . A <*> 0 . DP=31;I16=12,19,0,0,1123,41811,0,0,1798,106082,0,0,568,12490,0,0;QS=3,0;MQSB=0.743137;MQ0F=0 PL:DP:DV 0,30,228:10:0 0,30,255:10:0 0,33,255:11:0 +X 1394 . C <*> 0 . DP=31;I16=12,19,0,0,1139,42555,0,0,1798,106082,0,0,571,12569,0,0;QS=3,0;MQSB=0.743137;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,30,244:10:0 0,33,255:11:0 +X 1395 . A <*> 0 . DP=31;I16=12,19,0,0,1206,48048,0,0,1798,106082,0,0,575,12677,0,0;QS=3,0;MQSB=0.743137;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,240:9:0 0,33,255:11:0 +X 1396 . G <*> 0 . DP=31;I16=12,19,0,0,1196,46882,0,0,1798,106082,0,0,579,12763,0,0;QS=3,0;MQSB=0.743137;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,249:9:0 0,33,255:11:0 +X 1397 . C <*> 0 . DP=31;I16=12,18,0,0,993,33339,0,0,1738,102482,0,0,579,12775,0,0;QS=3,0;MQSB=0.748022;MQ0F=0 PL:DP:DV 0,30,231:10:0 0,27,205:9:0 0,33,217:11:0 +X 1398 . G <*> 0 . DP=30;I16=12,18,0,0,1055,38309,0,0,1738,102482,0,0,584,12826,0,0;QS=3,0;MQSB=0.748022;MQ0F=0 PL:DP:DV 0,33,250:11:0 0,27,229:9:0 0,30,244:10:0 +X 1399 . G <*> 0 . DP=30;I16=12,18,0,0,1132,43666,0,0,1738,102482,0,0,586,12854,0,0;QS=3,0;MQSB=0.748022;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,239:9:0 0,30,255:10:0 +X 1400 . A <*> 0 . DP=30;I16=11,18,0,0,1101,42271,0,0,1678,98882,0,0,563,12289,0,0;QS=3,0;MQSB=0.720887;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,27,239:9:0 0,30,246:10:0 +X 1401 . T <*> 0 . DP=30;I16=12,18,0,0,1130,44170,0,0,1738,102482,0,0,589,12955,0,0;QS=3,0;MQSB=0.748022;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,251:9:0 0,30,255:10:0 +X 1402 . T <*> 0 . DP=31;I16=13,18,0,0,1152,44058,0,0,1798,106082,0,0,589,12977,0,0;QS=3,0;MQSB=0.771348;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,244:9:0 0,30,255:10:0 +X 1403 . T <*> 0 . DP=31;I16=13,18,0,0,1178,45296,0,0,1798,106082,0,0,590,13032,0,0;QS=3,0;MQSB=0.771348;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,249:9:0 0,30,255:10:0 +X 1404 . C <*> 0 . DP=31;I16=13,18,0,0,1102,40838,0,0,1798,106082,0,0,591,13121,0,0;QS=3,0;MQSB=0.771348;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,236:9:0 0,30,244:10:0 +X 1405 . C <*> 0 . DP=30;I16=12,18,0,0,1154,45216,0,0,1738,102482,0,0,593,13243,0,0;QS=3,0;MQSB=0.748022;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,241:9:0 0,27,229:9:0 +X 1406 . T <*> 0 . DP=30;I16=12,18,0,0,1153,44919,0,0,1738,102482,0,0,595,13397,0,0;QS=3,0;MQSB=0.748022;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,248:9:0 0,27,223:9:0 +X 1407 . T <*> 0 . DP=30;I16=11,18,0,0,1074,40182,0,0,1678,98882,0,0,570,12856,0,0;QS=3,0;MQSB=0.720887;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,231:9:0 0,27,215:9:0 +X 1408 . A <*> 0 . DP=30;I16=12,18,0,0,1131,43363,0,0,1738,102482,0,0,596,13592,0,0;QS=3,0;MQSB=0.748022;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,30,244:10:0 0,27,234:9:0 +X 1409 . G <*> 0 . DP=29;I16=12,17,0,0,1082,40752,0,0,1678,98882,0,0,599,13729,0,0;QS=3,0;MQSB=0.753269;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,237:9:0 0,27,204:9:0 +X 1410 . T <*> 0 . DP=29;I16=12,17,0,0,1084,41030,0,0,1678,98882,0,0,601,13841,0,0;QS=3,0;MQSB=0.753269;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,239:9:0 0,27,218:9:0 +X 1411 . T <*> 0 . DP=29;I16=12,17,0,0,958,32550,0,0,1678,98882,0,0,600,13826,0,0;QS=3,0;MQSB=0.753269;MQ0F=0 PL:DP:DV 0,33,250:11:0 0,27,206:9:0 0,27,194:9:0 +X 1412 . A T,<*> 0 . DP=29;I16=11,17,1,0,924,31586,25,625,1649,98041,29,841,573,13159,24,576;QS=2.90842,0.0915751,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.753269;BQB=1;MQ0F=0 PL:DP:DV 0,33,245,33,245,245:11:0 0,2,171,24,174,187:9:1 0,27,192,27,192,192:9:0 +X 1413 . C <*> 0 . DP=29;I16=12,17,0,0,1067,39941,0,0,1678,98882,0,0,591,13521,0,0;QS=3,0;MQSB=0.753269;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,230:9:0 0,27,209:9:0 +X 1414 . T <*> 0 . DP=29;I16=12,17,0,0,1123,44271,0,0,1678,98882,0,0,585,13335,0,0;QS=3,0;MQSB=0.753269;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,236:9:0 0,27,221:9:0 +X 1415 . T <*> 0 . DP=29;I16=12,17,0,0,1000,35254,0,0,1678,98882,0,0,577,13077,0,0;QS=3,0;MQSB=0.753269;MQ0F=0 PL:DP:DV 0,33,246:11:0 0,27,216:9:0 0,27,208:9:0 +X 1416 . A <*> 0 . DP=30;I16=13,17,0,0,1026,36124,0,0,1738,102482,0,0,569,12847,0,0;QS=3,0;MQSB=0.776389;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,208:9:0 0,27,199:9:0 +X 1417 . C <*> 0 . DP=29;I16=13,16,0,0,1111,42941,0,0,1678,98882,0,0,563,12645,0,0;QS=3,0;MQSB=0.781802;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,235:9:0 0,24,211:8:0 +X 1418 . T <*> 0 . DP=29;I16=13,16,0,0,1111,43021,0,0,1678,98882,0,0,557,12471,0,0;QS=3,0;MQSB=0.781802;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,231:9:0 0,24,207:8:0 +X 1419 . A <*> 0 . DP=29;I16=13,16,0,0,1039,38191,0,0,1678,98882,0,0,551,12325,0,0;QS=3,0;MQSB=0.781802;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,222:9:0 0,24,199:8:0 +X 1420 . T <*> 0 . DP=29;I16=13,16,0,0,1039,37885,0,0,1678,98882,0,0,544,12158,0,0;QS=3,0;MQSB=0.781802;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,234:9:0 0,24,185:8:0 +X 1421 . G <*> 0 . DP=31;I16=13,18,0,0,1129,41649,0,0,1798,106082,0,0,536,11970,0,0;QS=3,0;MQSB=0.771348;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,30,247:10:0 0,24,191:8:0 +X 1422 . C <*> 0 . DP=29;I16=13,16,0,0,1075,40645,0,0,1678,98882,0,0,532,11810,0,0;QS=3,0;MQSB=0.781802;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,30,239:10:0 0,18,180:6:0 +X 1423 . T <*> 0 . DP=31;I16=14,17,0,0,1179,45767,0,0,1798,106082,0,0,528,11678,0,0;QS=3,0;MQSB=0.79638;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,36,255:12:0 0,18,183:6:0 +X 1424 . C <*> 0 . DP=30;I16=13,17,0,0,1086,40448,0,0,1738,102482,0,0,527,11575,0,0;QS=3,0;MQSB=0.776389;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,36,255:12:0 0,18,174:6:0 +X 1425 . C <*> 0 . DP=30;I16=13,17,0,0,1124,42974,0,0,1738,102482,0,0,525,11453,0,0;QS=3,0;MQSB=0.776389;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,36,255:12:0 0,18,180:6:0 +X 1426 . T <*> 0 . DP=32;I16=15,17,0,0,1218,47130,0,0,1858,109682,0,0,523,11363,0,0;QS=3,0;MQSB=0.813784;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,36,255:12:0 0,18,188:6:0 +X 1427 . T <*> 0 . DP=32;I16=14,18,0,0,1126,40772,0,0,1827,106923,0,0,524,11306,0,0;QS=3,0;MQSB=0.916401;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,36,255:12:0 0,18,176:6:0 +X 1428 . G <*> 0 . DP=33;I16=15,18,0,0,1188,43596,0,0,1887,110523,0,0,525,11233,0,0;QS=3,0;MQSB=0.930476;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,36,255:12:0 0,18,166:6:0 +X 1429 . G <*> 0 . DP=33;I16=14,18,0,0,1070,37720,0,0,1858,109682,0,0,507,10795,0,0;QS=3,0;MQSB=0.997118;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,33,243:11:0 0,18,148:6:0 +X 1430 . C <*> 0 . DP=33;I16=15,18,0,0,1145,40795,0,0,1887,110523,0,0,529,11193,0,0;QS=3,0;MQSB=0.930476;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,36,247:12:0 0,18,157:6:0 +X 1431 . C <*> 0 . DP=33;I16=15,18,0,0,1160,41686,0,0,1887,110523,0,0,531,11227,0,0;QS=3,0;MQSB=0.930476;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,36,253:12:0 0,18,167:6:0 +X 1432 . A <*> 0 . DP=33;I16=15,18,0,0,1118,39032,0,0,1887,110523,0,0,533,11297,0,0;QS=3,0;MQSB=0.930476;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,36,255:12:0 0,18,169:6:0 +X 1433 . T <*> 0 . DP=34;I16=15,19,0,0,1238,45602,0,0,1947,114123,0,0,535,11403,0,0;QS=3,0;MQSB=0.923533;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,36,255:12:0 0,18,174:6:0 +X 1434 . T <*> 0 . DP=35;I16=15,20,0,0,1269,46757,0,0,2007,117723,0,0,537,11495,0,0;QS=3,0;MQSB=0.916855;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,36,255:12:0 0,18,179:6:0 +X 1435 . T <*> 0 . DP=35;I16=14,20,0,0,1256,46868,0,0,1947,114123,0,0,515,10999,0,0;QS=3,0;MQSB=0.901704;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,36,255:12:0 0,18,180:6:0 +X 1436 . C <*> 0 . DP=34;I16=14,20,0,0,1250,46978,0,0,1947,114123,0,0,544,11790,0,0;QS=3,0;MQSB=0.901704;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,36,255:12:0 0,18,165:6:0 +X 1437 . T <*> 0 . DP=32;I16=13,19,0,0,1222,47206,0,0,1858,109682,0,0,548,11892,0,0;QS=3,0;MQSB=0.993397;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,33,255:11:0 0,15,161:5:0 +X 1438 . C <*> 0 . DP=30;I16=13,17,0,0,1132,43284,0,0,1738,102482,0,0,554,12028,0,0;QS=3,0;MQSB=0.996503;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,30,251:10:0 0,15,159:5:0 +X 1439 . T <*> 0 . DP=30;I16=13,17,0,0,1110,41602,0,0,1738,102482,0,0,560,12196,0,0;QS=3,0;MQSB=0.996503;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,30,255:10:0 0,15,156:5:0 +X 1440 . A <*> 0 . DP=30;I16=12,16,0,0,1062,41028,0,0,1618,95282,0,0,550,12106,0,0;QS=3,0;MQSB=0.995699;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,27,255:9:0 0,12,144:4:0 +X 1441 . G <*> 0 . DP=30;I16=13,17,0,0,1138,44104,0,0,1738,102482,0,0,574,12576,0,0;QS=3,0;MQSB=0.996503;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,30,244:10:0 0,12,137:4:0 +X 1442 . G <*> 0 . DP=30;I16=13,17,0,0,1064,38534,0,0,1738,102482,0,0,580,12740,0,0;QS=3,0;MQSB=0.996503;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,30,242:10:0 0,12,128:4:0 +X 1443 . T <*> 0 . DP=30;I16=12,17,0,0,1013,36225,0,0,1678,98882,0,0,568,12598,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,30,230:10:0 0,12,133:4:0 +X 1444 . A <*> 0 . DP=30;I16=12,17,0,0,968,33936,0,0,1678,98882,0,0,569,12627,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,27,205:9:0 0,12,132:4:0 +X 1445 . T <*> 0 . DP=30;I16=14,15,0,0,1053,39129,0,0,1678,98882,0,0,585,13161,0,0;QS=3,0;MQSB=0.999762;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,27,237:9:0 0,15,169:5:0 +X 1446 . T <*> 0 . DP=30;I16=13,16,0,0,1051,38675,0,0,1678,98882,0,0,579,12951,0,0;QS=3,0;MQSB=0.997839;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,229:8:0 0,15,164:5:0 +X 1447 . G <*> 0 . DP=30;I16=14,16,0,0,1110,42692,0,0,1738,102482,0,0,606,13612,0,0;QS=3,0;MQSB=0.999136;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,27,229:9:0 0,15,157:5:0 +X 1448 . G <*> 0 . DP=30;I16=13,16,0,0,1037,37759,0,0,1678,98882,0,0,585,13151,0,0;QS=3,0;MQSB=0.997839;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,217:8:0 0,15,150:5:0 +X 1449 . T <*> 0 . DP=30;I16=14,16,0,0,1051,37869,0,0,1738,102482,0,0,612,13870,0,0;QS=3,0;MQSB=0.999136;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,27,230:9:0 0,15,152:5:0 +X 1450 . A <*> 0 . DP=29;I16=13,15,0,0,1039,38785,0,0,1649,98041,0,0,604,13842,0,0;QS=3,0;MQSB=0.956162;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,24,224:8:0 0,15,165:5:0 +X 1451 . T <*> 0 . DP=29;I16=13,16,0,0,1046,38586,0,0,1709,101641,0,0,616,14042,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,228:8:0 0,15,158:5:0 +X 1452 . A <*> 0 . DP=31;I16=14,16,0,0,1066,38696,0,0,1769,105241,0,0,604,13924,0,0;QS=3,0;MQSB=0.958545;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,218:8:0 0,15,147:5:0 +X 1453 . T <*> 0 . DP=31;I16=13,17,0,0,1107,42059,0,0,1769,105241,0,0,592,13444,0,0;QS=3,0;MQSB=0.963674;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,199:7:0 0,15,165:5:0 +X 1454 . T <*> 0 . DP=31;I16=14,17,0,0,1139,42711,0,0,1829,108841,0,0,617,14045,0,0;QS=3,0;MQSB=0.962133;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,24,234:8:0 0,15,166:5:0 +X 1455 . G <*> 0 . DP=31;I16=13,17,0,0,1107,41765,0,0,1769,105241,0,0,592,13420,0,0;QS=3,0;MQSB=0.963674;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,197:7:0 0,15,148:5:0 +X 1456 . T <*> 0 . DP=31;I16=14,17,0,0,1139,42717,0,0,1829,108841,0,0,617,14069,0,0;QS=3,0;MQSB=0.962133;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,24,215:8:0 0,15,170:5:0 +X 1457 . G <*> 0 . DP=31;I16=14,17,0,0,1129,42071,0,0,1829,108841,0,0,615,14019,0,0;QS=3,0;MQSB=0.962133;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,24,212:8:0 0,15,164:5:0 +X 1458 . T <*> 0 . DP=31;I16=14,17,0,0,1101,40243,0,0,1829,108841,0,0,613,13997,0,0;QS=3,0;MQSB=0.962133;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,24,220:8:0 0,15,165:5:0 +X 1459 . C A,<*> 0 . DP=31;I16=14,16,0,1,1164,45842,24,576,1769,105241,60,3600,608,13948,2,4;QS=2.87234,0.12766,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.962133;BQB=1;MQ0F=0 PL:DP:DV 0,54,255,54,255,255:18:0 0,24,224,24,224,224:8:0 9,0,135,21,138,152:5:1 +X 1460 . T <*> 0 . DP=32;I16=15,17,0,0,1243,48813,0,0,1889,112441,0,0,605,13833,0,0;QS=3,0;MQSB=0.960687;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,24,240:8:0 0,15,170:5:0 +X 1461 . G <*> 0 . DP=32;I16=15,17,0,0,1171,44033,0,0,1889,112441,0,0,600,13692,0,0;QS=3,0;MQSB=0.960687;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,24,224:8:0 0,15,157:5:0 +X 1462 . C <*> 0 . DP=30;I16=14,15,0,0,1102,42216,0,0,1709,101641,0,0,579,13241,0,0;QS=3,0;MQSB=0.954405;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,202:7:0 0,9,112:3:0 +X 1463 . T <*> 0 . DP=30;I16=15,15,0,0,1128,43348,0,0,1769,105241,0,0,592,13396,0,0;QS=3,0;MQSB=0.952765;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,209:7:0 0,12,139:4:0 +X 1464 . G <*> 0 . DP=31;I16=14,16,0,0,1095,40557,0,0,1769,105241,0,0,563,12665,0,0;QS=3,0;MQSB=0.958545;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,186:6:0 0,15,144:5:0 +X 1465 . T <*> 0 . DP=31;I16=15,16,0,0,1143,42557,0,0,1829,108841,0,0,584,13164,0,0;QS=3,0;MQSB=0.957006;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,204:7:0 0,15,166:5:0 +X 1466 . G <*> 0 . DP=31;I16=15,16,0,0,1122,42294,0,0,1829,108841,0,0,580,13018,0,0;QS=3,0;MQSB=0.957006;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,206:7:0 0,15,163:5:0 +X 1467 . A <*> 0 . DP=31;I16=14,16,0,0,1031,36341,0,0,1769,105241,0,0,569,12803,0,0;QS=3,0;MQSB=0.958545;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,195:7:0 0,15,155:5:0 +X 1468 . A <*> 0 . DP=30;I16=15,15,0,0,991,34477,0,0,1769,105241,0,0,573,12717,0,0;QS=3,0;MQSB=0.952765;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,177:7:0 0,15,158:5:0 +X 1469 . C T,<*> 0 . DP=31;I16=13,15,1,0,1013,37887,38,1444,1649,98041,60,3600,536,12106,9,81;QS=2.94025,0.0597484,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.954405;BQB=1;MQ0F=0 PL:DP:DV 0,16,255,51,255,255:18:1 0,18,178,18,178,178:6:0 0,15,160,15,160,160:5:0 +X 1470 . T <*> 0 . DP=31;I16=16,15,0,0,1110,41070,0,0,1829,108841,0,0,567,12489,0,0;QS=3,0;MQSB=0.951229;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,210:7:0 0,15,165:5:0 +X 1471 . G <*> 0 . DP=30;I16=16,14,0,0,1051,38425,0,0,1769,105241,0,0,564,12348,0,0;QS=3,0;MQSB=0.946202;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,192:7:0 0,12,128:4:0 +X 1472 . T <*> 0 . DP=30;I16=16,14,0,0,1049,38097,0,0,1769,105241,0,0,561,12237,0,0;QS=3,0;MQSB=0.946202;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,200:7:0 0,12,134:4:0 +X 1473 . C <*> 0 . DP=30;I16=16,14,0,0,1058,38526,0,0,1769,105241,0,0,558,12156,0,0;QS=3,0;MQSB=0.946202;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,175:7:0 0,12,140:4:0 +X 1474 . C <*> 0 . DP=30;I16=16,14,0,0,1120,42756,0,0,1769,105241,0,0,555,12105,0,0;QS=3,0;MQSB=0.946202;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,202:7:0 0,12,141:4:0 +X 1475 . T <*> 0 . DP=29;I16=14,14,0,0,1047,40395,0,0,1649,98041,0,0,537,11827,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,208:7:0 0,12,155:4:0 +X 1476 . T G,<*> 0 . DP=31;I16=15,15,1,0,1056,37884,14,196,1769,105241,60,3600,566,12614,10,100;QS=2.944,0.056,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.951229;BQB=1;MQ0F=0 PL:DP:DV 0,57,255,57,255,255:19:0 0,9,177,21,180,183:8:1 0,12,140,12,140,140:4:0 +X 1477 . G <*> 0 . DP=31;I16=16,15,0,0,1150,43390,0,0,1829,108841,0,0,574,12700,0,0;QS=3,0;MQSB=0.951229;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,24,217:8:0 0,12,138:4:0 +X 1478 . G <*> 0 . DP=31;I16=14,15,0,0,1008,36638,0,0,1709,101641,0,0,542,11982,0,0;QS=3,0;MQSB=0.954405;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,24,208:8:0 0,9,109:3:0 +X 1479 . C <*> 0 . DP=30;I16=15,15,0,0,1061,38671,0,0,1769,105241,0,0,564,12556,0,0;QS=3,0;MQSB=0.952765;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,24,211:8:0 0,9,106:3:0 +X 1480 . C <*> 0 . DP=30;I16=15,15,0,0,1083,40355,0,0,1769,105241,0,0,561,12531,0,0;QS=3,0;MQSB=0.952765;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,24,220:8:0 0,9,103:3:0 +X 1481 . T <*> 0 . DP=30;I16=15,15,0,0,1102,41308,0,0,1769,105241,0,0,558,12532,0,0;QS=3,0;MQSB=0.952765;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,24,235:8:0 0,9,105:3:0 +X 1482 . G <*> 0 . DP=29;I16=15,14,0,0,1044,38550,0,0,1709,101641,0,0,556,12558,0,0;QS=3,0;MQSB=0.947838;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,24,210:8:0 0,6,75:2:0 +X 1483 . T <*> 0 . DP=31;I16=14,16,0,0,1042,37190,0,0,1769,105241,0,0,521,11919,0,0;QS=3,0;MQSB=0.958545;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,21,215:7:0 0,9,100:3:0 +X 1484 . T <*> 0 . DP=31;I16=15,16,0,0,1067,37837,0,0,1829,108841,0,0,547,12587,0,0;QS=3,0;MQSB=0.957006;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,24,216:8:0 0,9,106:3:0 +X 1485 . T <*> 0 . DP=30;I16=15,15,0,0,1027,35863,0,0,1769,105241,0,0,549,12659,0,0;QS=3,0;MQSB=0.952765;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,24,209:8:0 0,9,93:3:0 +X 1486 . G <*> 0 . DP=29;I16=15,14,0,0,1089,41679,0,0,1709,101641,0,0,551,12707,0,0;QS=3,0;MQSB=0.947838;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,198:7:0 0,9,108:3:0 +X 1487 . G <*> 0 . DP=28;I16=14,14,0,0,973,34723,0,0,1649,98041,0,0,554,12778,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,196:7:0 0,9,97:3:0 +X 1488 . T <*> 0 . DP=28;I16=13,14,0,0,928,32432,0,0,1589,94441,0,0,532,12246,0,0;QS=3,0;MQSB=0.951472;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,176:6:0 0,9,102:3:0 +X 1489 . G <*> 0 . DP=27;I16=13,14,0,0,958,35292,0,0,1589,94441,0,0,535,12361,0,0;QS=3,0;MQSB=0.951472;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,174:6:0 0,9,93:3:0 +X 1490 . A <*> 0 . DP=27;I16=13,14,0,0,928,33108,0,0,1589,94441,0,0,538,12446,0,0;QS=3,0;MQSB=0.951472;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,160:5:0 0,9,94:3:0 +X 1491 . C <*> 0 . DP=27;I16=12,13,0,0,798,26812,0,0,1469,87241,0,0,499,11587,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,12,108:4:0 0,9,79:3:0 +X 1492 . G <*> 0 . DP=27;I16=13,14,0,0,893,30927,0,0,1589,94441,0,0,543,12527,0,0;QS=3,0;MQSB=0.951472;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,136:5:0 0,9,100:3:0 +X 1493 . G <*> 0 . DP=27;I16=13,13,0,0,907,32761,0,0,1529,90841,0,0,520,11948,0,0;QS=3,0;MQSB=0.945959;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,155:5:0 0,9,106:3:0 +X 1494 . G <*> 0 . DP=27;I16=13,14,0,0,939,33599,0,0,1589,94441,0,0,547,12639,0,0;QS=3,0;MQSB=0.951472;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,156:5:0 0,9,107:3:0 +X 1495 . T <*> 0 . DP=26;I16=12,13,0,0,814,27700,0,0,1469,87241,0,0,524,12048,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,143:5:0 0,9,105:3:0 +X 1496 . G <*> 0 . DP=26;I16=13,13,0,0,969,36751,0,0,1529,90841,0,0,550,12674,0,0;QS=3,0;MQSB=0.945959;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,157:5:0 0,9,107:3:0 +X 1497 . A <*> 0 . DP=27;I16=12,14,0,0,904,32740,0,0,1529,90841,0,0,525,12019,0,0;QS=3,0;MQSB=0.953497;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,166:5:0 0,9,113:3:0 +X 1498 . G <*> 0 . DP=27;I16=13,14,0,0,1002,37852,0,0,1589,94441,0,0,551,12635,0,0;QS=3,0;MQSB=0.951472;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,153:5:0 0,9,112:3:0 +X 1499 . G <*> 0 . DP=28;I16=14,14,0,0,973,34891,0,0,1649,98041,0,0,551,12599,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,15,146:5:0 0,9,108:3:0 +X 1500 . A <*> 0 . DP=28;I16=14,14,0,0,1023,38115,0,0,1649,98041,0,0,552,12588,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,15,165:5:0 0,9,115:3:0 +X 1501 . G <*> 0 . DP=28;I16=14,14,0,0,1051,40105,0,0,1649,98041,0,0,551,12505,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,15,163:5:0 0,9,100:3:0 +X 1502 . C <*> 0 . DP=27;I16=13,14,0,0,963,35241,0,0,1589,94441,0,0,549,12351,0,0;QS=3,0;MQSB=0.951472;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,140:5:0 0,9,105:3:0 +X 1503 . A <*> 0 . DP=28;I16=14,14,0,0,1026,38252,0,0,1649,98041,0,0,546,12176,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,15,171:5:0 0,9,109:3:0 +X 1504 . G <*> 0 . DP=28;I16=13,14,0,0,1052,41226,0,0,1589,94441,0,0,523,11591,0,0;QS=3,0;MQSB=0.951472;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,163:5:0 0,9,111:3:0 +X 1505 . G <*> 0 . DP=28;I16=14,13,0,0,959,35545,0,0,1589,94441,0,0,517,11295,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,155:5:0 0,9,114:3:0 +X 1506 . G <*> 0 . DP=28;I16=14,14,0,0,1013,37355,0,0,1649,98041,0,0,540,11840,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,15,139:5:0 0,9,112:3:0 +X 1507 . A <*> 0 . DP=28;I16=14,14,0,0,987,35217,0,0,1649,98041,0,0,538,11792,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,15,162:5:0 0,9,114:3:0 +X 1508 . C <*> 0 . DP=28;I16=14,14,0,0,1033,38663,0,0,1649,98041,0,0,535,11727,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,15,137:5:0 0,9,112:3:0 +X 1509 . A <*> 0 . DP=28;I16=15,13,0,0,1028,38610,0,0,1649,98041,0,0,529,11493,0,0;QS=3,0;MQSB=0.942064;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,12,128:4:0 0,9,122:3:0 +X 1510 . G <*> 0 . DP=28;I16=15,13,0,0,1064,40824,0,0,1649,98041,0,0,524,11288,0,0;QS=3,0;MQSB=0.942064;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,12,132:4:0 0,9,111:3:0 +X 1511 . A <*> 0 . DP=28;I16=15,13,0,0,976,34794,0,0,1649,98041,0,0,519,11113,0,0;QS=3,0;MQSB=0.942064;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,12,136:4:0 0,9,110:3:0 +X 1512 . A <*> 0 . DP=28;I16=15,12,0,0,998,37460,0,0,1589,94441,0,0,489,10343,0,0;QS=3,0;MQSB=0.935229;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,12,142:4:0 0,9,110:3:0 +X 1513 . G <*> 0 . DP=28;I16=14,13,0,0,1014,38940,0,0,1589,94441,0,0,497,10709,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,12,134:4:0 0,9,108:3:0 +X 1514 . G <*> 0 . DP=28;I16=15,13,0,0,1054,39954,0,0,1649,98041,0,0,504,10768,0,0;QS=3,0;MQSB=0.942064;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,12,134:4:0 0,9,108:3:0 +X 1515 . G <*> 0 . DP=28;I16=14,13,0,0,948,34152,0,0,1589,94441,0,0,488,10564,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,12,133:4:0 0,9,101:3:0 +X 1516 . T <*> 0 . DP=27;I16=12,13,0,0,811,27385,0,0,1469,87241,0,0,472,10338,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,12,117:4:0 0,9,106:3:0 +X 1517 . C <*> 0 . DP=27;I16=13,13,0,0,943,35153,0,0,1529,90841,0,0,478,10380,0,0;QS=3,0;MQSB=0.945959;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,12,134:4:0 0,9,97:3:0 +X 1518 . C <*> 0 . DP=28;I16=13,12,0,0,908,33852,0,0,1469,87241,0,0,427,9261,0,0;QS=3,0;MQSB=0.939413;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,12,132:4:0 0,9,96:3:0 +X 1519 . T <*> 0 . DP=28;I16=15,13,0,0,988,35808,0,0,1649,98041,0,0,475,10337,0,0;QS=3,0;MQSB=0.942064;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,15,154:5:0 0,9,110:3:0 +X 1520 . G <*> 0 . DP=29;I16=16,13,0,0,1005,36307,0,0,1709,101641,0,0,470,10328,0,0;QS=3,0;MQSB=0.940317;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,18,150:6:0 0,9,104:3:0 +X 1521 . C <*> 0 . DP=28;I16=16,12,0,0,900,30324,0,0,1649,98041,0,0,466,10300,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,164:6:0 0,9,88:3:0 +X 1522 . G <*> 0 . DP=27;I16=15,10,0,0,784,25144,0,0,1469,87241,0,0,442,9956,0,0;QS=3,0;MQSB=0.9171;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,110:5:0 0,9,91:3:0 +X 1523 . T <*> 0 . DP=27;I16=16,11,0,0,921,32001,0,0,1589,94441,0,0,457,10189,0,0;QS=3,0;MQSB=0.925036;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,136:5:0 0,9,108:3:0 +X 1524 . G <*> 0 . DP=27;I16=16,10,0,0,932,34140,0,0,1529,90841,0,0,453,10153,0,0;QS=3,0;MQSB=0.914947;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,12,108:4:0 0,9,103:3:0 +X 1525 . C <*> 0 . DP=27;I16=16,11,0,0,972,35704,0,0,1589,94441,0,0,473,10719,0,0;QS=3,0;MQSB=0.925036;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,12,113:4:0 0,9,112:3:0 +X 1526 . C <*> 0 . DP=25;I16=14,11,0,0,883,31843,0,0,1469,87241,0,0,470,10684,0,0;QS=3,0;MQSB=0.929204;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,12,109:4:0 0,9,106:3:0 +X 1527 . C <*> 0 . DP=24;I16=14,10,0,0,867,31999,0,0,1440,86400,0,0,466,10572,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,107:4:0 0,9,112:3:0 +X 1528 . T <*> 0 . DP=23;I16=13,10,0,0,869,33133,0,0,1380,82800,0,0,463,10483,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,114:4:0 0,9,113:3:0 +X 1529 . G <*> 0 . DP=23;I16=13,10,0,0,812,29432,0,0,1380,82800,0,0,459,10365,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,108:4:0 0,9,104:3:0 +X 1530 . C <*> 0 . DP=24;I16=13,10,0,0,819,30073,0,0,1380,82800,0,0,446,10186,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,137:5:0 0,9,106:3:0 +X 1531 . C <*> 0 . DP=24;I16=13,11,0,0,877,32969,0,0,1440,86400,0,0,452,10190,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,144:5:0 0,9,105:3:0 +X 1532 . T <*> 0 . DP=24;I16=13,11,0,0,887,33721,0,0,1440,86400,0,0,449,10135,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,165:5:0 0,9,120:3:0 +X 1533 . T <*> 0 . DP=23;I16=13,10,0,0,793,27987,0,0,1380,82800,0,0,447,10101,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,146:5:0 0,9,107:3:0 +X 1534 . C <*> 0 . DP=23;I16=14,9,0,0,847,31627,0,0,1380,82800,0,0,446,10086,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,153:5:0 0,9,109:3:0 +X 1535 . A <*> 0 . DP=23;I16=14,9,0,0,770,26604,0,0,1380,82800,0,0,444,9990,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,144:5:0 0,9,99:3:0 +X 1536 . C <*> 0 . DP=24;I16=15,9,0,0,826,28984,0,0,1440,86400,0,0,442,9914,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,138:5:0 0,9,110:3:0 +X 1537 . A <*> 0 . DP=24;I16=14,9,0,0,844,31384,0,0,1380,82800,0,0,416,9234,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,149:5:0 0,9,115:3:0 +X 1538 . A <*> 0 . DP=24;I16=15,9,0,0,909,34727,0,0,1440,86400,0,0,440,9826,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,154:5:0 0,9,112:3:0 +X 1539 . G <*> 0 . DP=24;I16=15,9,0,0,913,35327,0,0,1440,86400,0,0,439,9815,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,149:5:0 0,9,117:3:0 +X 1540 . C <*> 0 . DP=23;I16=15,8,0,0,828,30260,0,0,1380,82800,0,0,438,9776,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,146:5:0 0,9,102:3:0 +X 1541 . C <*> 0 . DP=23;I16=15,8,0,0,823,30615,0,0,1380,82800,0,0,437,9759,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,142:5:0 0,9,108:3:0 +X 1542 . C <*> 0 . DP=25;I16=16,8,0,0,893,33843,0,0,1440,86400,0,0,435,9715,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,147:5:0 0,12,131:4:0 +X 1543 . C <*> 0 . DP=25;I16=16,8,0,0,880,33206,0,0,1440,86400,0,0,434,9696,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,141:5:0 0,12,136:4:0 +X 1544 . T <*> 0 . DP=25;I16=16,8,0,0,899,34405,0,0,1440,86400,0,0,431,9603,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,150:5:0 0,12,148:4:0 +X 1545 . G <*> 0 . DP=25;I16=16,8,0,0,874,32636,0,0,1440,86400,0,0,428,9536,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,146:5:0 0,12,129:4:0 +X 1546 . G <*> 0 . DP=24;I16=15,8,0,0,796,28796,0,0,1380,82800,0,0,425,9443,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,130:5:0 0,9,110:3:0 +X 1547 . A <*> 0 . DP=23;I16=15,8,0,0,837,30945,0,0,1380,82800,0,0,448,9996,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,176:6:0 0,9,112:3:0 +X 1548 . A <*> 0 . DP=23;I16=14,8,0,0,812,30830,0,0,1320,79200,0,0,421,9319,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,173:5:0 0,9,115:3:0 +X 1549 . G <*> 0 . DP=23;I16=15,8,0,0,870,33642,0,0,1380,82800,0,0,444,9912,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,174:6:0 0,9,114:3:0 +X 1550 . G <*> 0 . DP=23;I16=15,8,0,0,790,28502,0,0,1380,82800,0,0,442,9900,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,154:6:0 0,9,109:3:0 +X 1551 . A <*> 0 . DP=23;I16=15,8,0,0,802,28596,0,0,1380,82800,0,0,440,9908,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,173:6:0 0,9,107:3:0 +X 1552 . A <*> 0 . DP=21;I16=14,7,0,0,792,30156,0,0,1260,75600,0,0,438,9836,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,196:6:0 0,9,110:3:0 +X 1553 . A <*> 0 . DP=21;I16=13,7,0,0,738,28112,0,0,1200,72000,0,0,411,9159,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,251:11:0 0,18,192:6:0 0,9,115:3:0 +X 1554 . G <*> 0 . DP=21;I16=14,7,0,0,763,28221,0,0,1260,75600,0,0,434,9752,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,171:6:0 0,9,101:3:0 +X 1555 . T <*> 0 . DP=21;I16=14,7,0,0,726,26234,0,0,1260,75600,0,0,432,9740,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,252:12:0 0,18,169:6:0 0,9,108:3:0 +X 1556 . T <*> 0 . DP=21;I16=14,7,0,0,745,26971,0,0,1260,75600,0,0,429,9697,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,253:12:0 0,18,177:6:0 0,9,110:3:0 +X 1557 . G <*> 0 . DP=22;I16=15,7,0,0,801,29689,0,0,1320,79200,0,0,426,9672,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,166:6:0 0,9,101:3:0 +X 1558 . T <*> 0 . DP=22;I16=15,6,0,0,720,25620,0,0,1260,75600,0,0,404,9244,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,131:5:0 0,9,112:3:0 +X 1559 . T <*> 0 . DP=22;I16=15,7,0,0,712,24690,0,0,1320,79200,0,0,417,9439,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,248:13:0 0,18,158:6:0 0,9,103:3:0 +X 1560 . T <*> 0 . DP=21;I16=14,7,0,0,736,26560,0,0,1260,75600,0,0,412,9284,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,251:12:0 0,18,170:6:0 0,9,112:3:0 +X 1561 . T <*> 0 . DP=21;I16=14,7,0,0,706,24776,0,0,1260,75600,0,0,406,9102,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,241:12:0 0,18,174:6:0 0,9,106:3:0 +X 1562 . G <*> 0 . DP=21;I16=14,7,0,0,765,28655,0,0,1260,75600,0,0,399,8893,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,181:6:0 0,9,108:3:0 +X 1563 . G <*> 0 . DP=22;I16=13,7,0,0,713,26255,0,0,1200,72000,0,0,360,8176,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,147:5:0 0,9,108:3:0 +X 1564 . G <*> 0 . DP=22;I16=13,8,0,0,721,25457,0,0,1260,75600,0,0,368,8218,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,173:6:0 0,9,95:3:0 +X 1565 . A <*> 0 . DP=21;I16=14,7,0,0,724,25888,0,0,1260,75600,0,0,380,8352,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,162:6:0 0,6,71:2:0 +X 1566 . T <*> 0 . DP=21;I16=13,7,0,0,698,25286,0,0,1200,72000,0,0,364,8086,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,143:5:0 0,6,78:2:0 +X 1567 . C <*> 0 . DP=20;I16=12,6,0,0,652,24422,0,0,1080,64800,0,0,351,7881,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,104:3:0 0,6,72:2:0 +X 1568 . T <*> 0 . DP=20;I16=13,7,0,0,711,26125,0,0,1200,72000,0,0,363,7871,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,157:5:0 0,6,74:2:0 +X 1569 . C <*> 0 . DP=19;I16=12,6,0,0,676,25850,0,0,1080,64800,0,0,351,7669,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,128:4:0 0,6,76:2:0 +X 1570 . T <*> 0 . DP=19;I16=12,7,0,0,700,26750,0,0,1140,68400,0,0,353,7583,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,149:5:0 0,6,71:2:0 +X 1571 . G <*> 0 . DP=19;I16=12,6,0,0,639,23361,0,0,1080,64800,0,0,343,7441,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,125:4:0 0,6,70:2:0 +X 1572 . C <*> 0 . DP=19;I16=11,6,0,0,640,24568,0,0,1020,61200,0,0,328,7202,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,125:4:0 0,6,70:2:0 +X 1573 . A <*> 0 . DP=19;I16=11,4,0,0,565,21475,0,0,900,54000,0,0,304,6900,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,132:4:0 0,3,40:1:0 +X 1574 . C <*> 0 . DP=19;I16=12,5,0,0,636,24076,0,0,1020,61200,0,0,318,6948,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,128:4:0 0,3,38:1:0 +X 1575 . C <*> 0 . DP=19;I16=11,6,0,0,610,22742,0,0,1020,61200,0,0,296,6272,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,125:4:0 0,6,71:2:0 +X 1576 . C <*> 0 . DP=19;I16=12,6,0,0,675,25821,0,0,1080,64800,0,0,315,6785,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,133:4:0 0,6,78:2:0 +X 1577 . T <*> 0 . DP=17;I16=11,6,0,0,650,25330,0,0,1020,61200,0,0,310,6692,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,118:3:0 0,6,77:2:0 +X 1578 . C <*> 0 . DP=17;I16=10,6,0,0,622,24364,0,0,960,57600,0,0,279,5943,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,84:2:0 0,6,77:2:0 +X 1579 . A <*> 0 . DP=17;I16=11,6,0,0,596,22326,0,0,1020,61200,0,0,298,6464,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,116:3:0 0,6,80:2:0 +X 1580 . G <*> 0 . DP=17;I16=11,6,0,0,651,25195,0,0,1020,61200,0,0,292,6380,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,109:3:0 0,6,77:2:0 +X 1581 . C <*> 0 . DP=17;I16=11,6,0,0,586,21418,0,0,1020,61200,0,0,286,6316,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,103:3:0 0,6,71:2:0 +X 1582 . C <*> 0 . DP=18;I16=11,7,0,0,639,23491,0,0,1080,64800,0,0,280,6272,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,109:3:0 0,6,75:2:0 +X 1583 . T <*> 0 . DP=16;I16=10,6,0,0,591,22349,0,0,960,57600,0,0,276,6196,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,112:3:0 0,6,74:2:0 +X 1584 . G <*> 0 . DP=15;I16=10,5,0,0,563,21283,0,0,900,54000,0,0,272,6086,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,105:3:0 0,3,39:1:0 +X 1585 . G <*> 0 . DP=16;I16=10,5,0,0,494,17160,0,0,900,54000,0,0,251,5703,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,244:11:0 0,9,103:3:0 0,3,30:1:0 +X 1586 . A <*> 0 . DP=15;I16=10,3,0,0,470,17200,0,0,780,46800,0,0,237,5273,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,223:10:0 0,6,79:2:0 0,3,42:1:0 +X 1587 . C <*> 0 . DP=15;I16=11,4,0,0,508,17900,0,0,900,54000,0,0,264,5852,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,247:11:0 0,9,94:3:0 0,3,31:1:0 +X 1588 . A <*> 0 . DP=15;I16=11,4,0,0,511,17939,0,0,900,54000,0,0,262,5806,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,232:11:0 0,9,105:3:0 0,3,41:1:0 +X 1589 . A <*> 0 . DP=15;I16=11,4,0,0,536,19584,0,0,900,54000,0,0,259,5725,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,249:11:0 0,9,106:3:0 0,3,42:1:0 +X 1590 . C <*> 0 . DP=15;I16=10,5,0,0,514,18228,0,0,900,54000,0,0,257,5657,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,231:10:0 0,9,104:3:0 0,6,71:2:0 +X 1591 . T <*> 0 . DP=15;I16=10,5,0,0,515,18559,0,0,900,54000,0,0,256,5602,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,241:10:0 0,9,85:3:0 0,6,73:2:0 +X 1592 . T <*> 0 . DP=15;I16=10,5,0,0,503,17345,0,0,900,54000,0,0,255,5561,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,225:10:0 0,9,107:3:0 0,6,62:2:0 +X 1593 . G <*> 0 . DP=15;I16=10,5,0,0,540,19930,0,0,900,54000,0,0,254,5534,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,250:10:0 0,9,106:3:0 0,6,60:2:0 +X 1594 . T <*> 0 . DP=15;I16=10,5,0,0,535,19445,0,0,900,54000,0,0,252,5472,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,234:10:0 0,9,106:3:0 0,6,80:2:0 +X 1595 . G <*> 0 . DP=15;I16=10,4,0,0,494,17940,0,0,840,50400,0,0,225,4801,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,213:9:0 0,9,105:3:0 0,6,69:2:0 +X 1596 . C <*> 0 . DP=15;I16=10,4,0,0,479,17011,0,0,840,50400,0,0,233,5151,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,200:9:0 0,9,111:3:0 0,6,74:2:0 +X 1597 . C <*> 0 . DP=15;I16=10,5,0,0,489,16941,0,0,900,54000,0,0,245,5285,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,195:9:0 0,12,127:4:0 0,6,73:2:0 +X 1598 . C <*> 0 . DP=15;I16=10,5,0,0,514,18282,0,0,900,54000,0,0,244,5240,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,207:9:0 0,12,133:4:0 0,6,68:2:0 +X 1599 . A <*> 0 . DP=14;I16=8,5,0,0,436,15330,0,0,780,46800,0,0,225,4851,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,182:8:0 0,9,103:3:0 0,6,76:2:0 +X 1600 . T <*> 0 . DP=13;I16=8,5,0,0,456,16430,0,0,780,46800,0,0,226,4876,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,193:8:0 0,9,105:3:0 0,6,79:2:0 +X 1601 . C <*> 0 . DP=13;I16=8,4,0,0,431,15861,0,0,720,43200,0,0,208,4554,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,171:7:0 0,9,108:3:0 0,6,78:2:0 +X 1602 . T <*> 0 . DP=13;I16=7,5,0,0,439,16867,0,0,720,43200,0,0,228,4968,0,0;QS=3,0;MQSB=0.95494;MQ0F=0 PL:DP:DV 0,21,179:7:0 0,9,115:3:0 0,6,85:2:0 +X 1603 . G <*> 0 . DP=12;I16=7,5,0,0,455,17407,0,0,720,43200,0,0,230,5034,0,0;QS=3,0;MQSB=0.95494;MQ0F=0 PL:DP:DV 0,21,202:7:0 0,9,111:3:0 0,6,75:2:0 +X 1604 . G <*> 0 . DP=12;I16=7,5,0,0,362,11620,0,0,720,43200,0,0,232,5112,0,0;QS=3,0;MQSB=0.95494;MQ0F=0 PL:DP:DV 0,21,163:7:0 0,9,84:3:0 0,6,66:2:0 +X 1605 . T <*> 0 . DP=12;I16=7,5,0,0,410,14230,0,0,720,43200,0,0,234,5202,0,0;QS=3,0;MQSB=0.95494;MQ0F=0 PL:DP:DV 0,21,190:7:0 0,9,97:3:0 0,6,61:2:0 +X 1606 . G <*> 0 . DP=12;I16=7,4,0,0,370,12738,0,0,660,39600,0,0,211,4679,0,0;QS=3,0;MQSB=0.964642;MQ0F=0 PL:DP:DV 0,18,165:6:0 0,9,91:3:0 0,6,56:2:0 +X 1607 . A <*> 0 . DP=12;I16=7,4,0,0,337,11369,0,0,660,39600,0,0,226,5222,0,0;QS=3,0;MQSB=0.964642;MQ0F=0 PL:DP:DV 0,21,161:7:0 0,6,70:2:0 0,6,55:2:0 +X 1608 . C <*> 0 . DP=12;I16=7,4,0,0,366,12898,0,0,660,39600,0,0,211,4727,0,0;QS=3,0;MQSB=0.964642;MQ0F=0 PL:DP:DV 0,18,141:6:0 0,9,111:3:0 0,6,62:2:0 +X 1609 . C <*> 0 . DP=11;I16=6,5,0,0,365,12889,0,0,660,39600,0,0,237,5393,0,0;QS=3,0;MQSB=0.950952;MQ0F=0 PL:DP:DV 0,18,149:6:0 0,9,110:3:0 0,6,71:2:0 +X 1610 . C <*> 0 . DP=11;I16=5,5,0,0,313,10713,0,0,600,36000,0,0,213,4819,0,0;QS=3,0;MQSB=0.952347;MQ0F=0 PL:DP:DV 0,15,127:5:0 0,9,106:3:0 0,6,57:2:0 +X 1611 . C <*> 0 . DP=11;I16=6,5,0,0,398,14904,0,0,660,39600,0,0,238,5454,0,0;QS=3,0;MQSB=0.950952;MQ0F=0 PL:DP:DV 0,18,180:6:0 0,9,110:3:0 0,6,67:2:0 +X 1612 . T <*> 0 . DP=11;I16=6,5,0,0,409,15421,0,0,660,39600,0,0,238,5472,0,0;QS=3,0;MQSB=0.950952;MQ0F=0 PL:DP:DV 0,18,174:6:0 0,9,107:3:0 0,6,83:2:0 +X 1613 . C <*> 0 . DP=11;I16=6,5,0,0,372,12904,0,0,660,39600,0,0,238,5498,0,0;QS=3,0;MQSB=0.950952;MQ0F=0 PL:DP:DV 0,18,169:6:0 0,9,99:3:0 0,6,63:2:0 +X 1614 . A <*> 0 . DP=11;I16=6,5,0,0,353,12139,0,0,660,39600,0,0,238,5532,0,0;QS=3,0;MQSB=0.950952;MQ0F=0 PL:DP:DV 0,18,147:6:0 0,9,98:3:0 0,6,69:2:0 +X 1615 . C <*> 0 . DP=11;I16=6,5,0,0,366,13080,0,0,660,39600,0,0,238,5574,0,0;QS=3,0;MQSB=0.950952;MQ0F=0 PL:DP:DV 0,18,171:6:0 0,9,105:3:0 0,6,51:2:0 +X 1616 . T <*> 0 . DP=11;I16=6,3,0,0,348,13606,0,0,540,32400,0,0,187,4323,0,0;QS=3,0;MQSB=0.924584;MQ0F=0 PL:DP:DV 0,15,159:5:0 0,9,105:3:0 0,3,42:1:0 +X 1617 . C <*> 0 . DP=12;I16=6,3,0,0,330,12316,0,0,540,32400,0,0,185,4279,0,0;QS=3,0;MQSB=0.924584;MQ0F=0 PL:DP:DV 0,15,146:5:0 0,9,105:3:0 0,3,42:1:0 +X 1618 . A <*> 0 . DP=12;I16=5,6,0,0,385,14199,0,0,629,36841,0,0,244,5636,0,0;QS=3,0;MQSB=0.891517;MQ0F=0 PL:DP:DV 0,18,151:6:0 0,9,93:3:0 0,6,81:2:0 +X 1619 . G <*> 0 . DP=11;I16=5,6,0,0,377,13119,0,0,629,36841,0,0,242,5544,0,0;QS=3,0;MQSB=0.891517;MQ0F=0 PL:DP:DV 0,18,166:6:0 0,9,84:3:0 0,6,67:2:0 +X 1620 . C <*> 0 . DP=11;I16=5,5,0,0,323,10965,0,0,569,33241,0,0,215,4839,0,0;QS=3,0;MQSB=0.857112;MQ0F=0 PL:DP:DV 0,15,142:5:0 0,9,78:3:0 0,6,56:2:0 +X 1621 . C <*> 0 . DP=12;I16=5,7,0,0,363,11779,0,0,689,40441,0,0,263,6021,0,0;QS=3,0;MQSB=0.896474;MQ0F=0 PL:DP:DV 0,21,174:7:0 0,9,80:3:0 0,6,56:2:0 +X 1622 . A <*> 0 . DP=12;I16=5,7,0,0,365,12105,0,0,689,40441,0,0,261,5965,0,0;QS=3,0;MQSB=0.896474;MQ0F=0 PL:DP:DV 0,21,176:7:0 0,9,81:3:0 0,6,52:2:0 +X 1623 . C <*> 0 . DP=12;I16=5,5,0,0,325,10979,0,0,569,33241,0,0,208,4620,0,0;QS=3,0;MQSB=0.857112;MQ0F=0 PL:DP:DV 0,18,155:6:0 0,9,84:3:0 0,3,37:1:0 +X 1624 . C <*> 0 . DP=12;I16=4,6,0,0,336,11718,0,0,569,33241,0,0,211,4799,0,0;QS=3,0;MQSB=0.895781;MQ0F=0 PL:DP:DV 0,18,162:6:0 0,9,88:3:0 0,3,39:1:0 +X 1625 . A <*> 0 . DP=12;I16=4,7,0,0,375,13503,0,0,629,36841,0,0,234,5386,0,0;QS=3,0;MQSB=0.924449;MQ0F=0 PL:DP:DV 0,18,158:6:0 0,9,93:3:0 0,6,80:2:0 +X 1626 . G <*> 0 . DP=12;I16=5,7,0,0,358,11490,0,0,689,40441,0,0,249,5645,0,0;QS=3,0;MQSB=0.896474;MQ0F=0 PL:DP:DV 0,21,158:7:0 0,9,83:3:0 0,6,63:2:0 +X 1627 . A <*> 0 . DP=12;I16=5,7,0,0,363,11609,0,0,689,40441,0,0,246,5590,0,0;QS=3,0;MQSB=0.896474;MQ0F=0 PL:DP:DV 0,21,165:7:0 0,9,75:3:0 0,6,72:2:0 +X 1628 . C <*> 0 . DP=12;I16=5,7,0,0,357,11583,0,0,689,40441,0,0,243,5545,0,0;QS=3,0;MQSB=0.896474;MQ0F=0 PL:DP:DV 0,21,165:7:0 0,9,80:3:0 0,6,57:2:0 +X 1629 . T <*> 0 . DP=13;I16=6,7,0,0,451,16079,0,0,749,44041,0,0,240,5510,0,0;QS=3,0;MQSB=0.899815;MQ0F=0 PL:DP:DV 0,21,187:7:0 0,12,120:4:0 0,6,79:2:0 +X 1630 . T <*> 0 . DP=13;I16=6,7,0,0,403,13323,0,0,749,44041,0,0,237,5435,0,0;QS=3,0;MQSB=0.899815;MQ0F=0 PL:DP:DV 0,21,169:7:0 0,12,111:4:0 0,6,73:2:0 +X 1631 . C <*> 0 . DP=12;I16=6,5,0,0,354,12046,0,0,660,39600,0,0,210,4744,0,0;QS=3,0;MQSB=0.950952;MQ0F=0 PL:DP:DV 0,21,184:7:0 0,6,67:2:0 0,6,61:2:0 +X 1632 . C <*> 0 . DP=13;I16=6,7,0,0,387,12175,0,0,749,44041,0,0,232,5262,0,0;QS=3,0;MQSB=0.899815;MQ0F=0 PL:DP:DV 0,24,188:8:0 0,9,82:3:0 0,6,61:2:0 +X 1633 . A <*> 0 . DP=13;I16=6,7,0,0,404,13272,0,0,749,44041,0,0,230,5166,0,0;QS=3,0;MQSB=0.899815;MQ0F=0 PL:DP:DV 0,24,183:8:0 0,9,86:3:0 0,6,73:2:0 +X 1634 . C <*> 0 . DP=13;I16=6,6,0,0,328,9716,0,0,689,40441,0,0,203,4457,0,0;QS=3,0;MQSB=0.864013;MQ0F=0 PL:DP:DV 0,21,151:7:0 0,9,80:3:0 0,6,59:2:0 +X 1635 . G <*> 0 . DP=14;I16=6,8,0,0,419,12831,0,0,809,47641,0,0,226,5010,0,0;QS=3,0;MQSB=0.927743;MQ0F=0 PL:DP:DV 0,24,180:8:0 0,12,108:4:0 0,6,59:2:0 +X 1636 . A <*> 0 . DP=14;I16=6,8,0,0,418,13400,0,0,809,47641,0,0,225,4951,0,0;QS=3,0;MQSB=0.927743;MQ0F=0 PL:DP:DV 0,24,179:8:0 0,12,110:4:0 0,6,66:2:0 +X 1637 . C <*> 0 . DP=14;I16=6,8,0,0,422,13498,0,0,809,47641,0,0,224,4906,0,0;QS=3,0;MQSB=0.927743;MQ0F=0 PL:DP:DV 0,24,185:8:0 0,12,110:4:0 0,6,60:2:0 +X 1638 . A <*> 0 . DP=17;I16=9,7,0,0,513,17167,0,0,929,54841,0,0,216,4790,0,0;QS=3,0;MQSB=0.892753;MQ0F=0 PL:DP:DV 0,24,191:8:0 0,18,149:6:0 0,6,78:2:0 +X 1639 . G <*> 0 . DP=17;I16=9,8,0,0,552,18844,0,0,989,58441,0,0,223,4765,0,0;QS=3,0;MQSB=0.91051;MQ0F=0 PL:DP:DV 0,27,228:9:0 0,18,150:6:0 0,6,68:2:0 +X 1640 . G <*> 0 . DP=17;I16=8,6,0,0,414,13296,0,0,809,47641,0,0,171,3467,0,0;QS=3,0;MQSB=0.875173;MQ0F=0 PL:DP:DV 0,18,150:6:0 0,18,151:6:0 0,6,51:2:0 +X 1641 . C <*> 0 . DP=18;I16=9,8,0,0,511,16289,0,0,989,58441,0,0,225,4709,0,0;QS=3,0;MQSB=0.91051;MQ0F=0 PL:DP:DV 0,27,188:9:0 0,18,167:6:0 0,6,65:2:0 +X 1642 . T <*> 0 . DP=17;I16=8,7,0,0,519,18513,0,0,869,51241,0,0,217,4613,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,18,170:6:0 0,18,168:6:0 0,9,102:3:0 +X 1643 . C <*> 0 . DP=16;I16=7,9,0,0,508,16910,0,0,929,54841,0,0,255,5361,0,0;QS=3,0;MQSB=0.933674;MQ0F=0 PL:DP:DV 0,24,193:8:0 0,18,169:6:0 0,6,56:2:0 +X 1644 . C <*> 0 . DP=15;I16=6,9,0,0,514,18056,0,0,869,51241,0,0,259,5401,0,0;QS=3,0;MQSB=0.939413;MQ0F=0 PL:DP:DV 0,21,209:7:0 0,18,165:6:0 0,6,54:2:0 +X 1645 . A <*> 0 . DP=15;I16=6,9,0,0,520,18852,0,0,869,51241,0,0,263,5457,0,0;QS=3,0;MQSB=0.939413;MQ0F=0 PL:DP:DV 0,21,213:7:0 0,18,173:6:0 0,6,49:2:0 +X 1646 . G <*> 0 . DP=15;I16=6,7,0,0,440,15526,0,0,780,46800,0,0,217,4279,0,0;QS=3,0;MQSB=0.961166;MQ0F=0 PL:DP:DV 0,18,185:6:0 0,15,148:5:0 0,6,48:2:0 +X 1647 . C <*> 0 . DP=15;I16=6,9,0,0,433,13883,0,0,869,51241,0,0,271,5617,0,0;QS=3,0;MQSB=0.939413;MQ0F=0 PL:DP:DV 0,21,190:7:0 0,18,139:6:0 0,6,35:2:0 +X 1648 . C <*> 0 . DP=15;I16=6,9,0,0,495,16965,0,0,869,51241,0,0,275,5721,0,0;QS=3,0;MQSB=0.939413;MQ0F=0 PL:DP:DV 0,21,203:7:0 0,18,159:6:0 0,6,44:2:0 +X 1649 . T <*> 0 . DP=15;I16=6,9,0,0,516,18122,0,0,869,51241,0,0,279,5841,0,0;QS=3,0;MQSB=0.939413;MQ0F=0 PL:DP:DV 0,21,187:7:0 0,18,182:6:0 0,6,56:2:0 +X 1650 . C <*> 0 . DP=15;I16=6,7,0,0,405,13551,0,0,749,44041,0,0,240,5028,0,0;QS=3,0;MQSB=0.899815;MQ0F=0 PL:DP:DV 0,18,161:6:0 0,18,169:6:0 0,3,13:1:0 +X 1651 . G <*> 0 . DP=17;I16=5,9,0,0,424,13328,0,0,778,44882,0,0,249,5335,0,0;QS=3,0;MQSB=0.965069;MQ0F=0 PL:DP:DV 0,18,150:6:0 0,15,128:5:0 0,9,86:3:0 +X 1652 . G <*> 0 . DP=18;I16=7,9,0,0,532,18602,0,0,898,52082,0,0,267,5673,0,0;QS=3,0;MQSB=0.994413;MQ0F=0 PL:DP:DV 0,24,212:8:0 0,18,168:6:0 0,6,54:2:0 +X 1653 . C <*> 0 . DP=18;I16=8,10,0,0,581,19565,0,0,1018,59282,0,0,300,6490,0,0;QS=3,0;MQSB=0.99606;MQ0F=0 PL:DP:DV 0,24,208:8:0 0,21,175:7:0 0,9,82:3:0 +X 1654 . A T,<*> 0 . DP=18;I16=8,9,0,1,516,16718,15,225,958,55682,60,3600,285,6219,22,484;QS=2.93213,0.0678733,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.99606;BQB=1;MQ0F=0 PL:DP:DV 0,9,155,21,158,162:8:1 0,21,179,21,179,179:7:0 0,9,78,9,78,78:3:0 +X 1655 . C <*> 0 . DP=18;I16=8,10,0,0,565,19017,0,0,1018,59282,0,0,313,6887,0,0;QS=3,0;MQSB=0.99606;MQ0F=0 PL:DP:DV 0,24,198:8:0 0,21,180:7:0 0,9,79:3:0 +X 1656 . C <*> 0 . DP=19;I16=9,9,0,0,557,18013,0,0,1018,59282,0,0,295,6515,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,202:8:0 0,21,165:7:0 0,9,80:3:0 +X 1657 . T A,<*> 0 . DP=18;I16=8,9,0,1,580,20362,15,225,989,58441,29,841,301,6641,25,625;QS=2.93243,0.0675676,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.99606;BQB=1;MQ0F=0 PL:DP:DV 0,24,206,24,206,206:8:0 0,6,158,18,161,165:7:1 0,9,85,9,85,85:3:0 +X 1658 . T <*> 0 . DP=19;I16=8,10,0,0,573,19127,0,0,1018,59282,0,0,332,7412,0,0;QS=3,0;MQSB=0.99606;MQ0F=0 PL:DP:DV 0,24,187:8:0 0,21,189:7:0 0,9,91:3:0 +X 1659 . C <*> 0 . DP=20;I16=8,10,0,0,609,21517,0,0,1049,62041,0,0,338,7578,0,0;QS=3,0;MQSB=0.906029;MQ0F=0 PL:DP:DV 0,24,219:8:0 0,21,189:7:0 0,9,80:3:0 +X 1660 . A <*> 0 . DP=21;I16=8,11,0,0,641,23219,0,0,1078,62882,0,0,385,8901,0,0;QS=3,0;MQSB=0.992359;MQ0F=0 PL:DP:DV 0,21,172:7:0 0,24,219:8:0 0,12,127:4:0 +X 1661 . G <*> 0 . DP=21;I16=7,13,0,0,639,21739,0,0,1107,63723,0,0,412,9598,0,0;QS=3,0;MQSB=0.999215;MQ0F=0 PL:DP:DV 0,24,209:8:0 0,24,193:8:0 0,12,98:4:0 +X 1662 . C <*> 0 . DP=21;I16=8,12,0,0,641,21423,0,0,1107,63723,0,0,407,9465,0,0;QS=3,0;MQSB=0.988166;MQ0F=0 PL:DP:DV 0,21,192:7:0 0,27,211:9:0 0,12,100:4:0 +X 1663 . C <*> 0 . DP=20;I16=7,11,0,0,577,19507,0,0,1018,59282,0,0,394,9204,0,0;QS=3,0;MQSB=0.983729;MQ0F=0 PL:DP:DV 0,21,178:7:0 0,21,192:7:0 0,12,101:4:0 +X 1664 . A C,<*> 0 . DP=20;I16=6,10,0,1,530,17982,13,169,898,52082,29,841,358,8422,25,625;QS=2.93953,0.0604651,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.998738;BQB=1;MQ0F=0 PL:DP:DV 0,18,167,18,167,167:6:0 0,7,154,18,157,159:7:1 0,12,109,12,109,109:4:0 +X 1665 . T C,<*> 0 . DP=20;I16=7,11,1,1,592,20170,58,1924,1018,59282,89,4441,396,9188,39,821;QS=2.5913,0.408696,0;VDB=0.1;SGB=0.346553;RPB=0.222222;MQB=0.611111;MQSB=0.988166;BQB=0.944444;MQ0F=0 PL:DP:DV 0,21,185,21,185,185:7:0 0,27,222,27,222,222:9:0 35,0,51,41,57,90:4:2 +X 1666 . G <*> 0 . DP=20;I16=8,12,0,0,614,19760,0,0,1107,63723,0,0,435,9947,0,0;QS=3,0;MQSB=0.988166;MQ0F=0 PL:DP:DV 0,21,173:7:0 0,27,206:9:0 0,12,111:4:0 +X 1667 . G <*> 0 . DP=20;I16=8,11,0,0,617,21033,0,0,1078,62882,0,0,410,9276,0,0;QS=3,0;MQSB=0.992359;MQ0F=0 PL:DP:DV 0,21,183:7:0 0,24,195:8:0 0,12,115:4:0 +X 1668 . A <*> 0 . DP=20;I16=7,10,0,0,570,19908,0,0,958,55682,0,0,369,8365,0,0;QS=3,0;MQSB=0.989343;MQ0F=0 PL:DP:DV 0,18,158:6:0 0,21,186:7:0 0,12,124:4:0 +X 1669 . C <*> 0 . DP=20;I16=8,12,0,0,640,21336,0,0,1107,63723,0,0,435,9857,0,0;QS=3,0;MQSB=0.988166;MQ0F=0 PL:DP:DV 0,21,172:7:0 0,27,216:9:0 0,12,115:4:0 +X 1670 . A <*> 0 . DP=23;I16=9,13,0,0,765,27363,0,0,1258,73682,0,0,410,9234,0,0;QS=3,0;MQSB=0.991121;MQ0F=0 PL:DP:DV 0,27,215:9:0 0,27,233:9:0 0,12,129:4:0 +X 1671 . G <*> 0 . DP=23;I16=9,13,0,0,703,23631,0,0,1258,73682,0,0,412,9206,0,0;QS=3,0;MQSB=0.991121;MQ0F=0 PL:DP:DV 0,27,214:9:0 0,27,210:9:0 0,12,106:4:0 +X 1672 . T <*> 0 . DP=23;I16=9,13,0,0,724,24700,0,0,1258,73682,0,0,414,9202,0,0;QS=3,0;MQSB=0.991121;MQ0F=0 PL:DP:DV 0,27,203:9:0 0,27,232:9:0 0,12,111:4:0 +X 1673 . T <*> 0 . DP=25;I16=8,13,0,0,719,25183,0,0,1198,70082,0,0,372,8248,0,0;QS=3,0;MQSB=0.983744;MQ0F=0 PL:DP:DV 0,27,221:9:0 0,24,212:8:0 0,12,112:4:0 +X 1674 . C <*> 0 . DP=25;I16=8,14,0,0,755,26561,0,0,1289,76441,0,0,389,8417,0,0;QS=3,0;MQSB=0.892142;MQ0F=0 PL:DP:DV 0,33,244:11:0 0,21,206:7:0 0,12,96:4:0 +X 1675 . C <*> 0 . DP=25;I16=9,15,0,0,705,22355,0,0,1347,78123,0,0,447,9897,0,0;QS=3,0;MQSB=0.996008;MQ0F=0 PL:DP:DV 0,33,222:11:0 0,30,212:10:0 0,9,65:3:0 +X 1676 . G <*> 0 . DP=25;I16=6,15,0,0,660,21708,0,0,1167,67323,0,0,383,8265,0,0;QS=3,0;MQSB=0.993205;MQ0F=0 PL:DP:DV 0,33,222:11:0 0,21,170:7:0 0,9,96:3:0 +X 1677 . C <*> 0 . DP=25;I16=9,13,0,0,681,22869,0,0,1289,76441,0,0,394,8510,0,0;QS=3,0;MQSB=0.910098;MQ0F=0 PL:DP:DV 0,33,225:11:0 0,24,198:8:0 0,9,74:3:0 +X 1678 . C <*> 0 . DP=25;I16=9,15,0,0,775,26785,0,0,1347,78123,0,0,438,9496,0,0;QS=3,0;MQSB=0.996008;MQ0F=0 PL:DP:DV 0,33,235:11:0 0,30,231:10:0 0,9,83:3:0 +X 1679 . A <*> 0 . DP=25;I16=8,15,0,0,762,27552,0,0,1287,74523,0,0,412,8858,0,0;QS=3,0;MQSB=0.999479;MQ0F=0 PL:DP:DV 0,33,235:11:0 0,27,219:9:0 0,9,106:3:0 +X 1680 . G <*> 0 . DP=26;I16=9,17,0,0,843,29213,0,0,1467,85323,0,0,459,10021,0,0;QS=3,0;MQSB=0.999637;MQ0F=0 PL:DP:DV 0,33,253:11:0 0,33,232:11:0 0,12,108:4:0 +X 1681 . C <*> 0 . DP=26;I16=8,15,0,0,681,21293,0,0,1318,77282,0,0,407,8999,0,0;QS=3,0;MQSB=0.974802;MQ0F=0 PL:DP:DV 0,33,223:11:0 0,27,191:9:0 0,9,69:3:0 +X 1682 . G <*> 0 . DP=25;I16=9,16,0,0,728,22560,0,0,1407,81723,0,0,455,9877,0,0;QS=3,0;MQSB=0.998399;MQ0F=0 PL:DP:DV 0,30,222:10:0 0,33,208:11:0 0,12,98:4:0 +X 1683 . T <*> 0 . DP=25;I16=8,15,0,0,807,29159,0,0,1287,74523,0,0,403,8567,0,0;QS=3,0;MQSB=0.999479;MQ0F=0 PL:DP:DV 0,30,250:10:0 0,30,235:10:0 0,9,91:3:0 +X 1684 . T <*> 0 . DP=25;I16=8,15,0,0,802,28774,0,0,1318,77282,0,0,438,9612,0,0;QS=3,0;MQSB=0.974802;MQ0F=0 PL:DP:DV 0,27,227:9:0 0,30,237:10:0 0,12,107:4:0 +X 1685 . G <*> 0 . DP=24;I16=8,14,0,0,759,27319,0,0,1258,73682,0,0,413,8999,0,0;QS=3,0;MQSB=0.979255;MQ0F=0 PL:DP:DV 0,24,216:8:0 0,30,242:10:0 0,12,110:4:0 +X 1686 . C <*> 0 . DP=24;I16=8,15,0,0,793,28073,0,0,1318,77282,0,0,438,9656,0,0;QS=3,0;MQSB=0.974802;MQ0F=0 PL:DP:DV 0,27,225:9:0 0,30,241:10:0 0,12,103:4:0 +X 1687 . C <*> 0 . DP=24;I16=7,14,0,0,741,26765,0,0,1198,70082,0,0,388,8458,0,0;QS=3,0;MQSB=0.966484;MQ0F=0 PL:DP:DV 0,24,221:8:0 0,27,229:9:0 0,12,106:4:0 +X 1688 . C <*> 0 . DP=24;I16=8,15,0,0,794,28736,0,0,1318,77282,0,0,431,9605,0,0;QS=3,0;MQSB=0.974802;MQ0F=0 PL:DP:DV 0,27,239:9:0 0,30,221:10:0 0,12,120:4:0 +X 1689 . T A,<*> 0 . DP=24;I16=8,15,0,1,805,29443,33,1089,1287,74523,60,3600,421,9311,25,625;QS=2.74419,0.255814,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=1;BQB=1;MQ0F=0 PL:DP:DV 0,27,224,27,224,224:9:0 0,33,255,33,255,255:11:0 21,0,79,30,82,106:4:1 +X 1690 . C <*> 0 . DP=24;I16=8,16,0,0,864,32420,0,0,1347,78123,0,0,445,10033,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,242:9:0 0,33,255:11:0 0,12,95:4:0 +X 1691 . T <*> 0 . DP=22;I16=7,14,0,0,734,27150,0,0,1167,67323,0,0,421,9525,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,225:9:0 0,30,242:10:0 0,6,57:2:0 +X 1692 . G <*> 0 . DP=22;I16=7,13,0,0,678,24110,0,0,1107,63723,0,0,400,9176,0,0;QS=3,0;MQSB=0.999215;MQ0F=0 PL:DP:DV 0,24,218:8:0 0,30,218:10:0 0,6,61:2:0 +X 1693 . T <*> 0 . DP=24;I16=10,13,0,0,795,28363,0,0,1318,77282,0,0,444,10422,0,0;QS=3,0;MQSB=0.995682;MQ0F=0 PL:DP:DV 0,27,227:9:0 0,30,235:10:0 0,12,104:4:0 +X 1694 . T <*> 0 . DP=24;I16=10,13,0,0,771,26775,0,0,1318,77282,0,0,448,10602,0,0;QS=3,0;MQSB=0.995682;MQ0F=0 PL:DP:DV 0,27,221:9:0 0,30,232:10:0 0,12,114:4:0 +X 1695 . C <*> 0 . DP=24;I16=10,14,0,0,811,28517,0,0,1347,78123,0,0,454,10806,0,0;QS=3,0;MQSB=0.98469;MQ0F=0 PL:DP:DV 0,27,227:9:0 0,33,239:11:0 0,12,121:4:0 +X 1696 . T <*> 0 . DP=23;I16=10,13,0,0,825,30819,0,0,1287,74523,0,0,455,10869,0,0;QS=3,0;MQSB=0.976718;MQ0F=0 PL:DP:DV 0,24,219:8:0 0,33,255:11:0 0,12,108:4:0 +X 1697 . G <*> 0 . DP=23;I16=10,13,0,0,767,26757,0,0,1287,74523,0,0,455,10897,0,0;QS=3,0;MQSB=0.976718;MQ0F=0 PL:DP:DV 0,24,208:8:0 0,33,246:11:0 0,12,112:4:0 +X 1698 . C A,<*> 0 . DP=21;I16=10,10,0,1,726,27088,27,729,1169,69241,29,841,451,10903,6,36;QS=2.91148,0.0885246,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.99938;BQB=1;MQ0F=0 PL:DP:DV 0,24,229,24,229,229:8:0 0,0,190,24,193,207:9:1 0,12,111,12,111,111:4:0 +X 1699 . T <*> 0 . DP=21;I16=9,10,0,0,698,25826,0,0,1078,62882,0,0,408,9692,0,0;QS=3,0;MQSB=0.999167;MQ0F=0 PL:DP:DV 0,21,203:7:0 0,24,219:8:0 0,12,115:4:0 +X 1700 . G <*> 0 . DP=20;I16=9,10,0,0,696,25850,0,0,1078,62882,0,0,409,9705,0,0;QS=3,0;MQSB=0.999167;MQ0F=0 PL:DP:DV 0,21,216:7:0 0,24,215:8:0 0,12,110:4:0 +X 1701 . T <*> 0 . DP=20;I16=9,11,0,0,711,25539,0,0,1138,66482,0,0,435,10353,0,0;QS=3,0;MQSB=0.997118;MQ0F=0 PL:DP:DV 0,24,207:8:0 0,24,210:8:0 0,12,125:4:0 +X 1702 . T <*> 0 . DP=20;I16=8,11,0,0,671,24367,0,0,1078,62882,0,0,410,9712,0,0;QS=3,0;MQSB=0.992359;MQ0F=0 PL:DP:DV 0,24,214:8:0 0,21,193:7:0 0,12,115:4:0 +X 1703 . T <*> 0 . DP=20;I16=9,10,0,0,648,22696,0,0,1078,62882,0,0,410,9708,0,0;QS=3,0;MQSB=0.999167;MQ0F=0 PL:DP:DV 0,21,197:7:0 0,24,195:8:0 0,12,114:4:0 +X 1704 . T <*> 0 . DP=20;I16=10,10,0,0,711,25771,0,0,1169,69241,0,0,435,10341,0,0;QS=3,0;MQSB=0.931063;MQ0F=0 PL:DP:DV 0,24,208:8:0 0,21,208:7:0 0,15,128:5:0 +X 1705 . C <*> 0 . DP=20;I16=10,10,0,0,744,28388,0,0,1169,69241,0,0,436,10312,0,0;QS=3,0;MQSB=0.931063;MQ0F=0 PL:DP:DV 0,24,232:8:0 0,21,213:7:0 0,15,120:5:0 +X 1706 . T <*> 0 . DP=20;I16=10,10,0,0,775,30329,0,0,1169,69241,0,0,436,10246,0,0;QS=3,0;MQSB=0.931063;MQ0F=0 PL:DP:DV 0,24,221:8:0 0,21,219:7:0 0,15,145:5:0 +X 1707 . C <*> 0 . DP=21;I16=9,11,0,0,724,26998,0,0,1169,69241,0,0,410,9518,0,0;QS=3,0;MQSB=0.916401;MQ0F=0 PL:DP:DV 0,27,235:9:0 0,18,180:6:0 0,15,134:5:0 +X 1708 . T <*> 0 . DP=21;I16=9,12,0,0,740,27282,0,0,1229,72841,0,0,410,9430,0,0;QS=3,0;MQSB=0.913101;MQ0F=0 PL:DP:DV 0,30,229:10:0 0,18,187:6:0 0,15,132:5:0 +X 1709 . A <*> 0 . DP=21;I16=9,11,0,0,675,23509,0,0,1169,69241,0,0,386,8734,0,0;QS=3,0;MQSB=0.916401;MQ0F=0 PL:DP:DV 0,27,210:9:0 0,18,166:6:0 0,15,131:5:0 +X 1710 . C <*> 0 . DP=22;I16=9,13,0,0,755,26817,0,0,1289,76441,0,0,412,9306,0,0;QS=3,0;MQSB=0.910098;MQ0F=0 PL:DP:DV 0,33,236:11:0 0,18,181:6:0 0,15,128:5:0 +X 1711 . C <*> 0 . DP=22;I16=9,13,0,0,786,28790,0,0,1289,76441,0,0,413,9223,0,0;QS=3,0;MQSB=0.910098;MQ0F=0 PL:DP:DV 0,33,250:11:0 0,18,169:6:0 0,15,138:5:0 +X 1712 . A <*> 0 . DP=22;I16=9,13,0,0,824,31342,0,0,1289,76441,0,0,414,9162,0,0;QS=3,0;MQSB=0.910098;MQ0F=0 PL:DP:DV 0,33,252:11:0 0,18,198:6:0 0,15,136:5:0 +X 1713 . G <*> 0 . DP=23;I16=8,14,0,0,823,31285,0,0,1289,76441,0,0,405,8993,0,0;QS=3,0;MQSB=0.892142;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,189:6:0 0,12,118:4:0 +X 1714 . A <*> 0 . DP=23;I16=9,13,0,0,763,27439,0,0,1289,76441,0,0,402,8818,0,0;QS=3,0;MQSB=0.910098;MQ0F=0 PL:DP:DV 0,36,234:12:0 0,18,190:6:0 0,12,101:4:0 +X 1715 . A <*> 0 . DP=23;I16=9,14,0,0,900,35416,0,0,1349,80041,0,0,414,8878,0,0;QS=3,0;MQSB=0.907354;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,206:6:0 0,15,145:5:0 +X 1716 . G <*> 0 . DP=23;I16=9,14,0,0,844,31500,0,0,1349,80041,0,0,414,8822,0,0;QS=3,0;MQSB=0.907354;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,188:6:0 0,15,129:5:0 +X 1717 . T <*> 0 . DP=24;I16=9,15,0,0,854,30878,0,0,1409,83641,0,0,414,8794,0,0;QS=3,0;MQSB=0.904837;MQ0F=0 PL:DP:DV 0,39,253:13:0 0,18,185:6:0 0,15,122:5:0 +X 1718 . G <*> 0 . DP=24;I16=9,14,0,0,806,29332,0,0,1349,80041,0,0,390,8170,0,0;QS=3,0;MQSB=0.907354;MQ0F=0 PL:DP:DV 0,36,249:12:0 0,18,188:6:0 0,15,124:5:0 +X 1719 . C <*> 0 . DP=26;I16=11,14,0,0,857,30717,0,0,1469,87241,0,0,407,8675,0,0;QS=3,0;MQSB=0.929204;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,173:6:0 0,12,98:4:0 +X 1720 . C <*> 0 . DP=26;I16=11,14,0,0,898,33274,0,0,1469,87241,0,0,409,8645,0,0;QS=3,0;MQSB=0.929204;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,166:6:0 0,12,99:4:0 +X 1721 . C <*> 0 . DP=26;I16=10,14,0,0,846,30642,0,0,1409,83641,0,0,388,8258,0,0;QS=3,0;MQSB=0.919431;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,187:6:0 0,12,119:4:0 +X 1722 . T <*> 0 . DP=25;I16=11,13,0,0,876,33054,0,0,1409,83641,0,0,406,8540,0,0;QS=3,0;MQSB=0.931547;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,174:5:0 0,15,123:5:0 +X 1723 . T <*> 0 . DP=25;I16=11,14,0,0,835,28861,0,0,1469,87241,0,0,420,8728,0,0;QS=3,0;MQSB=0.929204;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,167:5:0 0,15,130:5:0 +X 1724 . C <*> 0 . DP=25;I16=11,14,0,0,903,33735,0,0,1469,87241,0,0,422,8800,0,0;QS=3,0;MQSB=0.929204;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,164:5:0 0,15,139:5:0 +X 1725 . C G,<*> 0 . DP=25;I16=11,13,0,1,835,29699,25,625,1409,83641,60,3600,406,8576,18,324;QS=2.95164,0.0483559,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.929204;BQB=1;MQ0F=0 PL:DP:DV 0,20,255,42,255,255:15:1 0,15,153,15,153,153:5:0 0,15,132,15,132,132:5:0 +X 1726 . C <*> 0 . DP=25;I16=11,14,0,0,932,35588,0,0,1469,87241,0,0,426,9028,0,0;QS=3,0;MQSB=0.929204;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,165:5:0 0,15,122:5:0 +X 1727 . T <*> 0 . DP=25;I16=10,14,0,0,862,32080,0,0,1409,83641,0,0,404,8556,0,0;QS=3,0;MQSB=0.919431;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,167:5:0 0,12,120:4:0 +X 1728 . C <*> 0 . DP=25;I16=11,14,0,0,915,33845,0,0,1469,87241,0,0,429,9173,0,0;QS=3,0;MQSB=0.929204;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,156:5:0 0,15,144:5:0 +X 1729 . C <*> 0 . DP=25;I16=10,14,0,0,919,35797,0,0,1409,83641,0,0,406,8668,0,0;QS=3,0;MQSB=0.919431;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,142:5:0 0,12,128:4:0 +X 1730 . T <*> 0 . DP=24;I16=10,14,0,0,849,30711,0,0,1409,83641,0,0,433,9393,0,0;QS=3,0;MQSB=0.919431;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,138:4:0 0,15,148:5:0 +X 1731 . C <*> 0 . DP=24;I16=10,14,0,0,907,34875,0,0,1409,83641,0,0,434,9472,0,0;QS=3,0;MQSB=0.919431;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,123:4:0 0,15,140:5:0 +X 1732 . A <*> 0 . DP=24;I16=11,13,0,0,816,28582,0,0,1409,83641,0,0,436,9580,0,0;QS=3,0;MQSB=0.931547;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,123:4:0 0,15,143:5:0 +X 1733 . C <*> 0 . DP=25;I16=12,13,0,0,869,31451,0,0,1469,87241,0,0,438,9666,0,0;QS=3,0;MQSB=0.939413;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,116:4:0 0,15,136:5:0 +X 1734 . C <*> 0 . DP=25;I16=12,13,0,0,926,35482,0,0,1469,87241,0,0,440,9730,0,0;QS=3,0;MQSB=0.939413;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,122:4:0 0,15,141:5:0 +X 1735 . T <*> 0 . DP=26;I16=13,13,0,0,935,35169,0,0,1529,90841,0,0,442,9822,0,0;QS=3,0;MQSB=0.945959;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,112:4:0 0,15,148:5:0 +X 1736 . G <*> 0 . DP=25;I16=11,11,0,0,829,31469,0,0,1289,76441,0,0,380,8416,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,72:2:0 0,12,118:4:0 +X 1737 . A <*> 0 . DP=25;I16=12,12,0,0,842,30606,0,0,1409,83641,0,0,422,9312,0,0;QS=3,0;MQSB=0.941765;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,76:2:0 0,15,131:5:0 +X 1738 . C <*> 0 . DP=24;I16=12,12,0,0,835,30251,0,0,1409,83641,0,0,450,10010,0,0;QS=3,0;MQSB=0.941765;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,78:3:0 0,15,130:5:0 +X 1739 . C <*> 0 . DP=23;I16=10,12,0,0,831,32123,0,0,1289,76441,0,0,428,9432,0,0;QS=3,0;MQSB=0.924723;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,55:2:0 0,12,135:4:0 +X 1740 . A <*> 0 . DP=23;I16=11,12,0,0,774,27126,0,0,1349,80041,0,0,456,10126,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,56:2:0 0,15,139:5:0 +X 1741 . C <*> 0 . DP=23;I16=11,12,0,0,850,32314,0,0,1349,80041,0,0,459,10217,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,70:2:0 0,15,136:5:0 +X 1742 . T <*> 0 . DP=23;I16=11,12,0,0,866,33204,0,0,1349,80041,0,0,462,10330,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,72:2:0 0,15,144:5:0 +X 1743 . C <*> 0 . DP=23;I16=11,12,0,0,894,35176,0,0,1349,80041,0,0,464,10414,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,74:2:0 0,15,138:5:0 +X 1744 . T <*> 0 . DP=23;I16=11,11,0,0,857,33579,0,0,1289,76441,0,0,459,10469,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,80:2:0 0,15,156:5:0 +X 1745 . G <*> 0 . DP=23;I16=11,12,0,0,882,34572,0,0,1349,80041,0,0,464,10442,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,78:2:0 0,15,142:5:0 +X 1746 . G <*> 0 . DP=24;I16=12,11,0,0,836,31102,0,0,1349,80041,0,0,456,10312,0,0;QS=3,0;MQSB=0.944319;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,69:2:0 0,18,151:6:0 +X 1747 . G <*> 0 . DP=24;I16=12,11,0,0,839,31729,0,0,1349,80041,0,0,455,10239,0,0;QS=3,0;MQSB=0.944319;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,75:2:0 0,18,154:6:0 +X 1748 . G <*> 0 . DP=24;I16=11,12,0,0,843,31857,0,0,1349,80041,0,0,434,9664,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,3,42:1:0 0,18,154:6:0 +X 1749 . A <*> 0 . DP=25;I16=13,11,0,0,864,31748,0,0,1409,83641,0,0,451,10063,0,0;QS=3,0;MQSB=0.950498;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,72:2:0 0,21,172:7:0 +X 1750 . A <*> 0 . DP=25;I16=13,12,0,0,905,33667,0,0,1469,87241,0,0,451,10013,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,56:2:0 0,21,187:7:0 +X 1751 . A <*> 0 . DP=25;I16=13,12,0,0,908,33658,0,0,1469,87241,0,0,449,9987,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,67:2:0 0,21,183:7:0 +X 1752 . T <*> 0 . DP=23;I16=12,11,0,0,838,31088,0,0,1380,82800,0,0,449,9987,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,71:2:0 0,18,170:6:0 +X 1753 . C <*> 0 . DP=23;I16=12,11,0,0,869,33595,0,0,1380,82800,0,0,448,9960,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,77:2:0 0,18,163:6:0 +X 1754 . C <*> 0 . DP=23;I16=11,11,0,0,830,31628,0,0,1320,79200,0,0,431,9699,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,3,42:1:0 0,18,163:6:0 +X 1755 . C <*> 0 . DP=23;I16=12,11,0,0,856,33082,0,0,1380,82800,0,0,446,9972,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,61:2:0 0,18,165:6:0 +X 1756 . T <*> 0 . DP=22;I16=11,11,0,0,858,33720,0,0,1320,79200,0,0,445,9961,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,77:2:0 0,18,179:6:0 +X 1757 . C <*> 0 . DP=22;I16=11,11,0,0,869,34651,0,0,1320,79200,0,0,444,9972,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,78:2:0 0,18,176:6:0 +X 1758 . A <*> 0 . DP=22;I16=11,11,0,0,865,34205,0,0,1320,79200,0,0,442,9954,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,81:2:0 0,18,177:6:0 +X 1759 . G <*> 0 . DP=22;I16=11,11,0,0,833,31965,0,0,1320,79200,0,0,439,9905,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,77:2:0 0,18,159:6:0 +X 1760 . C <*> 0 . DP=22;I16=11,11,0,0,849,33441,0,0,1320,79200,0,0,436,9874,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,79:2:0 0,18,159:6:0 +X 1761 . A <*> 0 . DP=22;I16=11,11,0,0,730,25766,0,0,1320,79200,0,0,432,9810,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,75:2:0 0,18,153:6:0 +X 1762 . C <*> 0 . DP=21;I16=11,10,0,0,767,28667,0,0,1260,75600,0,0,429,9761,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,76:2:0 0,18,160:6:0 +X 1763 . C <*> 0 . DP=21;I16=11,10,0,0,789,30115,0,0,1260,75600,0,0,426,9726,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,72:2:0 0,18,162:6:0 +X 1764 . C <*> 0 . DP=21;I16=11,10,0,0,821,32443,0,0,1260,75600,0,0,423,9705,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,72:2:0 0,18,167:6:0 +X 1765 . T <*> 0 . DP=21;I16=11,10,0,0,814,31746,0,0,1260,75600,0,0,420,9698,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,83:2:0 0,18,179:6:0 +X 1766 . C <*> 0 . DP=21;I16=11,10,0,0,796,30564,0,0,1260,75600,0,0,417,9705,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,71:2:0 0,18,162:6:0 +X 1767 . C <*> 0 . DP=21;I16=11,10,0,0,779,29559,0,0,1260,75600,0,0,414,9726,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,73:2:0 0,18,163:6:0 +X 1768 . C <*> 0 . DP=21;I16=11,10,0,0,798,30670,0,0,1260,75600,0,0,411,9761,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,68:2:0 0,18,160:6:0 +X 1769 . T <*> 0 . DP=21;I16=11,10,0,0,819,32179,0,0,1260,75600,0,0,406,9712,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,77:2:0 0,18,184:6:0 +X 1770 . G <*> 0 . DP=19;I16=11,8,0,0,699,26453,0,0,1140,68400,0,0,403,9679,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,68:2:0 0,18,158:6:0 +X 1771 . A <*> 0 . DP=18;I16=10,8,0,0,707,27853,0,0,1080,64800,0,0,401,9659,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,3,42:1:0 0,18,177:6:0 +X 1772 . G <*> 0 . DP=18;I16=10,8,0,0,669,25513,0,0,1080,64800,0,0,398,9600,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,3,38:1:0 0,18,159:6:0 +X 1773 . C <*> 0 . DP=17;I16=10,7,0,0,675,26897,0,0,1020,61200,0,0,396,9550,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,3,39:1:0 0,18,172:6:0 +X 1774 . A <*> 0 . DP=17;I16=10,7,0,0,653,25153,0,0,1020,61200,0,0,394,9508,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,3,39:1:0 0,18,172:6:0 +X 1775 . T <*> 0 . DP=17;I16=10,7,0,0,605,22253,0,0,1020,61200,0,0,391,9423,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,3,38:1:0 0,18,156:6:0 +X 1776 . A <*> 0 . DP=17;I16=10,7,0,0,610,22124,0,0,1020,61200,0,0,388,9344,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,254:10:0 0,3,35:1:0 0,18,166:6:0 +X 1777 . C <*> 0 . DP=18;I16=11,7,0,0,661,24975,0,0,1080,64800,0,0,385,9271,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,3,35:1:0 0,18,158:6:0 +X 1778 . C <*> 0 . DP=18;I16=11,7,0,0,680,25970,0,0,1080,64800,0,0,383,9205,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,3,31:1:0 0,18,172:6:0 +X 1779 . C <*> 0 . DP=18;I16=11,7,0,0,703,27663,0,0,1080,64800,0,0,381,9147,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,3,34:1:0 0,18,174:6:0 +X 1780 . T <*> 0 . DP=18;I16=11,7,0,0,672,26000,0,0,1080,64800,0,0,378,9048,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,3,33:1:0 0,18,177:6:0 +X 1781 . A <*> 0 . DP=19;I16=10,6,0,0,579,21377,0,0,960,57600,0,0,328,7804,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,0,0:0:0 0,15,160:5:0 +X 1782 . C <*> 0 . DP=20;I16=11,9,0,0,715,26603,0,0,1200,72000,0,0,382,8892,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,47:2:0 0,18,156:6:0 +X 1783 . T <*> 0 . DP=20;I16=11,9,0,0,755,29057,0,0,1200,72000,0,0,381,8743,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,68:2:0 0,18,184:6:0 +X 1784 . C <*> 0 . DP=20;I16=10,9,0,0,723,28017,0,0,1140,68400,0,0,360,8212,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,62:2:0 0,15,151:5:0 +X 1785 . T <*> 0 . DP=20;I16=10,10,0,0,766,29878,0,0,1200,72000,0,0,359,8089,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,66:2:0 0,15,168:5:0 +X 1786 . G <*> 0 . DP=22;I16=11,11,0,0,841,32323,0,0,1320,79200,0,0,359,7985,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,68:2:0 0,15,158:5:0 +X 1787 . G <*> 0 . DP=22;I16=11,11,0,0,806,30294,0,0,1320,79200,0,0,361,7903,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,68:2:0 0,15,148:5:0 +X 1788 . C <*> 0 . DP=22;I16=11,11,0,0,858,33674,0,0,1320,79200,0,0,362,7796,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,67:2:0 0,15,158:5:0 +X 1789 . A <*> 0 . DP=23;I16=11,12,0,0,797,28705,0,0,1380,82800,0,0,363,7715,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,69:2:0 0,15,157:5:0 +X 1790 . C <*> 0 . DP=23;I16=11,12,0,0,852,31816,0,0,1380,82800,0,0,365,7661,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,63:2:0 0,15,153:5:0 +X 1791 . A <*> 0 . DP=23;I16=11,12,0,0,830,30484,0,0,1380,82800,0,0,367,7635,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,61:2:0 0,15,155:5:0 +X 1792 . A <*> 0 . DP=23;I16=11,12,0,0,862,32760,0,0,1380,82800,0,0,368,7588,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,67:2:0 0,15,161:5:0 +X 1793 . G <*> 0 . DP=23;I16=11,12,0,0,813,29603,0,0,1380,82800,0,0,369,7571,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,61:2:0 0,15,126:5:0 +X 1794 . C <*> 0 . DP=21;I16=9,12,0,0,736,26472,0,0,1260,75600,0,0,370,7484,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,48:2:0 0,9,96:3:0 +X 1795 . C <*> 0 . DP=21;I16=9,12,0,0,763,28807,0,0,1260,75600,0,0,371,7427,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,45:2:0 0,9,100:3:0 +X 1796 . C <*> 0 . DP=21;I16=9,12,0,0,782,29718,0,0,1260,75600,0,0,372,7400,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,52:2:0 0,9,102:3:0 +X 1797 . A <*> 0 . DP=21;I16=9,12,0,0,704,25190,0,0,1260,75600,0,0,373,7403,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,59:2:0 0,9,92:3:0 +X 1798 . C <*> 0 . DP=21;I16=9,12,0,0,759,28119,0,0,1260,75600,0,0,374,7436,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,49:2:0 0,9,99:3:0 +X 1799 . C <*> 0 . DP=22;I16=9,13,0,0,796,29520,0,0,1320,79200,0,0,375,7499,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,56:2:0 0,12,131:4:0 +X 1800 . C <*> 0 . DP=22;I16=9,13,0,0,866,34352,0,0,1320,79200,0,0,376,7542,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,63:2:0 0,12,138:4:0 +X 1801 . T <*> 0 . DP=22;I16=9,13,0,0,838,32282,0,0,1320,79200,0,0,377,7615,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,63:2:0 0,12,150:4:0 +X 1802 . G <*> 0 . DP=22;I16=9,13,0,0,844,32894,0,0,1320,79200,0,0,378,7718,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,60:2:0 0,12,137:4:0 +X 1803 . C <*> 0 . DP=22;I16=9,13,0,0,837,32691,0,0,1320,79200,0,0,377,7751,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,60:2:0 0,12,143:4:0 +X 1804 . A <*> 0 . DP=23;I16=9,14,0,0,793,28517,0,0,1380,82800,0,0,376,7814,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,54:2:0 0,12,144:4:0 +X 1805 . A <*> 0 . DP=23;I16=9,14,0,0,810,29148,0,0,1380,82800,0,0,376,7908,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,67:2:0 0,12,138:4:0 +X 1806 . A <*> 0 . DP=23;I16=9,14,0,0,816,29932,0,0,1380,82800,0,0,376,8034,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,61:2:0 0,12,139:4:0 +X 1807 . G <*> 0 . DP=22;I16=9,13,0,0,837,32299,0,0,1320,79200,0,0,375,8091,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,67:2:0 0,12,142:4:0 +X 1808 . C <*> 0 . DP=21;I16=9,11,0,0,705,25519,0,0,1200,72000,0,0,354,7716,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,53:2:0 0,12,140:4:0 +X 1809 . C <*> 0 . DP=22;I16=10,12,0,0,789,29123,0,0,1320,79200,0,0,371,8091,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,55:2:0 0,12,143:4:0 +X 1810 . C <*> 0 . DP=21;I16=10,11,0,0,754,27902,0,0,1260,75600,0,0,370,8084,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,51:2:0 0,12,145:4:0 +X 1811 . C <*> 0 . DP=22;I16=11,11,0,0,837,32353,0,0,1320,79200,0,0,368,8056,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,61:2:0 0,12,146:4:0 +X 1812 . T <*> 0 . DP=22;I16=11,11,0,0,830,31782,0,0,1320,79200,0,0,365,7955,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,60:2:0 0,12,151:4:0 +X 1813 . G <*> 0 . DP=21;I16=11,10,0,0,789,29971,0,0,1260,75600,0,0,363,7879,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,63:2:0 0,12,135:4:0 +X 1814 . A <*> 0 . DP=21;I16=11,10,0,0,780,29356,0,0,1260,75600,0,0,361,7827,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,63:2:0 0,12,148:4:0 +X 1815 . G <*> 0 . DP=21;I16=11,10,0,0,742,27064,0,0,1260,75600,0,0,358,7748,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,56:2:0 0,12,135:4:0 +X 1816 . G <*> 0 . DP=21;I16=11,10,0,0,702,24670,0,0,1260,75600,0,0,355,7691,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,49:2:0 0,12,124:4:0 +X 1817 . C <*> 0 . DP=20;I16=11,9,0,0,701,25263,0,0,1200,72000,0,0,353,7655,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,58:2:0 0,12,134:4:0 +X 1818 . C <*> 0 . DP=20;I16=11,8,0,0,665,23987,0,0,1140,68400,0,0,326,7014,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,53:2:0 0,12,132:4:0 +X 1819 . C <*> 0 . DP=18;I16=9,9,0,0,580,20092,0,0,1080,64800,0,0,351,7641,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,38:2:0 0,12,124:4:0 +X 1820 . G <*> 0 . DP=18;I16=9,9,0,0,589,19883,0,0,1080,64800,0,0,351,7659,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,58:2:0 0,12,117:4:0 +X 1821 . C <*> 0 . DP=18;I16=9,9,0,0,619,22131,0,0,1080,64800,0,0,351,7693,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,60:2:0 0,12,131:4:0 +X 1822 . C <*> 0 . DP=18;I16=9,9,0,0,655,24177,0,0,1080,64800,0,0,350,7694,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,58:2:0 0,12,131:4:0 +X 1823 . C <*> 0 . DP=19;I16=10,9,0,0,703,26765,0,0,1140,68400,0,0,349,7713,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,62:2:0 0,12,138:4:0 +X 1824 . T <*> 0 . DP=19;I16=10,9,0,0,714,27628,0,0,1140,68400,0,0,349,7751,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,69:2:0 0,12,149:4:0 +X 1825 . G <*> 0 . DP=19;I16=10,9,0,0,682,24804,0,0,1140,68400,0,0,347,7709,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,61:2:0 0,12,129:4:0 +X 1826 . T <*> 0 . DP=19;I16=10,9,0,0,643,22525,0,0,1140,68400,0,0,345,7687,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,62:2:0 0,12,141:4:0 +X 1827 . G <*> 0 . DP=19;I16=10,9,0,0,722,27844,0,0,1140,68400,0,0,343,7685,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,66:2:0 0,12,134:4:0 +X 1828 . G <*> 0 . DP=18;I16=10,8,0,0,619,21719,0,0,1080,64800,0,0,342,7702,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,61:2:0 0,9,100:3:0 +X 1829 . C <*> 0 . DP=19;I16=9,9,0,0,576,19228,0,0,1080,64800,0,0,323,7413,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,59:3:0 0,9,103:3:0 +X 1830 . G <*> 0 . DP=19;I16=9,9,0,0,582,19586,0,0,1080,64800,0,0,321,7379,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,82:3:0 0,9,80:3:0 +X 1831 . T <*> 0 . DP=20;I16=10,8,0,0,605,21015,0,0,1080,64800,0,0,294,6736,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,106:4:0 0,9,101:3:0 +X 1832 . C <*> 0 . DP=19;I16=9,9,0,0,675,25747,0,0,1080,64800,0,0,319,7359,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,110:4:0 0,9,105:3:0 +X 1833 . T <*> 0 . DP=18;I16=8,8,0,0,565,20733,0,0,960,57600,0,0,295,6747,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,248:10:0 0,9,105:3:0 0,9,106:3:0 +X 1834 . C <*> 0 . DP=19;I16=9,9,0,0,654,24424,0,0,1037,61489,0,0,321,7399,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,104:4:0 0,9,107:3:0 +X 1835 . T <*> 0 . DP=18;I16=9,9,0,0,641,23505,0,0,1037,61489,0,0,347,7965,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,123:4:0 0,9,115:3:0 +X 1836 . C <*> 0 . DP=18;I16=9,9,0,0,657,24427,0,0,1037,61489,0,0,350,8016,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,127:4:0 0,9,108:3:0 +X 1837 . C <*> 0 . DP=18;I16=9,9,0,0,586,20044,0,0,1037,61489,0,0,352,8030,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,33,233:11:0 0,12,114:4:0 0,9,108:3:0 +X 1838 . C <*> 0 . DP=18;I16=9,9,0,0,655,24607,0,0,1037,61489,0,0,354,8056,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,120:4:0 0,9,107:3:0 +X 1839 . T <*> 0 . DP=18;I16=9,7,0,0,557,20543,0,0,917,54289,0,0,321,7369,0,0;QS=3,0;MQSB=0.933674;MQ0F=0 PL:DP:DV 0,30,231:10:0 0,9,103:3:0 0,9,119:3:0 +X 1840 . C <*> 0 . DP=18;I16=9,9,0,0,637,23295,0,0,1037,61489,0,0,358,8144,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,116:4:0 0,9,109:3:0 +X 1841 . C <*> 0 . DP=18;I16=9,9,0,0,622,22458,0,0,1037,61489,0,0,360,8206,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,33,252:11:0 0,12,121:4:0 0,9,108:3:0 +X 1842 . C <*> 0 . DP=18;I16=9,9,0,0,672,26064,0,0,1037,61489,0,0,362,8280,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,124:4:0 0,9,108:3:0 +X 1843 . T <*> 0 . DP=18;I16=9,9,0,0,630,22746,0,0,1037,61489,0,0,364,8366,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,33,243:11:0 0,12,131:4:0 0,9,107:3:0 +X 1844 . T <*> 0 . DP=18;I16=9,9,0,0,618,21618,0,0,1037,61489,0,0,366,8464,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,33,240:11:0 0,12,137:4:0 0,9,98:3:0 +X 1845 . G <*> 0 . DP=18;I16=9,9,0,0,644,23976,0,0,1037,61489,0,0,368,8574,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,138:4:0 0,9,82:3:0 +X 1846 . C <*> 0 . DP=18;I16=9,9,0,0,687,26809,0,0,1037,61489,0,0,370,8696,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,129:4:0 0,9,100:3:0 +X 1847 . T <*> 0 . DP=18;I16=9,9,0,0,675,25529,0,0,1037,61489,0,0,373,8829,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,132:4:0 0,6,76:2:0 +X 1848 . G <*> 0 . DP=18;I16=9,9,0,0,597,20845,0,0,1037,61489,0,0,377,8973,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,118:4:0 0,6,64:2:0 +X 1849 . T <*> 0 . DP=20;I16=9,10,0,0,614,20770,0,0,1097,65089,0,0,380,9078,0,0;QS=3,0;MQSB=0.920044;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,119:4:0 0,6,71:2:0 +X 1850 . C <*> 0 . DP=19;I16=8,11,0,0,684,25154,0,0,1097,65089,0,0,409,9769,0,0;QS=3,0;MQSB=0.902014;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,120:4:0 0,3,37:1:0 +X 1851 . A <*> 0 . DP=20;I16=9,11,0,0,738,27838,0,0,1157,68689,0,0,413,9847,0,0;QS=3,0;MQSB=0.916401;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,143:4:0 0,3,41:1:0 +X 1852 . G <*> 0 . DP=19;I16=8,11,0,0,639,22239,0,0,1097,65089,0,0,392,9264,0,0;QS=3,0;MQSB=0.902014;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,117:4:0 0,3,36:1:0 +X 1853 . G <*> 0 . DP=20;I16=9,11,0,0,627,20873,0,0,1157,68689,0,0,396,9322,0,0;QS=3,0;MQSB=0.916401;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,127:5:0 0,3,38:1:0 +X 1854 . A <*> 0 . DP=22;I16=10,11,0,0,674,22428,0,0,1217,72289,0,0,401,9397,0,0;QS=3,0;MQSB=0.927743;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,145:5:0 0,3,38:1:0 +X 1855 . C <*> 0 . DP=22;I16=10,12,0,0,771,27949,0,0,1277,75889,0,0,407,9441,0,0;QS=3,0;MQSB=0.924723;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,132:5:0 0,3,37:1:0 +X 1856 . A <*> 0 . DP=22;I16=10,12,0,0,806,30230,0,0,1277,75889,0,0,412,9456,0,0;QS=3,0;MQSB=0.924723;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,146:5:0 0,3,41:1:0 +X 1857 . G <*> 0 . DP=22;I16=10,12,0,0,699,23919,0,0,1277,75889,0,0,416,9442,0,0;QS=3,0;MQSB=0.924723;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,134:5:0 0,3,35:1:0 +X 1858 . T <*> 0 . DP=23;I16=10,13,0,0,773,26797,0,0,1337,79489,0,0,419,9399,0,0;QS=3,0;MQSB=0.921963;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,148:5:0 0,3,37:1:0 +X 1859 . G <*> 0 . DP=23;I16=10,13,0,0,798,28594,0,0,1337,79489,0,0,423,9379,0,0;QS=3,0;MQSB=0.921963;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,146:5:0 0,3,36:1:0 +X 1860 . G <*> 0 . DP=23;I16=10,13,0,0,726,23842,0,0,1337,79489,0,0,425,9283,0,0;QS=3,0;MQSB=0.921963;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,126:5:0 0,3,33:1:0 +X 1861 . T <*> 0 . DP=23;I16=10,13,0,0,741,24793,0,0,1337,79489,0,0,425,9113,0,0;QS=3,0;MQSB=0.921963;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,143:5:0 0,3,39:1:0 +X 1862 . C <*> 0 . DP=23;I16=10,12,0,0,738,25732,0,0,1277,75889,0,0,403,8487,0,0;QS=3,0;MQSB=0.924723;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,135:5:0 0,3,34:1:0 +X 1863 . C <*> 0 . DP=24;I16=10,13,0,0,804,29186,0,0,1337,79489,0,0,400,8232,0,0;QS=3,0;MQSB=0.921963;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,133:5:0 0,3,36:1:0 +X 1864 . T <*> 0 . DP=24;I16=11,11,0,0,766,27572,0,0,1277,75889,0,0,392,8174,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,125:4:0 0,3,37:1:0 +X 1865 . G <*> 0 . DP=24;I16=11,13,0,0,860,31394,0,0,1397,83089,0,0,425,8621,0,0;QS=3,0;MQSB=0.931547;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,154:5:0 0,3,38:1:0 +X 1866 . G <*> 0 . DP=24;I16=11,13,0,0,795,27503,0,0,1397,83089,0,0,425,8551,0,0;QS=3,0;MQSB=0.931547;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,152:5:0 0,3,36:1:0 +X 1867 . C <*> 0 . DP=24;I16=9,13,0,0,726,24886,0,0,1320,79200,0,0,375,7263,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,122:5:0 0,3,38:1:0 +X 1868 . C <*> 0 . DP=24;I16=11,12,0,0,857,32293,0,0,1337,79489,0,0,411,8311,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,12,118:4:0 0,3,41:1:0 +X 1869 . A T,<*> 0 . DP=24;I16=6,9,5,4,531,19001,268,8660,857,50689,540,32400,273,5667,152,2866;QS=1.4724,1.5276,0;VDB=0.928022;SGB=-11.9537;RPB=0.984127;MQB=0.96464;MQSB=0.931547;BQB=0.359155;MQ0F=0 PL:DP:DV 115,0,224,148,245,255:18:7 16,0,104,28,107,128:5:1 42,3,0,42,3,42:1:1 +X 1870 . C <*> 0 . DP=25;I16=11,13,0,0,804,27826,0,0,1397,83089,0,0,425,8591,0,0;QS=3,0;MQSB=0.931547;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,127:5:0 0,3,36:1:0 +X 1871 . C <*> 0 . DP=25;I16=11,14,0,0,761,24187,0,0,1457,86689,0,0,428,8690,0,0;QS=3,0;MQSB=0.929204;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,128:6:0 0,3,29:1:0 +X 1872 . G <*> 0 . DP=25;I16=10,14,0,0,763,25437,0,0,1397,83089,0,0,425,8803,0,0;QS=3,0;MQSB=0.919431;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,132:6:0 0,3,43:1:0 +X 1873 . G <*> 0 . DP=26;I16=11,15,0,0,790,25548,0,0,1517,90289,0,0,429,8931,0,0;QS=3,0;MQSB=0.927041;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,151:7:0 0,3,43:1:0 +X 1874 . G <*> 0 . DP=27;I16=11,16,0,0,861,29013,0,0,1577,93889,0,0,430,9076,0,0;QS=3,0;MQSB=0.925036;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,24,172:8:0 0,3,43:1:0 +X 1875 . G <*> 0 . DP=26;I16=11,15,0,0,800,26216,0,0,1517,90289,0,0,431,9155,0,0;QS=3,0;MQSB=0.927041;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,168:7:0 0,3,42:1:0 +X 1876 . C <*> 0 . DP=26;I16=10,15,0,0,894,32714,0,0,1457,86689,0,0,432,9268,0,0;QS=3,0;MQSB=0.9171;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,171:7:0 0,3,41:1:0 +X 1877 . T <*> 0 . DP=25;I16=9,15,0,0,848,30804,0,0,1397,83089,0,0,409,8787,0,0;QS=3,0;MQSB=0.904837;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,163:6:0 0,3,42:1:0 +X 1878 . C <*> 0 . DP=25;I16=10,15,0,0,906,33478,0,0,1457,86689,0,0,434,9488,0,0;QS=3,0;MQSB=0.9171;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,166:7:0 0,3,40:1:0 +X 1879 . A <*> 0 . DP=26;I16=10,16,0,0,911,32761,0,0,1517,90289,0,0,433,9543,0,0;QS=3,0;MQSB=0.914947;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,191:8:0 0,3,40:1:0 +X 1880 . C <*> 0 . DP=26;I16=10,16,0,0,790,24876,0,0,1517,90289,0,0,431,9527,0,0;QS=3,0;MQSB=0.914947;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,152:8:0 0,3,31:1:0 +X 1881 . G <*> 0 . DP=27;I16=10,15,0,0,782,25352,0,0,1500,90000,0,0,380,8288,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,144:7:0 0,3,42:1:0 +X 1882 . G <*> 0 . DP=28;I16=12,15,0,0,937,33215,0,0,1577,93889,0,0,406,8952,0,0;QS=3,0;MQSB=0.935229;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,164:7:0 0,3,42:1:0 +X 1883 . A <*> 0 . DP=29;I16=14,15,0,0,998,35394,0,0,1697,101089,0,0,434,9646,0,0;QS=3,0;MQSB=0.947838;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,24,180:8:0 0,3,43:1:0 +X 1884 . G <*> 0 . DP=29;I16=14,15,0,0,1036,37926,0,0,1697,101089,0,0,437,9647,0,0;QS=3,0;MQSB=0.947838;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,24,202:8:0 0,3,42:1:0 +X 1885 . C <*> 0 . DP=28;I16=14,13,0,0,925,32305,0,0,1577,93889,0,0,430,9560,0,0;QS=3,0;MQSB=0.951472;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,182:7:0 0,3,42:1:0 +X 1886 . C <*> 0 . DP=26;I16=13,13,0,0,826,27194,0,0,1517,90289,0,0,447,9745,0,0;QS=3,0;MQSB=0.945959;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,166:8:0 0,3,32:1:0 +X 1887 . G <*> 0 . DP=26;I16=12,13,0,0,798,26554,0,0,1500,90000,0,0,428,9212,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,185:8:0 0,3,40:1:0 +X 1888 . C <*> 0 . DP=26;I16=13,13,0,0,901,32343,0,0,1517,90289,0,0,459,9957,0,0;QS=3,0;MQSB=0.945959;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,178:8:0 0,3,39:1:0 +X 1889 . C <*> 0 . DP=25;I16=13,11,0,0,825,29127,0,0,1397,83089,0,0,444,9612,0,0;QS=3,0;MQSB=0.950498;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,187:7:0 0,3,37:1:0 +X 1890 . C <*> 0 . DP=25;I16=13,12,0,0,913,34029,0,0,1457,86689,0,0,471,10173,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,198:8:0 0,3,40:1:0 +X 1891 . T <*> 0 . DP=25;I16=13,12,0,0,912,34028,0,0,1457,86689,0,0,477,10317,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,212:8:0 0,3,39:1:0 +X 1892 . G <*> 0 . DP=25;I16=12,12,0,0,885,33149,0,0,1397,83089,0,0,458,9860,0,0;QS=3,0;MQSB=0.941765;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,166:7:0 0,3,37:1:0 +X 1893 . T <*> 0 . DP=26;I16=14,12,0,0,920,33494,0,0,1517,90289,0,0,489,10677,0,0;QS=3,0;MQSB=0.953497;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,205:8:0 0,6,72:2:0 +X 1894 . G <*> 0 . DP=26;I16=14,12,0,0,934,35048,0,0,1517,90289,0,0,495,10843,0,0;QS=3,0;MQSB=0.953497;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,188:8:0 0,6,75:2:0 +X 1895 . C <*> 0 . DP=26;I16=13,12,0,0,882,31980,0,0,1500,90000,0,0,476,10408,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,24,180:8:0 0,6,73:2:0 +X 1896 . C <*> 0 . DP=26;I16=14,11,0,0,827,28179,0,0,1457,86689,0,0,482,10622,0,0;QS=3,0;MQSB=0.955682;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,154:7:0 0,6,72:2:0 +X 1897 . G <*> 0 . DP=26;I16=13,11,0,0,763,25169,0,0,1397,83089,0,0,486,10856,0,0;QS=3,0;MQSB=0.950498;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,164:7:0 0,3,27:1:0 +X 1898 . T <*> 0 . DP=27;I16=14,11,0,0,846,29526,0,0,1500,90000,0,0,492,11072,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,24,187:8:0 0,6,62:2:0 +X 1899 . G <*> 0 . DP=27;I16=14,11,0,0,875,32007,0,0,1500,90000,0,0,497,11213,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,24,188:8:0 0,6,61:2:0 +X 1900 . T <*> 0 . DP=26;I16=14,11,0,0,850,29882,0,0,1500,90000,0,0,501,11329,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,24,185:8:0 0,6,69:2:0 +X 1901 . A <*> 0 . DP=27;I16=15,10,0,0,842,29298,0,0,1457,86689,0,0,505,11469,0,0;QS=3,0;MQSB=0.962269;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,190:7:0 0,6,68:2:0 +X 1902 . C <*> 0 . DP=27;I16=15,12,0,0,912,31970,0,0,1577,93889,0,0,537,12267,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,184:8:0 0,6,60:2:0 +X 1903 . C <*> 0 . DP=27;I16=15,12,0,0,959,34645,0,0,1577,93889,0,0,542,12462,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,201:8:0 0,6,63:2:0 +X 1904 . T <*> 0 . DP=27;I16=16,11,0,0,1017,38757,0,0,1577,93889,0,0,548,12682,0,0;QS=3,0;MQSB=0.96384;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,221:8:0 0,6,77:2:0 +X 1905 . C <*> 0 . DP=27;I16=16,11,0,0,985,36561,0,0,1577,93889,0,0,553,12827,0,0;QS=3,0;MQSB=0.96384;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,211:8:0 0,6,69:2:0 +X 1906 . T <*> 0 . DP=27;I16=16,11,0,0,1018,39242,0,0,1577,93889,0,0,558,12998,0,0;QS=3,0;MQSB=0.96384;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,207:8:0 0,6,75:2:0 +X 1907 . G <*> 0 . DP=27;I16=15,11,0,0,935,34679,0,0,1517,90289,0,0,535,12419,0,0;QS=3,0;MQSB=0.960078;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,187:7:0 0,6,68:2:0 +X 1908 . A <*> 0 . DP=28;I16=16,12,0,0,1023,38221,0,0,1637,97489,0,0,561,13063,0,0;QS=3,0;MQSB=0.96195;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,24,215:8:0 0,6,67:2:0 +X 1909 . G <*> 0 . DP=27;I16=15,12,0,0,1002,38398,0,0,1577,93889,0,0,561,12953,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,206:8:0 0,6,73:2:0 +X 1910 . C <*> 0 . DP=27;I16=14,10,0,0,855,31251,0,0,1440,86400,0,0,502,11588,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,179:7:0 0,6,71:2:0 +X 1911 . C <*> 0 . DP=27;I16=15,12,0,0,967,35429,0,0,1577,93889,0,0,561,12793,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,206:8:0 0,6,71:2:0 +X 1912 . C <*> 0 . DP=27;I16=15,12,0,0,1024,39272,0,0,1577,93889,0,0,561,12743,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,217:8:0 0,6,73:2:0 +X 1913 . T <*> 0 . DP=27;I16=15,12,0,0,1028,39768,0,0,1577,93889,0,0,561,12713,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,228:8:0 0,6,77:2:0 +X 1914 . C <*> 0 . DP=27;I16=15,12,0,0,1010,38762,0,0,1577,93889,0,0,561,12703,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,221:8:0 0,6,75:2:0 +X 1915 . T C,<*> 0 . DP=27;I16=14,12,1,0,974,37184,16,256,1560,93600,17,289,543,12389,18,324;QS=2.97351,0.0264901,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.958048;BQB=1;MQ0F=0 PL:DP:DV 0,34,255,48,255,255:17:1 0,24,231,24,231,231:8:0 0,6,60,6,60,60:2:0 +X 1916 . G T,<*> 0 . DP=27;I16=14,12,1,0,991,38291,15,225,1560,93600,17,289,544,12454,17,289;QS=2.97581,0.0241935,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.958048;BQB=1;MQ0F=0 PL:DP:DV 0,35,255,48,255,255:17:1 0,24,226,24,226,226:8:0 0,6,69,6,69,69:2:0 +X 1917 . C <*> 0 . DP=27;I16=15,12,0,0,1030,39740,0,0,1577,93889,0,0,561,12793,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,214:8:0 0,6,73:2:0 +X 1918 . A <*> 0 . DP=27;I16=15,11,0,0,963,36201,0,0,1517,90289,0,0,542,12502,0,0;QS=3,0;MQSB=0.960078;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,217:8:0 0,6,72:2:0 +X 1919 . C <*> 0 . DP=27;I16=15,12,0,0,987,36651,0,0,1577,93889,0,0,560,12902,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,214:8:0 0,6,72:2:0 +X 1920 . A T,<*> 0 . DP=29;I16=15,12,0,1,1007,38337,14,196,1546,91130,60,3600,538,12518,21,441;QS=2.97647,0.0235294,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.999735;BQB=1;MQ0F=0 PL:DP:DV 0,36,255,48,255,255:17:1 0,24,225,24,225,225:8:0 0,9,101,9,101,101:3:0 +X 1921 . G <*> 0 . DP=30;I16=15,14,0,0,1059,39815,0,0,1666,98330,0,0,542,12474,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,182:7:0 0,12,132:4:0 +X 1922 . T <*> 0 . DP=29;I16=14,14,0,0,1013,37513,0,0,1649,98041,0,0,532,12418,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,197:7:0 0,12,134:4:0 +X 1923 . G <*> 0 . DP=28;I16=14,14,0,0,1034,38974,0,0,1606,94730,0,0,545,12629,0,0;QS=3,0;MQSB=0.999736;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,188:7:0 0,12,126:4:0 +X 1924 . C <*> 0 . DP=27;I16=13,13,0,0,965,36587,0,0,1486,87530,0,0,521,12017,0,0;QS=3,0;MQSB=0.999671;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,183:7:0 0,12,116:4:0 +X 1925 . C <*> 0 . DP=27;I16=14,13,0,0,987,37021,0,0,1546,91130,0,0,546,12626,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,187:7:0 0,12,124:4:0 +X 1926 . T <*> 0 . DP=27;I16=14,13,0,0,1031,40057,0,0,1546,91130,0,0,545,12581,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,197:7:0 0,12,141:4:0 +X 1927 . T <*> 0 . DP=27;I16=13,13,0,0,959,35773,0,0,1529,90841,0,0,538,12522,0,0;QS=3,0;MQSB=0.945959;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,191:7:0 0,12,133:4:0 +X 1928 . C <*> 0 . DP=27;I16=13,13,0,0,986,38264,0,0,1529,90841,0,0,538,12532,0,0;QS=3,0;MQSB=0.945959;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,189:7:0 0,12,125:4:0 +X 1929 . T <*> 0 . DP=27;I16=13,13,0,0,990,38630,0,0,1529,90841,0,0,538,12562,0,0;QS=3,0;MQSB=0.945959;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,189:7:0 0,12,139:4:0 +X 1930 . G <*> 0 . DP=26;I16=13,11,0,0,905,34865,0,0,1409,83641,0,0,521,12271,0,0;QS=3,0;MQSB=0.931547;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,179:6:0 0,9,99:3:0 +X 1931 . C <*> 0 . DP=27;I16=15,12,0,0,967,36293,0,0,1546,91130,0,0,540,12578,0,0;QS=3,0;MQSB=0.99881;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,165:6:0 0,12,121:4:0 +X 1932 . T <*> 0 . DP=27;I16=14,13,0,0,998,38154,0,0,1546,91130,0,0,541,12605,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,143:5:0 0,15,146:5:0 +X 1933 . T <*> 0 . DP=27;I16=14,13,0,0,962,35344,0,0,1546,91130,0,0,542,12602,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,142:5:0 0,15,158:5:0 +X 1934 . G <*> 0 . DP=27;I16=13,13,0,0,987,38219,0,0,1529,90841,0,0,543,12569,0,0;QS=3,0;MQSB=0.945959;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,134:5:0 0,15,143:5:0 +X 1935 . C <*> 0 . DP=27;I16=14,12,0,0,963,36627,0,0,1529,90841,0,0,520,11930,0,0;QS=3,0;MQSB=0.937241;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,162:6:0 0,15,154:5:0 +X 1936 . C <*> 0 . DP=27;I16=14,13,0,0,1018,39406,0,0,1589,94441,0,0,547,12561,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,177:6:0 0,15,159:5:0 +X 1937 . T <*> 0 . DP=27;I16=14,13,0,0,1036,40636,0,0,1589,94441,0,0,547,12489,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,182:6:0 0,15,170:5:0 +X 1938 . G <*> 0 . DP=27;I16=14,13,0,0,1001,38377,0,0,1589,94441,0,0,546,12392,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,166:6:0 0,15,155:5:0 +X 1939 . T <*> 0 . DP=27;I16=14,12,0,0,964,36430,0,0,1560,93600,0,0,525,11909,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,167:6:0 0,12,144:4:0 +X 1940 . G <*> 0 . DP=27;I16=14,13,0,0,1003,37937,0,0,1589,94441,0,0,542,12172,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,159:6:0 0,15,155:5:0 +X 1941 . G <*> 0 . DP=27;I16=14,13,0,0,1004,38072,0,0,1589,94441,0,0,540,12098,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,176:6:0 0,15,156:5:0 +X 1942 . C <*> 0 . DP=27;I16=14,12,0,0,996,38790,0,0,1560,93600,0,0,516,11564,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,174:6:0 0,12,140:4:0 +X 1943 . T <*> 0 . DP=27;I16=14,13,0,0,1044,40952,0,0,1589,94441,0,0,536,12022,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,184:6:0 0,15,167:5:0 +X 1944 . T <*> 0 . DP=27;I16=14,13,0,0,987,37237,0,0,1589,94441,0,0,533,11971,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,175:6:0 0,15,170:5:0 +X 1945 . T <*> 0 . DP=27;I16=14,13,0,0,993,37067,0,0,1589,94441,0,0,530,11946,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,174:6:0 0,15,171:5:0 +X 1946 . G <*> 0 . DP=27;I16=14,13,0,0,1013,38617,0,0,1589,94441,0,0,526,11896,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,162:6:0 0,15,162:5:0 +X 1947 . A <*> 0 . DP=26;I16=13,13,0,0,950,35522,0,0,1529,90841,0,0,522,11818,0,0;QS=3,0;MQSB=0.945959;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,167:6:0 0,15,160:5:0 +X 1948 . G C,<*> 0 . DP=27;I16=14,12,0,1,966,36912,16,256,1560,93600,29,841,493,11135,25,625;QS=2.90361,0.0963855,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.94394;BQB=1;MQ0F=0 PL:DP:DV 0,45,255,45,255,255:15:0 0,21,190,21,190,190:7:0 1,0,123,13,126,132:5:1 +X 1949 . A <*> 0 . DP=26;I16=14,11,0,0,871,31325,0,0,1469,87241,0,0,490,11048,0,0;QS=3,0;MQSB=0.929204;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,174:7:0 0,15,155:5:0 +X 1950 . A <*> 0 . DP=27;I16=14,13,0,0,1007,38049,0,0,1589,94441,0,0,511,11559,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,21,205:7:0 0,18,176:6:0 +X 1951 . G <*> 0 . DP=27;I16=14,13,0,0,960,35536,0,0,1589,94441,0,0,509,11469,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,21,180:7:0 0,18,181:6:0 +X 1952 . A <*> 0 . DP=27;I16=14,12,0,0,924,33366,0,0,1529,90841,0,0,483,10779,0,0;QS=3,0;MQSB=0.937241;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,184:7:0 0,18,182:6:0 +X 1953 . A <*> 0 . DP=28;I16=15,12,0,0,925,32719,0,0,1589,94441,0,0,482,10740,0,0;QS=3,0;MQSB=0.935229;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,21,189:7:0 0,18,168:6:0 +X 1954 . A C,<*> 0 . DP=29;I16=14,13,0,1,929,33219,18,324,1620,97200,29,841,475,10679,25,625;QS=2.90217,0.0978261,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.949591;BQB=1;MQ0F=0 PL:DP:DV 0,45,255,45,255,255:15:0 0,21,198,21,198,198:7:0 0,0,130,15,133,141:6:1 +X 1955 . C <*> 0 . DP=29;I16=14,12,0,0,961,36067,0,0,1560,93600,0,0,451,10035,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,21,206:7:0 0,15,165:5:0 +X 1956 . C <*> 0 . DP=29;I16=14,13,0,0,964,35402,0,0,1620,97200,0,0,475,10573,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,196:7:0 0,15,164:5:0 +X 1957 . C <*> 0 . DP=29;I16=14,13,0,0,980,36212,0,0,1620,97200,0,0,472,10420,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,183:7:0 0,15,167:5:0 +X 1958 . C <*> 0 . DP=29;I16=15,13,0,0,1003,37293,0,0,1649,98041,0,0,493,10825,0,0;QS=3,0;MQSB=0.942064;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,191:7:0 0,18,190:6:0 +X 1959 . T <*> 0 . DP=29;I16=16,13,0,0,1112,43258,0,0,1709,101641,0,0,491,10593,0,0;QS=3,0;MQSB=0.940317;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,213:7:0 0,18,193:6:0 +X 1960 . T <*> 0 . DP=30;I16=17,13,0,0,1053,37939,0,0,1769,105241,0,0,485,10339,0,0;QS=3,0;MQSB=0.938685;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,196:7:0 0,18,186:6:0 +X 1961 . C <*> 0 . DP=30;I16=17,13,0,0,1101,41737,0,0,1769,105241,0,0,480,10122,0,0;QS=3,0;MQSB=0.938685;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,195:7:0 0,18,183:6:0 +X 1962 . T <*> 0 . DP=29;I16=17,12,0,0,1134,44582,0,0,1709,101641,0,0,477,9941,0,0;QS=3,0;MQSB=0.931617;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,208:7:0 0,18,198:6:0 +X 1963 . G <*> 0 . DP=28;I16=16,12,0,0,1066,41050,0,0,1649,98041,0,0,476,9794,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,192:7:0 0,18,188:6:0 +X 1964 . G <*> 0 . DP=28;I16=16,12,0,0,970,34764,0,0,1649,98041,0,0,475,9681,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,178:7:0 0,18,169:6:0 +X 1965 . T <*> 0 . DP=29;I16=16,12,0,0,964,34772,0,0,1649,98041,0,0,449,8977,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,196:7:0 0,18,171:6:0 +X 1966 . T <*> 0 . DP=29;I16=16,13,0,0,1029,37027,0,0,1709,101641,0,0,474,9558,0,0;QS=3,0;MQSB=0.940317;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,191:7:0 0,18,181:6:0 +X 1967 . A <*> 0 . DP=29;I16=16,13,0,0,1030,37234,0,0,1709,101641,0,0,474,9550,0,0;QS=3,0;MQSB=0.940317;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,187:7:0 0,18,182:6:0 +X 1968 . T <*> 0 . DP=29;I16=16,13,0,0,1075,40173,0,0,1709,101641,0,0,474,9578,0,0;QS=3,0;MQSB=0.940317;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,195:7:0 0,18,190:6:0 +X 1969 . A <*> 0 . DP=28;I16=16,12,0,0,992,35828,0,0,1649,98041,0,0,474,9592,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,175:6:0 0,18,186:6:0 +X 1970 . C <*> 0 . DP=28;I16=16,12,0,0,1015,37503,0,0,1649,98041,0,0,474,9642,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,170:6:0 0,18,180:6:0 +X 1971 . A <*> 0 . DP=29;I16=16,13,0,0,1073,40273,0,0,1709,101641,0,0,474,9728,0,0;QS=3,0;MQSB=0.940317;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,178:6:0 0,21,206:7:0 +X 1972 . T <*> 0 . DP=30;I16=16,14,0,0,1068,38978,0,0,1769,105241,0,0,475,9851,0,0;QS=3,0;MQSB=0.946202;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,176:6:0 0,21,203:7:0 +X 1973 . A <*> 0 . DP=30;I16=16,13,0,0,1046,38070,0,0,1740,104400,0,0,452,9388,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,172:6:0 0,18,196:6:0 +X 1974 . A <*> 0 . DP=29;I16=16,13,0,0,1086,41474,0,0,1709,101641,0,0,477,10065,0,0;QS=3,0;MQSB=0.940317;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,157:5:0 0,21,214:7:0 +X 1975 . G <*> 0 . DP=28;I16=16,12,0,0,1067,41171,0,0,1649,98041,0,0,478,10156,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,133:4:0 0,21,195:7:0 +X 1976 . A <*> 0 . DP=28;I16=16,12,0,0,981,34839,0,0,1649,98041,0,0,478,10234,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,125:4:0 0,21,199:7:0 +X 1977 . C <*> 0 . DP=28;I16=16,12,0,0,1009,37471,0,0,1649,98041,0,0,477,10297,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,132:4:0 0,21,194:7:0 +X 1978 . A <*> 0 . DP=28;I16=16,12,0,0,1082,42132,0,0,1649,98041,0,0,476,10394,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,144:4:0 0,21,220:7:0 +X 1979 . G <*> 0 . DP=28;I16=16,11,0,0,1019,38927,0,0,1589,94441,0,0,454,10064,0,0;QS=3,0;MQSB=0.925036;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,122:4:0 0,21,208:7:0 +X 1980 . C <*> 0 . DP=27;I16=16,10,0,0,932,34456,0,0,1529,90841,0,0,452,10114,0,0;QS=3,0;MQSB=0.914947;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,107:3:0 0,21,197:7:0 +X 1981 . C <*> 0 . DP=28;I16=16,12,0,0,998,36510,0,0,1649,98041,0,0,469,10479,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,9,101:3:0 0,24,219:8:0 +X 1982 . A <*> 0 . DP=29;I16=16,12,0,0,1035,38815,0,0,1649,98041,0,0,472,10548,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,110:3:0 0,27,254:9:0 +X 1983 . G <*> 0 . DP=28;I16=16,12,0,0,1048,40322,0,0,1649,98041,0,0,477,10599,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,96:3:0 0,27,249:9:0 +X 1984 . A <*> 0 . DP=27;I16=16,11,0,0,1024,39232,0,0,1589,94441,0,0,482,10632,0,0;QS=3,0;MQSB=0.925036;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,70:2:0 0,27,255:9:0 +X 1985 . G <*> 0 . DP=27;I16=16,11,0,0,1009,38449,0,0,1589,94441,0,0,487,10695,0,0;QS=3,0;MQSB=0.925036;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,66:2:0 0,27,231:9:0 +X 1986 . A <*> 0 . DP=27;I16=16,10,0,0,926,33696,0,0,1560,93600,0,0,466,10112,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,76:2:0 0,24,223:8:0 +X 1987 . A <*> 0 . DP=28;I16=17,11,0,0,1034,39088,0,0,1649,98041,0,0,495,10807,0,0;QS=3,0;MQSB=0.923174;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,78:2:0 0,27,247:9:0 +X 1988 . G <*> 0 . DP=28;I16=17,11,0,0,1050,39980,0,0,1649,98041,0,0,499,10855,0,0;QS=3,0;MQSB=0.923174;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,63:2:0 0,27,239:9:0 +X 1989 . G <*> 0 . DP=28;I16=17,10,0,0,994,37610,0,0,1589,94441,0,0,493,10801,0,0;QS=3,0;MQSB=0.912952;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,73:2:0 0,27,237:9:0 +X 1990 . G T,<*> 0 . DP=28;I16=17,9,0,1,965,36359,33,1089,1560,93600,29,841,472,10250,25,625;QS=2.90675,0.0932476,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.912952;BQB=1;MQ0F=0 PL:DP:DV 0,48,255,48,255,255:16:0 0,6,71,6,71,71:2:0 2,0,195,26,198,215:9:1 +X 1991 . A <*> 0 . DP=28;I16=17,11,0,0,1017,38203,0,0,1649,98041,0,0,507,10975,0,0;QS=3,0;MQSB=0.923174;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,60:2:0 0,27,250:9:0 +X 1992 . G <*> 0 . DP=28;I16=17,11,0,0,1028,38852,0,0,1649,98041,0,0,509,11039,0,0;QS=3,0;MQSB=0.923174;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,62:2:0 0,27,231:9:0 +X 1993 . T <*> 0 . DP=28;I16=17,11,0,0,1015,37325,0,0,1649,98041,0,0,511,11131,0,0;QS=3,0;MQSB=0.923174;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,59:2:0 0,27,243:9:0 +X 1994 . T <*> 0 . DP=27;I16=16,11,0,0,942,33698,0,0,1589,94441,0,0,514,11250,0,0;QS=3,0;MQSB=0.925036;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,54:2:0 0,24,216:8:0 +X 1995 . G <*> 0 . DP=28;I16=16,11,0,0,960,35432,0,0,1620,97200,0,0,492,10770,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,66:2:0 0,21,188:7:0 +X 1996 . C <*> 0 . DP=29;I16=17,12,0,0,1022,37426,0,0,1709,101641,0,0,519,11469,0,0;QS=3,0;MQSB=0.931617;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,64:2:0 0,24,192:8:0 +X 1997 . C <*> 0 . DP=29;I16=17,11,0,0,934,32858,0,0,1649,98041,0,0,520,11524,0,0;QS=3,0;MQSB=0.923174;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,70:2:0 0,24,193:8:0 +X 1998 . C <*> 0 . DP=29;I16=17,12,0,0,1027,37843,0,0,1709,101641,0,0,522,11562,0,0;QS=3,0;MQSB=0.931617;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,69:2:0 0,24,222:8:0 +X 1999 . A <*> 0 . DP=28;I16=17,11,0,0,1073,41493,0,0,1649,98041,0,0,525,11627,0,0;QS=3,0;MQSB=0.923174;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,72:2:0 0,21,206:7:0 +X 2000 . G <*> 0 . DP=28;I16=16,11,0,0,1036,40576,0,0,1589,94441,0,0,511,11395,0,0;QS=3,0;MQSB=0.925036;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,72:2:0 0,18,168:6:0 +X 2001 . G <*> 0 . DP=28;I16=15,11,0,0,955,35661,0,0,1529,90841,0,0,489,10853,0,0;QS=3,0;MQSB=0.927041;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,62:2:0 0,18,172:6:0 +X 2002 . G <*> 0 . DP=28;I16=17,10,0,0,907,32227,0,0,1620,97200,0,0,519,11663,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,53:2:0 0,18,163:6:0 +X 2003 . T <*> 0 . DP=28;I16=17,11,0,0,920,31866,0,0,1649,98041,0,0,541,12163,0,0;QS=3,0;MQSB=0.923174;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,49:2:0 0,21,190:7:0 +X 2004 . G <*> 0 . DP=27;I16=16,10,0,0,970,36928,0,0,1560,93600,0,0,530,12110,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,57:2:0 0,18,178:6:0 +X 2005 . G <*> 0 . DP=27;I16=16,10,0,0,868,30936,0,0,1560,93600,0,0,536,12370,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,59:2:0 0,18,153:6:0 +X 2006 . C <*> 0 . DP=27;I16=16,10,0,0,968,37046,0,0,1560,93600,0,0,541,12605,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,73:2:0 0,18,166:6:0 +X 2007 . A <*> 0 . DP=27;I16=16,11,0,0,1000,37396,0,0,1589,94441,0,0,556,12882,0,0;QS=3,0;MQSB=0.925036;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,76:2:0 0,21,193:7:0 +X 2008 . C <*> 0 . DP=26;I16=16,10,0,0,964,36892,0,0,1529,90841,0,0,555,12833,0,0;QS=3,0;MQSB=0.914947;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,73:2:0 0,21,183:7:0 +X 2009 . A <*> 0 . DP=26;I16=16,10,0,0,997,38955,0,0,1529,90841,0,0,554,12802,0,0;QS=3,0;MQSB=0.914947;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,74:2:0 0,21,210:7:0 +X 2010 . G <*> 0 . DP=26;I16=16,9,0,0,936,36208,0,0,1500,90000,0,0,542,12640,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,73:2:0 0,18,169:6:0 +X 2011 . C <*> 0 . DP=26;I16=16,9,0,0,966,37960,0,0,1500,90000,0,0,541,12617,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,74:2:0 0,18,175:6:0 +X 2012 . A <*> 0 . DP=27;I16=16,11,0,0,956,35018,0,0,1589,94441,0,0,548,12676,0,0;QS=3,0;MQSB=0.925036;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,74:2:0 0,21,189:7:0 +X 2013 . C <*> 0 . DP=27;I16=15,10,0,0,876,31370,0,0,1500,90000,0,0,514,11950,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,69:2:0 0,18,160:6:0 +X 2014 . G <*> 0 . DP=27;I16=17,10,0,0,903,31239,0,0,1589,94441,0,0,545,12591,0,0;QS=3,0;MQSB=0.912952;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,9,80:3:0 0,18,160:6:0 +X 2015 . T <*> 0 . DP=27;I16=17,10,0,0,999,37507,0,0,1589,94441,0,0,545,12577,0,0;QS=3,0;MQSB=0.912952;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,9,95:3:0 0,18,178:6:0 +X 2016 . T <*> 0 . DP=27;I16=17,10,0,0,971,35649,0,0,1589,94441,0,0,545,12583,0,0;QS=3,0;MQSB=0.912952;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,9,93:3:0 0,18,178:6:0 +X 2017 . G <*> 0 . DP=28;I16=17,11,0,0,1013,37849,0,0,1649,98041,0,0,545,12609,0,0;QS=3,0;MQSB=0.923174;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,9,91:3:0 0,18,172:6:0 +X 2018 . C <*> 0 . DP=28;I16=17,11,0,0,1060,41414,0,0,1649,98041,0,0,546,12656,0,0;QS=3,0;MQSB=0.923174;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,9,97:3:0 0,18,169:6:0 +X 2019 . T <*> 0 . DP=28;I16=17,11,0,0,1083,42253,0,0,1649,98041,0,0,547,12725,0,0;QS=3,0;MQSB=0.923174;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,9,106:3:0 0,18,187:6:0 +X 2020 . G <*> 0 . DP=29;I16=18,11,0,0,1095,42063,0,0,1678,98882,0,0,548,12816,0,0;QS=3,0;MQSB=0.987702;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,9,85:3:0 0,18,175:6:0 +X 2021 . C <*> 0 . DP=29;I16=18,11,0,0,1081,41535,0,0,1709,101641,0,0,551,12877,0,0;QS=3,0;MQSB=0.969907;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,9,97:3:0 0,15,167:5:0 +X 2022 . C <*> 0 . DP=30;I16=19,11,0,0,1115,42003,0,0,1769,105241,0,0,555,12907,0,0;QS=3,0;MQSB=0.972375;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,9,92:3:0 0,18,177:6:0 +X 2023 . A <*> 0 . DP=30;I16=19,10,0,0,1063,39991,0,0,1709,101641,0,0,549,12837,0,0;QS=3,0;MQSB=0.974027;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,9,96:3:0 0,18,186:6:0 +X 2024 . G <*> 0 . DP=32;I16=20,12,0,0,1168,43872,0,0,1889,112441,0,0,564,12982,0,0;QS=3,0;MQSB=0.973096;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,9,92:3:0 0,24,203:8:0 +X 2025 . T <*> 0 . DP=32;I16=20,12,0,0,1150,42122,0,0,1889,112441,0,0,569,12981,0,0;QS=3,0;MQSB=0.973096;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,9,87:3:0 0,24,226:8:0 +X 2026 . T <*> 0 . DP=32;I16=20,12,0,0,1130,40724,0,0,1889,112441,0,0,572,12908,0,0;QS=3,0;MQSB=0.973096;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,9,94:3:0 0,24,208:8:0 +X 2027 . A <*> 0 . DP=32;I16=19,12,0,0,1121,40871,0,0,1829,108841,0,0,550,12240,0,0;QS=3,0;MQSB=0.970829;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,9,84:3:0 0,21,207:7:0 +X 2028 . C <*> 0 . DP=32;I16=20,12,0,0,1242,48548,0,0,1889,112441,0,0,577,12803,0,0;QS=3,0;MQSB=0.973096;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,9,94:3:0 0,24,228:8:0 +X 2029 . T <*> 0 . DP=32;I16=20,12,0,0,1229,47605,0,0,1889,112441,0,0,578,12724,0,0;QS=3,0;MQSB=0.973096;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,9,102:3:0 0,24,236:8:0 +X 2030 . G <*> 0 . DP=32;I16=20,12,0,0,1222,47140,0,0,1889,112441,0,0,579,12679,0,0;QS=3,0;MQSB=0.973096;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,9,93:3:0 0,24,216:8:0 +X 2031 . C <*> 0 . DP=31;I16=19,12,0,0,1150,43656,0,0,1829,108841,0,0,581,12667,0,0;QS=3,0;MQSB=0.970829;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,9,96:3:0 0,24,204:8:0 +X 2032 . C <*> 0 . DP=31;I16=19,12,0,0,1157,44035,0,0,1829,108841,0,0,583,12687,0,0;QS=3,0;MQSB=0.970829;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,9,90:3:0 0,24,210:8:0 +X 2033 . A <*> 0 . DP=30;I16=19,11,0,0,1091,40223,0,0,1769,105241,0,0,585,12689,0,0;QS=3,0;MQSB=0.972375;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,9,93:3:0 0,21,203:7:0 +X 2034 . T <*> 0 . DP=30;I16=19,11,0,0,1104,41498,0,0,1769,105241,0,0,587,12723,0,0;QS=3,0;MQSB=0.972375;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,9,91:3:0 0,21,208:7:0 +X 2035 . T <*> 0 . DP=29;I16=18,11,0,0,1084,41024,0,0,1709,101641,0,0,589,12739,0,0;QS=3,0;MQSB=0.969907;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,6,69:2:0 0,21,211:7:0 +X 2036 . T <*> 0 . DP=29;I16=18,11,0,0,1080,40612,0,0,1709,101641,0,0,591,12787,0,0;QS=3,0;MQSB=0.969907;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,6,67:2:0 0,21,216:7:0 +X 2037 . T <*> 0 . DP=29;I16=18,11,0,0,1082,40956,0,0,1709,101641,0,0,592,12818,0,0;QS=3,0;MQSB=0.969907;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,6,69:2:0 0,21,217:7:0 +X 2038 . C <*> 0 . DP=29;I16=18,11,0,0,1117,43573,0,0,1709,101641,0,0,592,12832,0,0;QS=3,0;MQSB=0.969907;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,6,69:2:0 0,21,211:7:0 +X 2039 . A <*> 0 . DP=29;I16=18,11,0,0,1067,39581,0,0,1709,101641,0,0,592,12878,0,0;QS=3,0;MQSB=0.969907;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,6,72:2:0 0,21,212:7:0 +X 2040 . C <*> 0 . DP=29;I16=18,11,0,0,1077,40469,0,0,1709,101641,0,0,590,12856,0,0;QS=3,0;MQSB=0.969907;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,6,69:2:0 0,21,196:7:0 +X 2041 . G A,<*> 0 . DP=31;I16=6,5,12,7,389,14023,721,28149,660,39600,1109,65641,235,5607,353,7259;QS=0.917304,2.0827,0;VDB=0.816435;SGB=-4.18892;RPB=0.88473;MQB=0.972375;MQSB=0.968257;BQB=0.311275;MQ0F=0 PL:DP:DV 229,0,212,255,245,255:21:11 32,0,24,35,27,59:2:1 223,21,0,223,21,223:7:7 +X 2042 . G <*> 0 . DP=32;I16=18,14,0,0,1189,45617,0,0,1889,112441,0,0,588,12910,0,0;QS=3,0;MQSB=0.965264;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,9,86:3:0 0,21,206:7:0 +X 2043 . G <*> 0 . DP=32;I16=17,14,0,0,1115,41585,0,0,1829,108841,0,0,581,12891,0,0;QS=3,0;MQSB=0.962133;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,9,90:3:0 0,21,197:7:0 +X 2044 . C <*> 0 . DP=32;I16=18,14,0,0,1213,47029,0,0,1889,112441,0,0,588,13006,0,0;QS=3,0;MQSB=0.965264;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,9,85:3:0 0,21,207:7:0 +X 2045 . A <*> 0 . DP=32;I16=18,14,0,0,1181,44527,0,0,1889,112441,0,0,588,13108,0,0;QS=3,0;MQSB=0.965264;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,9,83:3:0 0,21,213:7:0 +X 2046 . T <*> 0 . DP=32;I16=18,14,0,0,1197,45135,0,0,1889,112441,0,0,587,13195,0,0;QS=3,0;MQSB=0.965264;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,9,103:3:0 0,21,216:7:0 +X 2047 . G <*> 0 . DP=34;I16=17,16,0,0,1248,47798,0,0,1949,116041,0,0,557,12491,0,0;QS=3,0;MQSB=0.959328;MQ0F=0 PL:DP:DV 0,72,255:24:0 0,9,88:3:0 0,18,195:6:0 +X 2048 . A <*> 0 . DP=34;I16=18,16,0,0,1230,45184,0,0,2009,119641,0,0,578,13022,0,0;QS=3,0;MQSB=0.962621;MQ0F=0 PL:DP:DV 0,72,255:24:0 0,9,87:3:0 0,21,206:7:0 +X 2049 . A <*> 0 . DP=33;I16=17,16,0,0,1207,44567,0,0,1949,116041,0,0,575,12963,0,0;QS=3,0;MQSB=0.959328;MQ0F=0 PL:DP:DV 0,72,255:24:0 0,6,74:2:0 0,21,208:7:0 +X 2050 . A <*> 0 . DP=33;I16=16,16,0,0,1169,43313,0,0,1889,112441,0,0,545,12211,0,0;QS=3,0;MQSB=0.955563;MQ0F=0 PL:DP:DV 0,72,255:24:0 0,6,77:2:0 0,18,188:6:0 +X 2051 . T <*> 0 . DP=31;I16=16,15,0,0,1134,42164,0,0,1829,108841,0,0,567,12737,0,0;QS=3,0;MQSB=0.957006;MQ0F=0 PL:DP:DV 0,69,255:23:0 0,6,69:2:0 0,18,170:6:0 +X 2052 . G <*> 0 . DP=31;I16=16,15,0,0,1180,45546,0,0,1829,108841,0,0,564,12664,0,0;QS=3,0;MQSB=0.957006;MQ0F=0 PL:DP:DV 0,69,255:23:0 0,6,74:2:0 0,18,175:6:0 +X 2053 . G T,<*> 0 . DP=31;I16=15,15,0,1,1126,42672,23,529,1769,105241,60,3600,537,11991,25,625;QS=2.97307,0.0269321,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.951229;BQB=1;MQ0F=0 PL:DP:DV 0,46,255,66,255,255:23:1 0,6,71,6,71,71:2:0 0,18,180,18,180,180:6:0 +X 2054 . A <*> 0 . DP=30;I16=15,15,0,0,1123,43027,0,0,1769,105241,0,0,562,12592,0,0;QS=3,0;MQSB=0.952765;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,6,78:2:0 0,18,171:6:0 +X 2055 . G <*> 0 . DP=30;I16=15,15,0,0,1156,45206,0,0,1769,105241,0,0,562,12592,0,0;QS=3,0;MQSB=0.952765;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,6,66:2:0 0,18,168:6:0 +X 2056 . A <*> 0 . DP=30;I16=15,15,0,0,1124,42416,0,0,1769,105241,0,0,560,12518,0,0;QS=3,0;MQSB=0.952765;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,6,71:2:0 0,18,179:6:0 +X 2057 . T <*> 0 . DP=30;I16=15,15,0,0,1094,40082,0,0,1769,105241,0,0,556,12374,0,0;QS=3,0;MQSB=0.952765;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,6,72:2:0 0,18,178:6:0 +X 2058 . A <*> 0 . DP=29;I16=14,15,0,0,1035,37517,0,0,1709,101641,0,0,552,12212,0,0;QS=3,0;MQSB=0.947838;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,6,57:2:0 0,18,179:6:0 +X 2059 . A <*> 0 . DP=29;I16=14,15,0,0,1063,39615,0,0,1709,101641,0,0,548,12082,0,0;QS=3,0;MQSB=0.947838;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,6,66:2:0 0,18,188:6:0 +X 2060 . C <*> 0 . DP=28;I16=12,15,0,0,1015,39057,0,0,1589,94441,0,0,523,11499,0,0;QS=3,0;MQSB=0.935229;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,6,62:2:0 0,15,143:5:0 +X 2061 . A <*> 0 . DP=27;I16=12,14,0,0,950,35084,0,0,1529,90841,0,0,501,11073,0,0;QS=3,0;MQSB=0.937241;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,3,41:1:0 0,15,163:5:0 +X 2062 . A <*> 0 . DP=26;I16=11,15,0,0,973,37349,0,0,1529,90841,0,0,519,11425,0,0;QS=3,0;MQSB=0.927041;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,57:2:0 0,15,164:5:0 +X 2063 . C <*> 0 . DP=26;I16=11,15,0,0,1017,40149,0,0,1529,90841,0,0,517,11405,0,0;QS=3,0;MQSB=0.927041;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,74:2:0 0,15,158:5:0 +X 2064 . A <*> 0 . DP=26;I16=11,15,0,0,1002,38980,0,0,1529,90841,0,0,515,11413,0,0;QS=3,0;MQSB=0.927041;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,75:2:0 0,15,164:5:0 +X 2065 . G <*> 0 . DP=26;I16=12,14,0,0,1030,41232,0,0,1529,90841,0,0,514,11448,0,0;QS=3,0;MQSB=0.937241;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,78:2:0 0,18,167:6:0 +X 2066 . G <*> 0 . DP=26;I16=12,14,0,0,973,37055,0,0,1529,90841,0,0,514,11510,0,0;QS=3,0;MQSB=0.937241;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,75:2:0 0,18,152:6:0 +X 2067 . A <*> 0 . DP=26;I16=12,14,0,0,1005,39095,0,0,1529,90841,0,0,512,11498,0,0;QS=3,0;MQSB=0.937241;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,69:2:0 0,18,187:6:0 +X 2068 . G <*> 0 . DP=26;I16=12,14,0,0,993,39005,0,0,1529,90841,0,0,509,11459,0,0;QS=3,0;MQSB=0.937241;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,53:2:0 0,18,167:6:0 +X 2069 . C <*> 0 . DP=26;I16=12,14,0,0,873,29879,0,0,1529,90841,0,0,506,11442,0,0;QS=3,0;MQSB=0.937241;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,59:2:0 0,18,156:6:0 +X 2070 . G <*> 0 . DP=27;I16=13,14,0,0,932,33090,0,0,1589,94441,0,0,502,11398,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,62:2:0 0,18,145:6:0 +X 2071 . A <*> 0 . DP=27;I16=13,14,0,0,946,33884,0,0,1589,94441,0,0,498,11330,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,53:2:0 0,18,177:6:0 +X 2072 . C <*> 0 . DP=25;I16=13,12,0,0,897,32897,0,0,1469,87241,0,0,496,11288,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,59:2:0 0,15,128:5:0 +X 2073 . C <*> 0 . DP=26;I16=14,12,0,0,874,30184,0,0,1529,90841,0,0,492,11168,0,0;QS=3,0;MQSB=0.953497;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,53:2:0 0,15,133:5:0 +X 2074 . G <*> 0 . DP=26;I16=13,12,0,0,835,29219,0,0,1469,87241,0,0,463,10395,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,67:2:0 0,12,83:4:0 +X 2075 . C <*> 0 . DP=27;I16=15,12,0,0,989,37027,0,0,1589,94441,0,0,484,10896,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,6,69:2:0 0,15,115:5:0 +X 2076 . A <*> 0 . DP=27;I16=14,12,0,0,929,33551,0,0,1529,90841,0,0,470,10676,0,0;QS=3,0;MQSB=0.953497;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,6,76:2:0 0,12,114:4:0 +X 2077 . C <*> 0 . DP=27;I16=15,12,0,0,990,37252,0,0,1589,94441,0,0,478,10724,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,6,65:2:0 0,15,125:5:0 +X 2078 . A <*> 0 . DP=27;I16=15,12,0,0,1023,39089,0,0,1589,94441,0,0,475,10677,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,6,72:2:0 0,15,148:5:0 +X 2079 . G <*> 0 . DP=28;I16=15,13,0,0,1042,39694,0,0,1649,98041,0,0,471,10605,0,0;QS=3,0;MQSB=0.956162;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,6,72:2:0 0,15,133:5:0 +X 2080 . G <*> 0 . DP=28;I16=14,13,0,0,968,35328,0,0,1589,94441,0,0,453,10333,0,0;QS=3,0;MQSB=0.951472;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,6,67:2:0 0,12,108:4:0 +X 2081 . C <*> 0 . DP=26;I16=14,12,0,0,937,35303,0,0,1529,90841,0,0,467,10535,0,0;QS=3,0;MQSB=0.953497;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,63:2:0 0,15,110:5:0 +X 2082 . T <*> 0 . DP=24;I16=12,12,0,0,901,34287,0,0,1409,83641,0,0,468,10532,0,0;QS=3,0;MQSB=0.941765;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,71:2:0 0,12,112:4:0 +X 2083 . G <*> 0 . DP=24;I16=12,12,0,0,887,33597,0,0,1409,83641,0,0,469,10547,0,0;QS=3,0;MQSB=0.941765;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,68:2:0 0,12,113:4:0 +X 2084 . C <*> 0 . DP=25;I16=13,12,0,0,938,35868,0,0,1469,87241,0,0,470,10580,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,61:2:0 0,12,115:4:0 +X 2085 . T <*> 0 . DP=25;I16=13,12,0,0,932,35282,0,0,1469,87241,0,0,472,10632,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,64:2:0 0,12,130:4:0 +X 2086 . G <*> 0 . DP=25;I16=13,12,0,0,932,35400,0,0,1469,87241,0,0,474,10704,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,61:2:0 0,12,129:4:0 +X 2087 . A <*> 0 . DP=24;I16=12,12,0,0,903,34391,0,0,1409,83641,0,0,476,10746,0,0;QS=3,0;MQSB=0.941765;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,66:2:0 0,12,126:4:0 +X 2088 . G <*> 0 . DP=24;I16=12,12,0,0,880,33116,0,0,1409,83641,0,0,478,10808,0,0;QS=3,0;MQSB=0.941765;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,70:2:0 0,12,121:4:0 +X 2089 . C <*> 0 . DP=25;I16=13,12,0,0,817,27419,0,0,1469,87241,0,0,480,10890,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,64:2:0 0,15,138:5:0 +X 2090 . G <*> 0 . DP=25;I16=12,12,0,0,802,27940,0,0,1409,83641,0,0,457,10319,0,0;QS=3,0;MQSB=0.941765;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,63:2:0 0,12,99:4:0 +X 2091 . C <*> 0 . DP=25;I16=12,12,0,0,800,27346,0,0,1440,86400,0,0,458,10346,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,61:2:0 0,15,125:5:0 +X 2092 . G <*> 0 . DP=26;I16=13,12,0,0,838,29188,0,0,1469,87241,0,0,461,10487,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,64:2:0 0,18,133:6:0 +X 2093 . T G,<*> 0 . DP=26;I16=13,12,1,0,905,33415,17,289,1500,90000,29,841,459,10371,25,625;QS=2.97424,0.0257576,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.953497;BQB=1;MQ0F=0 PL:DP:DV 0,36,255,51,255,255:18:1 0,6,67,6,67,67:2:0 0,18,153,18,153,153:6:0 +X 2094 . C <*> 0 . DP=26;I16=14,12,0,0,949,35501,0,0,1529,90841,0,0,485,11047,0,0;QS=3,0;MQSB=0.953497;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,69:2:0 0,18,142:6:0 +X 2095 . A <*> 0 . DP=25;I16=14,11,0,0,879,31219,0,0,1469,87241,0,0,487,11123,0,0;QS=3,0;MQSB=0.955682;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,72:2:0 0,18,154:6:0 +X 2096 . C <*> 0 . DP=24;I16=13,11,0,0,878,32734,0,0,1409,83641,0,0,487,11073,0,0;QS=3,0;MQSB=0.950498;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,65:2:0 0,18,161:6:0 +X 2097 . A <*> 0 . DP=24;I16=13,11,0,0,849,30671,0,0,1409,83641,0,0,487,11047,0,0;QS=3,0;MQSB=0.950498;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,56:2:0 0,18,172:6:0 +X 2098 . C <*> 0 . DP=24;I16=13,11,0,0,781,26113,0,0,1409,83641,0,0,486,10996,0,0;QS=3,0;MQSB=0.950498;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,58:2:0 0,18,139:6:0 +X 2099 . G <*> 0 . DP=23;I16=12,10,0,0,719,25109,0,0,1289,76441,0,0,460,10294,0,0;QS=3,0;MQSB=0.947103;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,3,24:1:0 0,18,129:6:0 +X 2100 . C <*> 0 . DP=25;I16=13,11,0,0,873,32759,0,0,1409,83641,0,0,457,10141,0,0;QS=3,0;MQSB=0.950498;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,87:3:0 0,18,160:6:0 +X 2101 . A <*> 0 . DP=25;I16=12,12,0,0,907,34671,0,0,1440,86400,0,0,455,9965,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,135:4:0 0,18,161:6:0 +X 2102 . G <*> 0 . DP=25;I16=13,12,0,0,930,35596,0,0,1469,87241,0,0,478,10442,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,118:4:0 0,18,151:6:0 +X 2103 . C <*> 0 . DP=25;I16=11,12,0,0,842,31630,0,0,1380,82800,0,0,432,9336,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,106:4:0 0,15,146:5:0 +X 2104 . C <*> 0 . DP=24;I16=12,12,0,0,869,32463,0,0,1409,83641,0,0,454,9810,0,0;QS=3,0;MQSB=0.941765;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,126:4:0 0,15,147:5:0 +X 2105 . A <*> 0 . DP=25;I16=11,12,0,0,836,30696,0,0,1380,82800,0,0,429,9201,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,138:4:0 0,15,130:5:0 +X 2106 . T <*> 0 . DP=25;I16=12,13,0,0,897,33087,0,0,1469,87241,0,0,473,10211,0,0;QS=3,0;MQSB=0.939413;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,129:4:0 0,15,146:5:0 +X 2107 . C <*> 0 . DP=25;I16=11,12,0,0,783,27185,0,0,1380,82800,0,0,425,9113,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,100:3:0 0,15,133:5:0 +X 2108 . G <*> 0 . DP=25;I16=11,13,0,0,829,29703,0,0,1440,86400,0,0,448,9730,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,122:4:0 0,15,111:5:0 +X 2109 . C <*> 0 . DP=25;I16=11,13,0,0,781,26717,0,0,1440,86400,0,0,446,9746,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,109:4:0 0,15,125:5:0 +X 2110 . G <*> 0 . DP=25;I16=12,12,0,0,804,28134,0,0,1440,86400,0,0,418,9110,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,92:3:0 0,15,117:5:0 +X 2111 . C <*> 0 . DP=25;I16=12,13,0,0,925,35081,0,0,1500,90000,0,0,441,9747,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,134:4:0 0,15,140:5:0 +X 2112 . A <*> 0 . DP=24;I16=12,12,0,0,885,33445,0,0,1440,86400,0,0,440,9782,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,129:4:0 0,15,140:5:0 +X 2113 . G <*> 0 . DP=24;I16=12,12,0,0,871,32641,0,0,1440,86400,0,0,439,9839,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,128:4:0 0,15,134:5:0 +X 2114 . C <*> 0 . DP=24;I16=12,11,0,0,844,32052,0,0,1380,82800,0,0,413,9293,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,103:3:0 0,15,126:5:0 +X 2115 . T <*> 0 . DP=23;I16=11,11,0,0,821,30869,0,0,1320,79200,0,0,412,9342,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,78:2:0 0,15,143:5:0 +X 2116 . C <*> 0 . DP=23;I16=11,12,0,0,890,34892,0,0,1380,82800,0,0,435,9985,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,102:3:0 0,15,152:5:0 +X 2117 . A <*> 0 . DP=23;I16=11,11,0,0,833,32121,0,0,1320,79200,0,0,432,9924,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,118:3:0 0,15,156:5:0 +X 2118 . G <*> 0 . DP=23;I16=12,11,0,0,842,31502,0,0,1380,82800,0,0,429,9835,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,125:4:0 0,15,147:5:0 +X 2119 . G <*> 0 . DP=23;I16=12,11,0,0,823,30553,0,0,1380,82800,0,0,426,9768,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,135:4:0 0,15,137:5:0 +X 2120 . G <*> 0 . DP=24;I16=13,11,0,0,864,32028,0,0,1440,86400,0,0,423,9723,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,137:4:0 0,15,140:5:0 +X 2121 . A <*> 0 . DP=22;I16=11,10,0,0,734,26712,0,0,1260,75600,0,0,398,9074,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,135:4:0 0,12,122:4:0 +X 2122 . T <*> 0 . DP=22;I16=11,10,0,0,752,27278,0,0,1260,75600,0,0,396,8972,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,136:4:0 0,12,123:4:0 +X 2123 . A <*> 0 . DP=22;I16=12,10,0,0,758,27024,0,0,1320,79200,0,0,419,9519,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,120:4:0 0,15,137:5:0 +X 2124 . T <*> 0 . DP=22;I16=12,10,0,0,789,28741,0,0,1320,79200,0,0,417,9465,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,128:4:0 0,15,136:5:0 +X 2125 . T <*> 0 . DP=20;I16=11,8,0,0,696,25704,0,0,1140,68400,0,0,401,9177,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,106:3:0 0,9,93:3:0 +X 2126 . A <*> 0 . DP=20;I16=11,9,0,0,717,25979,0,0,1200,72000,0,0,415,9319,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,133:4:0 0,9,95:3:0 +X 2127 . C <*> 0 . DP=21;I16=11,10,0,0,706,24426,0,0,1260,75600,0,0,413,9221,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,107:4:0 0,9,95:3:0 +X 2128 . G <*> 0 . DP=21;I16=11,10,0,0,677,22633,0,0,1260,75600,0,0,411,9091,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,116:4:0 0,9,72:3:0 +X 2129 . T <*> 0 . DP=21;I16=11,10,0,0,782,29386,0,0,1260,75600,0,0,409,8981,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,140:4:0 0,9,83:3:0 +X 2130 . G <*> 0 . DP=21;I16=11,10,0,0,766,28562,0,0,1260,75600,0,0,407,8891,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,135:4:0 0,9,87:3:0 +X 2131 . T <*> 0 . DP=21;I16=11,10,0,0,732,26216,0,0,1260,75600,0,0,405,8821,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,136:4:0 0,9,79:3:0 +X 2132 . A <*> 0 . DP=21;I16=11,10,0,0,743,26733,0,0,1260,75600,0,0,403,8771,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,135:4:0 0,9,88:3:0 +X 2133 . A <*> 0 . DP=21;I16=11,10,0,0,787,29651,0,0,1260,75600,0,0,401,8741,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,141:4:0 0,9,96:3:0 +X 2134 . C <*> 0 . DP=21;I16=11,10,0,0,804,31100,0,0,1260,75600,0,0,399,8731,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,138:4:0 0,9,86:3:0 +X 2135 . T <*> 0 . DP=22;I16=11,11,0,0,831,32197,0,0,1320,79200,0,0,397,8741,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,153:4:0 0,12,119:4:0 +X 2136 . C <*> 0 . DP=22;I16=11,11,0,0,760,26892,0,0,1320,79200,0,0,395,8721,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,124:4:0 0,12,127:4:0 +X 2137 . G <*> 0 . DP=22;I16=11,11,0,0,745,26047,0,0,1320,79200,0,0,393,8721,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,121:4:0 0,12,102:4:0 +X 2138 . A <*> 0 . DP=22;I16=11,11,0,0,816,30934,0,0,1320,79200,0,0,391,8741,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,128:4:0 0,12,139:4:0 +X 2139 . C <*> 0 . DP=22;I16=11,11,0,0,839,32237,0,0,1320,79200,0,0,389,8781,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,138:4:0 0,12,125:4:0 +X 2140 . A <*> 0 . DP=22;I16=11,11,0,0,826,31300,0,0,1320,79200,0,0,387,8841,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,140:4:0 0,12,138:4:0 +X 2141 . T <*> 0 . DP=21;I16=11,10,0,0,792,30156,0,0,1260,75600,0,0,385,8871,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,137:4:0 0,12,137:4:0 +X 2142 . G <*> 0 . DP=19;I16=11,8,0,0,724,27784,0,0,1140,68400,0,0,385,8919,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,113:3:0 0,12,129:4:0 +X 2143 . T <*> 0 . DP=19;I16=11,8,0,0,650,23454,0,0,1140,68400,0,0,384,8932,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,113:3:0 0,12,120:4:0 +X 2144 . C <*> 0 . DP=19;I16=11,8,0,0,739,29003,0,0,1140,68400,0,0,383,8959,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,108:3:0 0,12,125:4:0 +X 2145 . A <*> 0 . DP=20;I16=12,8,0,0,760,29304,0,0,1200,72000,0,0,381,8951,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,133:4:0 0,12,139:4:0 +X 2146 . G <*> 0 . DP=20;I16=12,8,0,0,745,28105,0,0,1200,72000,0,0,379,8909,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,139:4:0 0,12,127:4:0 +X 2147 . C <*> 0 . DP=20;I16=13,6,0,0,674,24296,0,0,1140,68400,0,0,379,8881,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,127:4:0 0,12,130:4:0 +X 2148 . G <*> 0 . DP=20;I16=12,7,0,0,630,21274,0,0,1140,68400,0,0,365,8537,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,250:11:0 0,12,112:4:0 0,12,120:4:0 +X 2149 . A <*> 0 . DP=20;I16=12,7,0,0,702,26212,0,0,1140,68400,0,0,367,8529,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,138:4:0 0,12,127:4:0 +X 2150 . T <*> 0 . DP=20;I16=13,7,0,0,675,23943,0,0,1200,72000,0,0,383,8713,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,247:11:0 0,12,138:4:0 0,15,139:5:0 +X 2151 . T <*> 0 . DP=20;I16=13,7,0,0,690,24274,0,0,1200,72000,0,0,383,8661,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,251:11:0 0,12,133:4:0 0,15,142:5:0 +X 2152 . G <*> 0 . DP=20;I16=13,7,0,0,693,24713,0,0,1200,72000,0,0,383,8629,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,131:4:0 0,15,146:5:0 +X 2153 . T <*> 0 . DP=19;I16=13,6,0,0,671,24571,0,0,1140,68400,0,0,383,8565,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,230:10:0 0,12,134:4:0 0,15,162:5:0 +X 2154 . C <*> 0 . DP=19;I16=13,6,0,0,703,26955,0,0,1140,68400,0,0,382,8468,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,251:10:0 0,12,131:4:0 0,15,159:5:0 +X 2155 . A <*> 0 . DP=19;I16=13,6,0,0,693,25727,0,0,1140,68400,0,0,381,8389,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,245:10:0 0,12,135:4:0 0,15,156:5:0 +X 2156 . C <*> 0 . DP=19;I16=13,6,0,0,702,26214,0,0,1140,68400,0,0,380,8328,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,125:4:0 0,15,154:5:0 +X 2157 . A <*> 0 . DP=19;I16=13,6,0,0,722,28058,0,0,1140,68400,0,0,379,8285,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,250:10:0 0,12,141:4:0 0,15,173:5:0 +X 2158 . G <*> 0 . DP=19;I16=13,6,0,0,713,27567,0,0,1140,68400,0,0,378,8260,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,136:4:0 0,15,144:5:0 +X 2159 . G <*> 0 . DP=19;I16=12,6,0,0,662,24744,0,0,1080,64800,0,0,366,8104,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,247:9:0 0,12,126:4:0 0,15,153:5:0 +X 2160 . C <*> 0 . DP=19;I16=12,6,0,0,651,24005,0,0,1080,64800,0,0,364,8038,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,244:9:0 0,12,119:4:0 0,15,154:5:0 +X 2161 . A <*> 0 . DP=19;I16=13,6,0,0,695,25883,0,0,1140,68400,0,0,369,8005,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,248:10:0 0,12,121:4:0 0,15,164:5:0 +X 2162 . C <*> 0 . DP=20;I16=13,7,0,0,742,27834,0,0,1200,72000,0,0,365,7911,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,127:4:0 0,15,155:5:0 +X 2163 . T <*> 0 . DP=20;I16=13,7,0,0,763,29517,0,0,1200,72000,0,0,362,7838,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,131:4:0 0,15,175:5:0 +X 2164 . G <*> 0 . DP=20;I16=13,7,0,0,715,26301,0,0,1200,72000,0,0,359,7787,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,116:4:0 0,15,156:5:0 +X 2165 . C <*> 0 . DP=20;I16=13,7,0,0,753,28781,0,0,1200,72000,0,0,355,7709,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,136:4:0 0,15,151:5:0 +X 2166 . T <*> 0 . DP=19;I16=12,7,0,0,711,27211,0,0,1140,68400,0,0,352,7654,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,142:4:0 0,12,140:4:0 +X 2167 . A <*> 0 . DP=19;I16=12,6,0,0,650,23760,0,0,1080,64800,0,0,327,7137,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,254:11:0 0,12,133:4:0 0,9,111:3:0 +X 2168 . C <*> 0 . DP=19;I16=12,7,0,0,685,25039,0,0,1140,68400,0,0,345,7561,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,130:4:0 0,12,124:4:0 +X 2169 . T <*> 0 . DP=19;I16=12,7,0,0,702,26940,0,0,1140,68400,0,0,341,7525,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,140:4:0 0,12,142:4:0 +X 2170 . C <*> 0 . DP=18;I16=11,7,0,0,665,24861,0,0,1080,64800,0,0,338,7512,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,132:4:0 0,12,135:4:0 +X 2171 . C <*> 0 . DP=20;I16=11,9,0,0,750,28368,0,0,1200,72000,0,0,333,7419,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,136:4:0 0,12,138:4:0 +X 2172 . T <*> 0 . DP=20;I16=11,9,0,0,732,27540,0,0,1200,72000,0,0,330,7346,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,149:4:0 0,12,147:4:0 +X 2173 . G <*> 0 . DP=19;I16=10,9,0,0,704,26534,0,0,1140,68400,0,0,327,7243,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,142:4:0 0,12,133:4:0 +X 2174 . G <*> 0 . DP=19;I16=10,9,0,0,674,24372,0,0,1140,68400,0,0,324,7158,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,126:4:0 0,12,129:4:0 +X 2175 . G <*> 0 . DP=18;I16=9,9,0,0,639,23059,0,0,1080,64800,0,0,322,7090,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,123:4:0 0,12,126:4:0 +X 2176 . G <*> 0 . DP=18;I16=9,9,0,0,621,21815,0,0,1080,64800,0,0,318,6940,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,247:10:0 0,12,121:4:0 0,12,123:4:0 +X 2177 . T <*> 0 . DP=18;I16=9,9,0,0,547,18051,0,0,1080,64800,0,0,314,6810,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,239:10:0 0,12,83:4:0 0,12,108:4:0 +X 2178 . T <*> 0 . DP=18;I16=9,9,0,0,579,19659,0,0,1080,64800,0,0,310,6700,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,234:10:0 0,12,110:4:0 0,12,118:4:0 +X 2179 . T <*> 0 . DP=18;I16=9,9,0,0,591,20403,0,0,1080,64800,0,0,307,6609,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,239:10:0 0,12,97:4:0 0,12,135:4:0 +X 2180 . T <*> 0 . DP=18;I16=9,9,0,0,616,21524,0,0,1080,64800,0,0,305,6537,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,236:10:0 0,12,122:4:0 0,12,133:4:0 +X 2181 . C <*> 0 . DP=18;I16=9,8,0,0,611,22485,0,0,1020,61200,0,0,293,6385,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,224:9:0 0,12,129:4:0 0,12,150:4:0 +X 2182 . C <*> 0 . DP=18;I16=9,9,0,0,665,24877,0,0,1080,64800,0,0,301,6453,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,125:4:0 0,12,145:4:0 +X 2183 . A <*> 0 . DP=18;I16=9,9,0,0,646,23624,0,0,1080,64800,0,0,299,6441,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,247:10:0 0,12,123:4:0 0,12,144:4:0 +X 2184 . T <*> 0 . DP=17;I16=8,9,0,0,610,22250,0,0,1020,61200,0,0,298,6448,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,224:9:0 0,12,134:4:0 0,12,136:4:0 +X 2185 . C <*> 0 . DP=16;I16=8,8,0,0,569,20761,0,0,960,57600,0,0,297,6423,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,211:8:0 0,12,128:4:0 0,12,137:4:0 +X 2186 . A <*> 0 . DP=16;I16=8,8,0,0,576,21314,0,0,960,57600,0,0,296,6416,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,204:8:0 0,12,134:4:0 0,12,145:4:0 +X 2187 . A <*> 0 . DP=16;I16=8,8,0,0,562,20396,0,0,960,57600,0,0,295,6427,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,201:8:0 0,12,136:4:0 0,12,135:4:0 +X 2188 . A <*> 0 . DP=17;I16=9,8,0,0,569,19925,0,0,1020,61200,0,0,293,6405,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,214:9:0 0,12,133:4:0 0,12,123:4:0 +X 2189 . C <*> 0 . DP=19;I16=9,10,0,0,645,22647,0,0,1097,65089,0,0,292,6400,0,0;QS=3,0;MQSB=0.934728;MQ0F=0 PL:DP:DV 0,30,230:10:0 0,12,133:4:0 0,15,142:5:0 +X 2190 . C <*> 0 . DP=19;I16=9,10,0,0,604,20072,0,0,1097,65089,0,0,294,6414,0,0;QS=3,0;MQSB=0.934728;MQ0F=0 PL:DP:DV 0,33,238:11:0 0,12,119:4:0 0,12,107:4:0 +X 2191 . C <*> 0 . DP=19;I16=9,10,0,0,647,23007,0,0,1097,65089,0,0,297,6449,0,0;QS=3,0;MQSB=0.934728;MQ0F=0 PL:DP:DV 0,33,251:11:0 0,12,129:4:0 0,12,119:4:0 +X 2192 . T <*> 0 . DP=19;I16=9,10,0,0,659,23723,0,0,1097,65089,0,0,300,6506,0,0;QS=3,0;MQSB=0.934728;MQ0F=0 PL:DP:DV 0,33,253:11:0 0,12,136:4:0 0,12,120:4:0 +X 2193 . C <*> 0 . DP=18;I16=8,10,0,0,642,23934,0,0,1037,61489,0,0,303,6535,0,0;QS=3,0;MQSB=0.938795;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,128:4:0 0,9,87:3:0 +X 2194 . A <*> 0 . DP=18;I16=8,9,0,0,617,22683,0,0,1020,61200,0,0,301,6561,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,247:10:0 0,12,134:4:0 0,9,98:3:0 +X 2195 . A <*> 0 . DP=18;I16=8,10,0,0,635,23271,0,0,1037,61489,0,0,309,6659,0,0;QS=3,0;MQSB=0.938795;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,128:4:0 0,9,101:3:0 +X 2196 . G <*> 0 . DP=19;I16=8,11,0,0,703,26383,0,0,1097,65089,0,0,312,6754,0,0;QS=3,0;MQSB=0.946915;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,117:4:0 0,12,120:4:0 +X 2197 . A <*> 0 . DP=19;I16=8,11,0,0,735,28599,0,0,1097,65089,0,0,314,6770,0,0;QS=3,0;MQSB=0.946915;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,141:4:0 0,12,125:4:0 +X 2198 . G <*> 0 . DP=19;I16=8,10,0,0,650,24206,0,0,1080,64800,0,0,307,6725,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,129:4:0 0,12,107:4:0 +X 2199 . C <*> 0 . DP=19;I16=8,11,0,0,701,26735,0,0,1097,65089,0,0,318,6862,0,0;QS=3,0;MQSB=0.946915;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,128:4:0 0,12,116:4:0 +X 2200 . T <*> 0 . DP=19;I16=8,11,0,0,710,26768,0,0,1097,65089,0,0,320,6938,0,0;QS=3,0;MQSB=0.946915;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,129:4:0 0,12,114:4:0 +X 2201 . G <*> 0 . DP=17;I16=7,10,0,0,628,23764,0,0,977,57889,0,0,324,7032,0,0;QS=3,0;MQSB=0.943335;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,66:2:0 0,12,119:4:0 +X 2202 . G <*> 0 . DP=17;I16=7,10,0,0,557,19249,0,0,977,57889,0,0,327,7093,0,0;QS=3,0;MQSB=0.943335;MQ0F=0 PL:DP:DV 0,33,245:11:0 0,6,57:2:0 0,12,115:4:0 +X 2203 . G <*> 0 . DP=17;I16=7,10,0,0,588,21184,0,0,977,57889,0,0,329,7123,0,0;QS=3,0;MQSB=0.943335;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,47:2:0 0,12,116:4:0 +X 2204 . C <*> 0 . DP=17;I16=7,10,0,0,538,18568,0,0,977,57889,0,0,331,7173,0,0;QS=3,0;MQSB=0.943335;MQ0F=0 PL:DP:DV 0,33,246:11:0 0,6,61:2:0 0,12,99:4:0 +X 2205 . C <*> 0 . DP=18;I16=7,11,0,0,628,22918,0,0,1037,61489,0,0,332,7192,0,0;QS=3,0;MQSB=0.951002;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,68:2:0 0,12,109:4:0 +X 2206 . T <*> 0 . DP=19;I16=7,12,0,0,677,25237,0,0,1097,65089,0,0,334,7230,0,0;QS=3,0;MQSB=0.957193;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,77:2:0 0,12,115:4:0 +X 2207 . G <*> 0 . DP=19;I16=7,11,0,0,663,24717,0,0,1080,64800,0,0,319,6965,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,67:2:0 0,12,110:4:0 +X 2208 . G <*> 0 . DP=21;I16=7,14,0,0,726,26038,0,0,1217,72289,0,0,340,7370,0,0;QS=3,0;MQSB=0.966484;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,110:4:0 0,12,122:4:0 +X 2209 . G <*> 0 . DP=22;I16=8,13,0,0,715,25133,0,0,1237,73369,0,0,325,7075,0,0;QS=3,0;MQSB=0.895122;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,128:5:0 0,12,117:4:0 +X 2210 . G C,<*> 0 . DP=21;I16=7,13,0,1,648,22186,25,625,1177,69769,17,289,331,7165,21,441;QS=2.95442,0.0455764,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.975265;BQB=1;MQ0F=0 PL:DP:DV 0,19,234,33,237,241:12:1 0,15,127,15,127,127:5:0 0,12,113,12,113,113:4:0 +X 2211 . T <*> 0 . DP=21;I16=7,13,0,0,724,27000,0,0,1177,69769,0,0,336,7230,0,0;QS=3,0;MQSB=0.875769;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,141:5:0 0,12,124:4:0 +X 2212 . C <*> 0 . DP=22;I16=8,14,0,0,791,29201,0,0,1254,73658,0,0,364,7850,0,0;QS=3,0;MQSB=0.985548;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,148:5:0 0,12,111:4:0 +X 2213 . A <*> 0 . DP=22;I16=8,14,0,0,767,27327,0,0,1254,73658,0,0,371,8015,0,0;QS=3,0;MQSB=0.985548;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,153:5:0 0,12,112:4:0 +X 2214 . A <*> 0 . DP=22;I16=8,14,0,0,756,26836,0,0,1254,73658,0,0,377,8159,0,0;QS=3,0;MQSB=0.985548;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,153:5:0 0,12,117:4:0 +X 2215 . C <*> 0 . DP=22;I16=8,14,0,0,815,31121,0,0,1254,73658,0,0,381,8229,0,0;QS=3,0;MQSB=0.985548;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,162:5:0 0,12,124:4:0 +X 2216 . T <*> 0 . DP=22;I16=8,14,0,0,815,31233,0,0,1254,73658,0,0,384,8272,0,0;QS=3,0;MQSB=0.985548;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,166:5:0 0,12,124:4:0 +X 2217 . T <*> 0 . DP=22;I16=8,13,0,0,741,26855,0,0,1237,73369,0,0,362,7712,0,0;QS=3,0;MQSB=0.895122;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,155:5:0 0,12,118:4:0 +X 2218 . C <*> 0 . DP=21;I16=7,14,0,0,753,27973,0,0,1194,70058,0,0,391,8423,0,0;QS=3,0;MQSB=0.975265;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,138:4:0 0,12,119:4:0 +X 2219 . C <*> 0 . DP=21;I16=7,13,0,0,757,29125,0,0,1177,69769,0,0,370,7904,0,0;QS=3,0;MQSB=0.875769;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,141:4:0 0,12,122:4:0 +X 2220 . G A,<*> 0 . DP=21;I16=6,2,1,11,256,8364,474,19128,457,26569,720,43200,141,2959,233,5071;QS=0.886504,2.1135,0;VDB=0.532753;SGB=-3.51597;RPB=0.964198;MQB=0.898397;MQSB=0.875769;BQB=0.0354359;MQ0F=0 PL:DP:DV 139,0,130,157,148,255:12:6 69,0,46,75,52,119:4:2 131,12,0,131,12,131:4:4 +X 2221 . G <*> 0 . DP=21;I16=7,13,0,0,738,27922,0,0,1177,69769,0,0,376,8078,0,0;QS=3,0;MQSB=0.875769;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,132:4:0 0,12,120:4:0 +X 2222 . C <*> 0 . DP=21;I16=7,14,0,0,746,28098,0,0,1194,70058,0,0,401,8675,0,0;QS=3,0;MQSB=0.975265;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,135:4:0 0,12,107:4:0 +X 2223 . C <*> 0 . DP=21;I16=7,14,0,0,796,30632,0,0,1194,70058,0,0,401,8671,0,0;QS=3,0;MQSB=0.975265;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,135:4:0 0,12,122:4:0 +X 2224 . T <*> 0 . DP=21;I16=7,14,0,0,811,31599,0,0,1194,70058,0,0,401,8691,0,0;QS=3,0;MQSB=0.975265;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,144:4:0 0,12,123:4:0 +X 2225 . G <*> 0 . DP=21;I16=7,14,0,0,778,29396,0,0,1194,70058,0,0,401,8735,0,0;QS=3,0;MQSB=0.975265;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,133:4:0 0,12,121:4:0 +X 2226 . G <*> 0 . DP=21;I16=7,14,0,0,727,26485,0,0,1194,70058,0,0,401,8803,0,0;QS=3,0;MQSB=0.975265;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,128:4:0 0,12,113:4:0 +X 2227 . G <*> 0 . DP=20;I16=7,12,0,0,663,23985,0,0,1117,66169,0,0,377,8269,0,0;QS=3,0;MQSB=0.879351;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,123:4:0 0,12,114:4:0 +X 2228 . G C,<*> 0 . DP=19;I16=5,12,0,1,643,24791,16,256,1020,61200,17,289,360,8020,25,625;QS=2.9603,0.0397022,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.970092;BQB=1;MQ0F=0 PL:DP:DV 0,17,255,30,255,255:11:1 0,9,95,9,95,95:3:0 0,12,121,12,121,121:4:0 +X 2229 . A <*> 0 . DP=20;I16=6,14,0,0,757,28857,0,0,1134,66458,0,0,406,9138,0,0;QS=3,0;MQSB=0.959189;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,138:4:0 0,12,122:4:0 +X 2230 . A <*> 0 . DP=20;I16=6,14,0,0,729,26985,0,0,1134,66458,0,0,409,9291,0,0;QS=3,0;MQSB=0.959189;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,141:4:0 0,12,119:4:0 +X 2231 . A <*> 0 . DP=20;I16=6,13,0,0,712,26990,0,0,1117,66169,0,0,386,8790,0,0;QS=3,0;MQSB=0.850016;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,144:4:0 0,12,124:4:0 +X 2232 . C <*> 0 . DP=20;I16=6,14,0,0,751,28657,0,0,1134,66458,0,0,412,9508,0,0;QS=3,0;MQSB=0.959189;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,130:4:0 0,12,107:4:0 +X 2233 . T <*> 0 . DP=20;I16=6,14,0,0,774,30432,0,0,1134,66458,0,0,413,9619,0,0;QS=3,0;MQSB=0.959189;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,150:4:0 0,12,117:4:0 +X 2234 . G <*> 0 . DP=20;I16=6,14,0,0,719,26621,0,0,1134,66458,0,0,412,9646,0,0;QS=3,0;MQSB=0.959189;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,145:4:0 0,12,107:4:0 +X 2235 . G <*> 0 . DP=20;I16=6,14,0,0,728,27036,0,0,1134,66458,0,0,410,9636,0,0;QS=3,0;MQSB=0.959189;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,139:4:0 0,12,104:4:0 +X 2236 . G <*> 0 . DP=19;I16=6,13,0,0,705,26985,0,0,1074,62858,0,0,409,9637,0,0;QS=3,0;MQSB=0.965977;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,142:4:0 0,9,84:3:0 +X 2237 . G <*> 0 . DP=19;I16=6,12,0,0,684,26576,0,0,1057,62569,0,0,383,9023,0,0;QS=3,0;MQSB=0.85394;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,141:4:0 0,9,86:3:0 +X 2238 . C <*> 0 . DP=19;I16=5,13,0,0,648,24496,0,0,1037,61489,0,0,381,8993,0,0;QS=3,0;MQSB=0.970092;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,108:3:0 0,9,78:3:0 +X 2239 . A <*> 0 . DP=19;I16=6,11,0,0,634,24178,0,0,997,58969,0,0,373,8935,0,0;QS=3,0;MQSB=0.85832;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,133:4:0 0,6,77:2:0 +X 2240 . A <*> 0 . DP=19;I16=6,13,0,0,731,28595,0,0,1074,62858,0,0,402,9582,0,0;QS=3,0;MQSB=0.965977;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,135:4:0 0,9,101:3:0 +X 2241 . G <*> 0 . DP=19;I16=6,12,0,0,683,26433,0,0,1057,62569,0,0,375,8951,0,0;QS=3,0;MQSB=0.85394;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,126:4:0 0,9,88:3:0 +X 2242 . T <*> 0 . DP=20;I16=5,13,0,0,635,22949,0,0,1057,62569,0,0,370,8944,0,0;QS=3,0;MQSB=0.814433;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,91:3:0 0,9,95:3:0 +X 2243 . A <*> 0 . DP=19;I16=5,14,0,0,704,26274,0,0,1074,62858,0,0,395,9585,0,0;QS=3,0;MQSB=0.933727;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,107:3:0 0,9,99:3:0 +X 2244 . T <*> 0 . DP=19;I16=5,14,0,0,681,25263,0,0,1074,62858,0,0,395,9609,0,0;QS=3,0;MQSB=0.933727;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,89:3:0 0,9,98:3:0 +X 2245 . C <*> 0 . DP=19;I16=5,14,0,0,722,27846,0,0,1074,62858,0,0,394,9592,0,0;QS=3,0;MQSB=0.933727;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,98:3:0 0,9,88:3:0 +X 2246 . A <*> 0 . DP=18;I16=5,12,0,0,597,21693,0,0,997,58969,0,0,367,8861,0,0;QS=3,0;MQSB=0.818731;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,95:3:0 0,6,72:2:0 +X 2247 . C <*> 0 . DP=17;I16=4,13,0,0,639,24373,0,0,954,55658,0,0,391,9391,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,105:3:0 0,6,71:2:0 +X 2248 . C <*> 0 . DP=17;I16=4,13,0,0,669,26863,0,0,954,55658,0,0,390,9306,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,90:3:0 0,6,75:2:0 +X 2249 . A <*> 0 . DP=17;I16=4,13,0,0,677,27371,0,0,954,55658,0,0,389,9231,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,116:3:0 0,6,80:2:0 +X 2250 . G <*> 0 . DP=17;I16=4,13,0,0,654,25800,0,0,954,55658,0,0,388,9166,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,100:3:0 0,6,78:2:0 +X 2251 . A <*> 0 . DP=17;I16=4,13,0,0,673,27327,0,0,954,55658,0,0,387,9111,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,112:3:0 0,6,80:2:0 +X 2252 . G <*> 0 . DP=17;I16=4,12,0,0,647,26249,0,0,937,55369,0,0,361,8441,0,0;QS=3,0;MQSB=0.767432;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,113:3:0 0,6,73:2:0 +X 2253 . A <*> 0 . DP=17;I16=4,13,0,0,641,24643,0,0,954,55658,0,0,385,9031,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,111:3:0 0,6,73:2:0 +X 2254 . T <*> 0 . DP=17;I16=4,12,0,0,615,23821,0,0,937,55369,0,0,358,8332,0,0;QS=3,0;MQSB=0.767432;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,112:3:0 0,6,73:2:0 +X 2255 . G <*> 0 . DP=17;I16=4,13,0,0,677,27243,0,0,954,55658,0,0,380,8844,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,115:3:0 0,6,71:2:0 +X 2256 . A <*> 0 . DP=17;I16=4,13,0,0,656,26088,0,0,954,55658,0,0,377,8741,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,110:3:0 0,6,78:2:0 +X 2257 . G <*> 0 . DP=17;I16=4,12,0,0,627,24863,0,0,937,55369,0,0,349,8023,0,0;QS=3,0;MQSB=0.767432;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,115:3:0 0,6,74:2:0 +X 2258 . C <*> 0 . DP=17;I16=4,13,0,0,667,26403,0,0,954,55658,0,0,371,8565,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,109:3:0 0,6,70:2:0 +X 2259 . T <*> 0 . DP=17;I16=4,13,0,0,646,25334,0,0,954,55658,0,0,368,8492,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,116:3:0 0,6,79:2:0 +X 2260 . T <*> 0 . DP=17;I16=4,13,0,0,638,24178,0,0,954,55658,0,0,365,8429,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,115:3:0 0,6,72:2:0 +X 2261 . T <*> 0 . DP=17;I16=4,13,0,0,633,23799,0,0,954,55658,0,0,362,8376,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,105:3:0 0,6,73:2:0 +X 2262 . A <*> 0 . DP=17;I16=4,13,0,0,628,23438,0,0,954,55658,0,0,359,8333,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,36,253:12:0 0,9,112:3:0 0,6,74:2:0 +X 2263 . T <*> 0 . DP=17;I16=4,13,0,0,631,23673,0,0,954,55658,0,0,355,8251,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,112:3:0 0,6,74:2:0 +X 2264 . A <*> 0 . DP=17;I16=4,12,0,0,623,24371,0,0,937,55369,0,0,326,7556,0,0;QS=3,0;MQSB=0.767432;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,114:3:0 0,6,75:2:0 +X 2265 . A <*> 0 . DP=18;I16=4,13,0,0,642,24718,0,0,997,58969,0,0,320,7400,0,0;QS=3,0;MQSB=0.762744;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,113:3:0 0,6,75:2:0 +X 2266 . A <*> 0 . DP=19;I16=5,14,0,0,656,23962,0,0,1074,62858,0,0,337,7745,0,0;QS=3,0;MQSB=0.933727;MQ0F=0 PL:DP:DV 0,39,252:13:0 0,12,128:4:0 0,6,75:2:0 +X 2267 . A <*> 0 . DP=20;I16=6,14,0,0,712,26052,0,0,1134,66458,0,0,332,7582,0,0;QS=3,0;MQSB=0.959189;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,134:4:0 0,9,102:3:0 +X 2268 . A <*> 0 . DP=20;I16=6,14,0,0,741,27841,0,0,1134,66458,0,0,327,7391,0,0;QS=3,0;MQSB=0.959189;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,135:4:0 0,9,100:3:0 +X 2269 . T <*> 0 . DP=20;I16=6,13,0,0,681,24751,0,0,1074,62858,0,0,318,7206,0,0;QS=3,0;MQSB=0.965977;MQ0F=0 PL:DP:DV 0,36,246:12:0 0,12,137:4:0 0,9,111:3:0 +X 2270 . A <*> 0 . DP=19;I16=6,12,0,0,652,24154,0,0,1057,62569,0,0,300,6750,0,0;QS=3,0;MQSB=0.85394;MQ0F=0 PL:DP:DV 0,33,244:11:0 0,12,134:4:0 0,9,112:3:0 +X 2271 . A <*> 0 . DP=17;I16=6,11,0,0,654,25406,0,0,954,55658,0,0,316,6944,0,0;QS=3,0;MQSB=0.980001;MQ0F=0 PL:DP:DV 0,30,243:10:0 0,12,142:4:0 0,9,111:3:0 +X 2272 . T <*> 0 . DP=17;I16=6,10,0,0,604,22908,0,0,937,55369,0,0,297,6525,0,0;QS=3,0;MQSB=0.863243;MQ0F=0 PL:DP:DV 0,27,238:9:0 0,12,137:4:0 0,9,111:3:0 +X 2273 . G <*> 0 . DP=17;I16=6,10,0,0,581,22129,0,0,937,55369,0,0,295,6411,0,0;QS=3,0;MQSB=0.863243;MQ0F=0 PL:DP:DV 0,27,240:9:0 0,12,123:4:0 0,9,115:3:0 +X 2274 . G <*> 0 . DP=18;I16=6,11,0,0,621,23109,0,0,997,58969,0,0,293,6313,0,0;QS=3,0;MQSB=0.85832;MQ0F=0 PL:DP:DV 0,30,248:10:0 0,12,132:4:0 0,9,110:3:0 +X 2275 . T <*> 0 . DP=18;I16=6,11,0,0,624,23152,0,0,997,58969,0,0,292,6232,0,0;QS=3,0;MQSB=0.85832;MQ0F=0 PL:DP:DV 0,30,249:10:0 0,12,126:4:0 0,9,113:3:0 +X 2276 . G <*> 0 . DP=20;I16=7,12,0,0,710,26848,0,0,1074,62858,0,0,303,6313,0,0;QS=3,0;MQSB=0.985816;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,129:4:0 0,9,110:3:0 +X 2277 . C <*> 0 . DP=21;I16=8,13,0,0,797,30699,0,0,1194,70058,0,0,303,6247,0,0;QS=3,0;MQSB=0.989565;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,151:5:0 0,12,143:4:0 +X 2278 . T <*> 0 . DP=21;I16=7,13,0,0,736,27790,0,0,1157,68689,0,0,279,5581,0,0;QS=3,0;MQSB=0.962269;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,133:4:0 0,12,148:4:0 +X 2279 . A <*> 0 . DP=20;I16=8,12,0,0,723,27047,0,0,1134,66458,0,0,306,6190,0,0;QS=3,0;MQSB=0.993326;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,155:5:0 0,12,144:4:0 +X 2280 . G <*> 0 . DP=21;I16=8,12,0,0,766,29776,0,0,1177,69769,0,0,299,6085,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,166:5:0 0,12,144:4:0 +X 2281 . C <*> 0 . DP=22;I16=8,13,0,0,784,29748,0,0,1237,73369,0,0,301,6037,0,0;QS=3,0;MQSB=0.895122;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,165:5:0 0,12,140:4:0 +X 2282 . T <*> 0 . DP=22;I16=8,14,0,0,789,29699,0,0,1254,73658,0,0,310,6054,0,0;QS=3,0;MQSB=0.985548;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,162:5:0 0,12,150:4:0 +X 2283 . G <*> 0 . DP=22;I16=8,14,0,0,798,29774,0,0,1254,73658,0,0,312,6054,0,0;QS=3,0;MQSB=0.985548;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,158:5:0 0,12,142:4:0 +X 2284 . G <*> 0 . DP=22;I16=7,14,0,0,760,28408,0,0,1194,70058,0,0,294,5664,0,0;QS=3,0;MQSB=0.975265;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,130:4:0 0,12,141:4:0 +X 2285 . G <*> 0 . DP=23;I16=9,14,0,0,844,31592,0,0,1314,77258,0,0,311,5909,0,0;QS=3,0;MQSB=0.992095;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,152:5:0 0,12,144:4:0 +X 2286 . C <*> 0 . DP=23;I16=9,14,0,0,854,32244,0,0,1314,77258,0,0,311,5869,0,0;QS=3,0;MQSB=0.992095;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,155:5:0 0,12,130:4:0 +X 2287 . A <*> 0 . DP=23;I16=9,14,0,0,818,30288,0,0,1314,77258,0,0,311,5869,0,0;QS=3,0;MQSB=0.992095;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,166:5:0 0,12,143:4:0 +X 2288 . T <*> 0 . DP=22;I16=8,14,0,0,794,29190,0,0,1254,73658,0,0,312,5908,0,0;QS=3,0;MQSB=0.985548;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,158:5:0 0,12,142:4:0 +X 2289 . G <*> 0 . DP=21;I16=8,13,0,0,723,25835,0,0,1237,73369,0,0,314,5984,0,0;QS=3,0;MQSB=0.895122;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,154:5:0 0,12,126:4:0 +X 2290 . G <*> 0 . DP=20;I16=7,13,0,0,748,28318,0,0,1177,69769,0,0,318,6094,0,0;QS=3,0;MQSB=0.875769;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,149:5:0 0,9,114:3:0 +X 2291 . T <*> 0 . DP=20;I16=7,13,0,0,731,27165,0,0,1177,69769,0,0,322,6186,0,0;QS=3,0;MQSB=0.875769;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,151:5:0 0,9,112:3:0 +X 2292 . G <*> 0 . DP=20;I16=7,13,0,0,749,28747,0,0,1177,69769,0,0,325,6259,0,0;QS=3,0;MQSB=0.875769;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,156:5:0 0,9,109:3:0 +X 2293 . G <*> 0 . DP=20;I16=7,13,0,0,739,27903,0,0,1177,69769,0,0,327,6311,0,0;QS=3,0;MQSB=0.875769;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,156:5:0 0,9,112:3:0 +X 2294 . C <*> 0 . DP=21;I16=7,14,0,0,775,29453,0,0,1237,73369,0,0,329,6391,0,0;QS=3,0;MQSB=0.872525;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,169:5:0 0,9,114:3:0 +X 2295 . T <*> 0 . DP=21;I16=7,14,0,0,773,29209,0,0,1237,73369,0,0,331,6451,0,0;QS=3,0;MQSB=0.872525;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,164:5:0 0,9,115:3:0 +X 2296 . T <*> 0 . DP=21;I16=7,14,0,0,756,27780,0,0,1237,73369,0,0,333,6543,0,0;QS=3,0;MQSB=0.872525;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,160:5:0 0,9,106:3:0 +X 2297 . G <*> 0 . DP=20;I16=7,13,0,0,736,27692,0,0,1177,69769,0,0,336,6666,0,0;QS=3,0;MQSB=0.875769;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,165:5:0 0,6,74:2:0 +X 2298 . C <*> 0 . DP=21;I16=7,14,0,0,778,29300,0,0,1237,73369,0,0,339,6819,0,0;QS=3,0;MQSB=0.872525;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,139:5:0 0,9,106:3:0 +X 2299 . A <*> 0 . DP=21;I16=7,14,0,0,714,25282,0,0,1237,73369,0,0,343,7003,0,0;QS=3,0;MQSB=0.872525;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,128:5:0 0,9,110:3:0 +X 2300 . C <*> 0 . DP=21;I16=7,13,0,0,687,24749,0,0,1177,69769,0,0,326,6768,0,0;QS=3,0;MQSB=0.875769;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,148:5:0 0,9,109:3:0 +X 2301 . C <*> 0 . DP=23;I16=7,15,0,0,802,30292,0,0,1266,74210,0,0,349,7363,0,0;QS=3,0;MQSB=0.970024;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,147:5:0 0,9,116:3:0 +X 2302 . T <*> 0 . DP=23;I16=7,16,0,0,860,32956,0,0,1326,77810,0,0,354,7496,0,0;QS=3,0;MQSB=0.964916;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,166:5:0 0,12,150:4:0 +X 2303 . G <*> 0 . DP=23;I16=7,16,0,0,817,29823,0,0,1326,77810,0,0,356,7604,0,0;QS=3,0;MQSB=0.964916;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,151:5:0 0,12,139:4:0 +X 2304 . T <*> 0 . DP=23;I16=7,16,0,0,802,28628,0,0,1326,77810,0,0,357,7691,0,0;QS=3,0;MQSB=0.964916;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,148:5:0 0,12,140:4:0 +X 2305 . A <*> 0 . DP=22;I16=7,14,0,0,725,25585,0,0,1237,73369,0,0,355,7791,0,0;QS=3,0;MQSB=0.872525;MQ0F=0 PL:DP:DV 0,36,248:12:0 0,15,155:5:0 0,12,129:4:0 +X 2306 . A <*> 0 . DP=21;I16=7,14,0,0,727,26841,0,0,1206,70610,0,0,361,7899,0,0;QS=3,0;MQSB=0.975265;MQ0F=0 PL:DP:DV 0,36,246:12:0 0,15,168:5:0 0,12,130:4:0 +X 2307 . T <*> 0 . DP=21;I16=7,14,0,0,751,27427,0,0,1206,70610,0,0,362,7964,0,0;QS=3,0;MQSB=0.975265;MQ0F=0 PL:DP:DV 0,36,251:12:0 0,15,165:5:0 0,12,141:4:0 +X 2308 . C <*> 0 . DP=21;I16=7,14,0,0,735,26675,0,0,1206,70610,0,0,363,8051,0,0;QS=3,0;MQSB=0.975265;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,144:5:0 0,12,146:4:0 +X 2309 . C A,<*> 0 . DP=19;I16=7,11,0,1,604,21364,16,256,1057,62569,29,841,358,8094,8,64;QS=2.95676,0.0432432,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.985816;BQB=1;MQ0F=0 PL:DP:DV 0,20,224,33,227,230:12:1 0,9,94,9,94,94:3:0 0,12,138,12,138,138:4:0 +X 2310 . C <*> 0 . DP=18;I16=6,12,0,0,668,25392,0,0,1049,62041,0,0,370,8282,0,0;QS=3,0;MQSB=0.961295;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,80:2:0 0,12,139:4:0 +X 2311 . A <*> 0 . DP=19;I16=7,12,0,0,707,26855,0,0,1109,65641,0,0,373,8371,0,0;QS=3,0;MQSB=0.957193;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,78:2:0 0,12,137:4:0 +X 2312 . G <*> 0 . DP=20;I16=7,12,0,0,736,29118,0,0,1109,65641,0,0,364,8306,0,0;QS=3,0;MQSB=0.957193;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,82:2:0 0,9,122:3:0 +X 2313 . C <*> 0 . DP=20;I16=7,13,0,0,723,27231,0,0,1169,69241,0,0,382,8596,0,0;QS=3,0;MQSB=0.962269;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,76:2:0 0,12,130:4:0 +X 2314 . A <*> 0 . DP=21;I16=7,12,0,0,630,22184,0,0,1109,65641,0,0,372,8510,0,0;QS=3,0;MQSB=0.957193;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,78:2:0 0,9,115:3:0 +X 2315 . C <*> 0 . DP=23;I16=7,14,0,0,739,26861,0,0,1229,72841,0,0,392,8892,0,0;QS=3,0;MQSB=0.966484;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,71:2:0 0,12,135:4:0 +X 2316 . T <*> 0 . DP=23;I16=8,15,0,0,826,30690,0,0,1349,80041,0,0,408,9102,0,0;QS=3,0;MQSB=0.967216;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,105:3:0 0,15,170:5:0 +X 2317 . T <*> 0 . DP=24;I16=7,16,0,0,766,27014,0,0,1349,80041,0,0,411,9211,0,0;QS=3,0;MQSB=0.973027;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,78:2:0 0,15,170:5:0 +X 2318 . T <*> 0 . DP=24;I16=8,14,0,0,757,27433,0,0,1320,79200,0,0,379,8449,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,91:3:0 0,15,165:5:0 +X 2319 . G <*> 0 . DP=24;I16=6,16,0,0,827,31577,0,0,1289,76441,0,0,398,8882,0,0;QS=3,0;MQSB=0.97584;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,3,43:1:0 0,15,167:5:0 +X 2320 . G <*> 0 . DP=23;I16=7,16,0,0,803,29077,0,0,1349,80041,0,0,435,9675,0,0;QS=3,0;MQSB=0.973027;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,87:3:0 0,15,157:5:0 +X 2321 . G <*> 0 . DP=23;I16=7,16,0,0,804,29368,0,0,1349,80041,0,0,442,9840,0,0;QS=3,0;MQSB=0.973027;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,79:3:0 0,15,169:5:0 +X 2322 . A <*> 0 . DP=24;I16=7,17,0,0,860,32116,0,0,1409,83641,0,0,449,10027,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,95:3:0 0,15,178:5:0 +X 2323 . G <*> 0 . DP=24;I16=7,17,0,0,863,31887,0,0,1409,83641,0,0,457,10237,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,88:3:0 0,15,153:5:0 +X 2324 . G <*> 0 . DP=24;I16=7,16,0,0,786,27932,0,0,1349,80041,0,0,462,10416,0,0;QS=3,0;MQSB=0.973027;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,88:3:0 0,15,161:5:0 +X 2325 . C <*> 0 . DP=24;I16=7,15,0,0,730,25576,0,0,1289,76441,0,0,427,9625,0,0;QS=3,0;MQSB=0.970024;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,102:3:0 0,12,130:4:0 +X 2326 . C <*> 0 . DP=24;I16=7,15,0,0,709,23523,0,0,1320,79200,0,0,426,9498,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,241:15:0 0,9,95:3:0 0,12,133:4:0 +X 2327 . G <*> 0 . DP=24;I16=7,17,0,0,817,29275,0,0,1409,83641,0,0,481,10891,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,81:3:0 0,15,158:5:0 +X 2328 . A <*> 0 . DP=24;I16=6,17,0,0,814,29804,0,0,1349,80041,0,0,461,10427,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,82:3:0 0,15,172:5:0 +X 2329 . G <*> 0 . DP=23;I16=6,16,0,0,755,27641,0,0,1289,76441,0,0,477,11005,0,0;QS=3,0;MQSB=0.97584;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,63:2:0 0,15,160:5:0 +X 2330 . C <*> 0 . DP=24;I16=7,17,0,0,875,33131,0,0,1409,83641,0,0,498,11424,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,87:3:0 0,18,181:6:0 +X 2331 . T <*> 0 . DP=24;I16=7,17,0,0,862,31882,0,0,1409,83641,0,0,505,11635,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,106:3:0 0,18,200:6:0 +X 2332 . A <*> 0 . DP=25;I16=8,17,0,0,926,35412,0,0,1469,87241,0,0,512,11864,0,0;QS=3,0;MQSB=0.973216;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,97:3:0 0,18,204:6:0 +X 2333 . G <*> 0 . DP=26;I16=8,17,0,0,923,35129,0,0,1469,87241,0,0,494,11436,0,0;QS=3,0;MQSB=0.973216;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,97:3:0 0,18,189:6:0 +X 2334 . G <*> 0 . DP=26;I16=8,18,0,0,928,34574,0,0,1529,90841,0,0,527,12277,0,0;QS=3,0;MQSB=0.975611;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,93:3:0 0,21,202:7:0 +X 2335 . A <*> 0 . DP=26;I16=8,18,0,0,967,36793,0,0,1529,90841,0,0,535,12513,0,0;QS=3,0;MQSB=0.975611;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,105:3:0 0,21,214:7:0 +X 2336 . G <*> 0 . DP=26;I16=8,18,0,0,962,36346,0,0,1529,90841,0,0,543,12769,0,0;QS=3,0;MQSB=0.975611;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,92:3:0 0,21,204:7:0 +X 2337 . G <*> 0 . DP=26;I16=7,18,0,0,895,32981,0,0,1469,87241,0,0,527,12465,0,0;QS=3,0;MQSB=0.977814;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,74:2:0 0,21,204:7:0 +X 2338 . A <*> 0 . DP=26;I16=8,18,0,0,892,31758,0,0,1529,90841,0,0,556,13186,0,0;QS=3,0;MQSB=0.975611;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,87:3:0 0,21,194:7:0 +X 2339 . T <*> 0 . DP=26;I16=7,18,0,0,827,28921,0,0,1469,87241,0,0,537,12769,0,0;QS=3,0;MQSB=0.977814;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,55:2:0 0,21,200:7:0 +X 2340 . C <*> 0 . DP=25;I16=7,18,0,0,792,25816,0,0,1469,87241,0,0,541,12893,0,0;QS=3,0;MQSB=0.977814;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,57:2:0 0,21,173:7:0 +X 2341 . G <*> 0 . DP=25;I16=6,17,0,0,771,26477,0,0,1349,80041,0,0,494,11732,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,3,41:1:0 0,21,186:7:0 +X 2342 . T <*> 0 . DP=24;I16=6,17,0,0,863,32711,0,0,1349,80041,0,0,523,12459,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,3,43:1:0 0,21,214:7:0 +X 2343 . T <*> 0 . DP=24;I16=6,16,0,0,770,28230,0,0,1289,76441,0,0,504,12032,0,0;QS=3,0;MQSB=0.97584;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,3,44:1:0 0,21,213:7:0 +X 2344 . T <*> 0 . DP=24;I16=7,17,0,0,843,30483,0,0,1409,83641,0,0,552,13124,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,56:2:0 0,21,202:7:0 +X 2345 . G <*> 0 . DP=24;I16=7,17,0,0,897,34121,0,0,1409,83641,0,0,554,13162,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,77:2:0 0,21,206:7:0 +X 2346 . A <*> 0 . DP=24;I16=7,17,0,0,908,34818,0,0,1409,83641,0,0,556,13212,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,68:2:0 0,21,220:7:0 +X 2347 . G <*> 0 . DP=24;I16=6,17,0,0,824,30406,0,0,1349,80041,0,0,533,12649,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,3,39:1:0 0,21,190:7:0 +X 2348 . T <*> 0 . DP=24;I16=7,16,0,0,745,25653,0,0,1349,80041,0,0,544,13072,0,0;QS=3,0;MQSB=0.973027;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,64:2:0 0,18,183:6:0 +X 2349 . C <*> 0 . DP=24;I16=6,17,0,0,804,29224,0,0,1349,80041,0,0,534,12656,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,3,36:1:0 0,21,200:7:0 +X 2350 . C <*> 0 . DP=25;I16=7,17,0,0,869,31905,0,0,1409,83641,0,0,534,12652,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,63:2:0 0,21,198:7:0 +X 2351 . A <*> 0 . DP=25;I16=8,17,0,0,945,36169,0,0,1469,87241,0,0,559,13237,0,0;QS=3,0;MQSB=0.973216;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,74:2:0 0,21,222:7:0 +X 2352 . G <*> 0 . DP=25;I16=7,17,0,0,893,34005,0,0,1409,83641,0,0,533,12539,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,3,41:1:0 0,21,207:7:0 +X 2353 . C <*> 0 . DP=24;I16=7,17,0,0,866,31864,0,0,1409,83641,0,0,531,12435,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,3,41:1:0 0,21,205:7:0 +X 2354 . A <*> 0 . DP=24;I16=7,17,0,0,880,33206,0,0,1409,83641,0,0,529,12351,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,3,43:1:0 0,21,214:7:0 +X 2355 . G <*> 0 . DP=24;I16=7,17,0,0,871,32261,0,0,1409,83641,0,0,526,12238,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,3,39:1:0 0,21,195:7:0 +X 2356 . T <*> 0 . DP=24;I16=7,17,0,0,887,33305,0,0,1409,83641,0,0,521,12047,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,3,43:1:0 0,21,219:7:0 +X 2357 . T <*> 0 . DP=24;I16=7,17,0,0,899,34225,0,0,1409,83641,0,0,516,11878,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,3,43:1:0 0,21,220:7:0 +X 2358 . T <*> 0 . DP=24;I16=7,17,0,0,913,34891,0,0,1409,83641,0,0,510,11680,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,3,40:1:0 0,21,218:7:0 +X 2359 . G <*> 0 . DP=25;I16=7,17,0,0,898,34048,0,0,1409,83641,0,0,503,11451,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,3,39:1:0 0,21,209:7:0 +X 2360 . A <*> 0 . DP=25;I16=7,18,0,0,959,37113,0,0,1469,87241,0,0,514,11552,0,0;QS=3,0;MQSB=0.977814;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,72:2:0 0,21,222:7:0 +X 2361 . G <*> 0 . DP=25;I16=7,17,0,0,850,30946,0,0,1409,83641,0,0,482,10726,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,67:2:0 0,18,168:6:0 +X 2362 . A <*> 0 . DP=25;I16=7,17,0,0,762,25482,0,0,1409,83641,0,0,475,10547,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,51:2:0 0,18,159:6:0 +X 2363 . C <*> 0 . DP=25;I16=7,18,0,0,875,31837,0,0,1469,87241,0,0,493,11015,0,0;QS=3,0;MQSB=0.977814;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,65:2:0 0,21,187:7:0 +X 2364 . C <*> 0 . DP=25;I16=7,18,0,0,927,34965,0,0,1469,87241,0,0,486,10880,0,0;QS=3,0;MQSB=0.977814;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,64:2:0 0,21,201:7:0 +X 2365 . A <*> 0 . DP=24;I16=7,17,0,0,908,34754,0,0,1409,83641,0,0,479,10717,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,65:2:0 0,21,221:7:0 +X 2366 . G <*> 0 . DP=25;I16=7,17,0,0,912,35074,0,0,1440,86400,0,0,447,9951,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,58:2:0 0,21,206:7:0 +X 2367 . C <*> 0 . DP=25;I16=7,17,0,0,872,32088,0,0,1409,83641,0,0,440,9782,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,3,36:1:0 0,21,197:7:0 +X 2368 . C <*> 0 . DP=24;I16=6,17,0,0,871,33801,0,0,1349,80041,0,0,434,9634,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,3,39:1:0 0,18,180:6:0 +X 2369 . T <*> 0 . DP=24;I16=6,18,0,0,877,33009,0,0,1409,83641,0,0,452,10082,0,0;QS=3,0;MQSB=0.980199;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,49:2:0 0,18,179:6:0 +X 2370 . G <*> 0 . DP=24;I16=6,18,0,0,899,34289,0,0,1409,83641,0,0,445,9927,0,0;QS=3,0;MQSB=0.980199;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,56:2:0 0,18,179:6:0 +X 2371 . G <*> 0 . DP=24;I16=6,18,0,0,880,33088,0,0,1409,83641,0,0,438,9794,0,0;QS=3,0;MQSB=0.980199;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,51:2:0 0,18,177:6:0 +X 2372 . C <*> 0 . DP=24;I16=6,18,0,0,827,29615,0,0,1409,83641,0,0,431,9683,0,0;QS=3,0;MQSB=0.980199;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,47:2:0 0,18,163:6:0 +X 2373 . C <*> 0 . DP=24;I16=6,18,0,0,886,33212,0,0,1409,83641,0,0,424,9594,0,0;QS=3,0;MQSB=0.980199;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,58:2:0 0,18,166:6:0 +X 2374 . A <*> 0 . DP=23;I16=6,17,0,0,844,31230,0,0,1349,80041,0,0,417,9477,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,66:2:0 0,18,177:6:0 +X 2375 . A <*> 0 . DP=23;I16=5,17,0,0,788,28340,0,0,1289,76441,0,0,409,9333,0,0;QS=3,0;MQSB=0.981001;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,64:2:0 0,18,171:6:0 +X 2376 . T <*> 0 . DP=22;I16=5,17,0,0,778,27804,0,0,1289,76441,0,0,401,9161,0,0;QS=3,0;MQSB=0.981001;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,62:2:0 0,18,162:6:0 +X 2377 . A <*> 0 . DP=21;I16=4,17,0,0,704,24488,0,0,1229,72841,0,0,394,9008,0,0;QS=3,0;MQSB=0.984085;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,49:2:0 0,15,135:5:0 +X 2378 . C <*> 0 . DP=20;I16=4,16,0,0,626,20138,0,0,1169,69241,0,0,388,8872,0,0;QS=3,0;MQSB=0.982301;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,3,15:1:0 0,15,108:5:0 +X 2379 . G <*> 0 . DP=20;I16=4,16,0,0,714,25924,0,0,1169,69241,0,0,382,8752,0,0;QS=3,0;MQSB=0.982301;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,3,34:1:0 0,15,140:5:0 +X 2380 . G <*> 0 . DP=19;I16=4,14,0,0,672,25672,0,0,1049,62041,0,0,352,8022,0,0;QS=3,0;MQSB=0.977696;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,18:1:0 0,15,134:5:0 +X 2381 . C <*> 0 . DP=18;I16=4,14,0,0,676,25626,0,0,1049,62041,0,0,373,8555,0,0;QS=3,0;MQSB=0.977696;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,28:1:0 0,15,133:5:0 +X 2382 . A <*> 0 . DP=19;I16=5,14,0,0,669,23995,0,0,1109,65641,0,0,369,8475,0,0;QS=3,0;MQSB=0.97357;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,3,28:1:0 0,15,131:5:0 +X 2383 . A <*> 0 . DP=19;I16=5,14,0,0,686,25162,0,0,1109,65641,0,0,365,8359,0,0;QS=3,0;MQSB=0.97357;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,3,26:1:0 0,15,140:5:0 +X 2384 . A <*> 0 . DP=19;I16=5,14,0,0,649,22943,0,0,1109,65641,0,0,360,8210,0,0;QS=3,0;MQSB=0.97357;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,3,13:1:0 0,15,132:5:0 +X 2385 . A <*> 0 . DP=18;I16=4,14,0,0,643,23235,0,0,1049,62041,0,0,356,8078,0,0;QS=3,0;MQSB=0.977696;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,38:1:0 0,15,134:5:0 +X 2386 . C <*> 0 . DP=18;I16=4,14,0,0,652,24008,0,0,1049,62041,0,0,351,7913,0,0;QS=3,0;MQSB=0.977696;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,25:1:0 0,15,130:5:0 +X 2387 . C <*> 0 . DP=18;I16=4,14,0,0,667,25007,0,0,1049,62041,0,0,345,7717,0,0;QS=3,0;MQSB=0.977696;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,25:1:0 0,15,128:5:0 +X 2388 . C <*> 0 . DP=18;I16=4,14,0,0,691,26659,0,0,1049,62041,0,0,339,7541,0,0;QS=3,0;MQSB=0.977696;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,39:1:0 0,15,134:5:0 +X 2389 . A <*> 0 . DP=19;I16=5,14,0,0,682,24912,0,0,1109,65641,0,0,333,7385,0,0;QS=3,0;MQSB=0.97357;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,3,35:1:0 0,15,140:5:0 +X 2390 . G <*> 0 . DP=18;I16=5,13,0,0,642,23418,0,0,1049,62041,0,0,328,7200,0,0;QS=3,0;MQSB=0.970092;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,27:1:0 0,15,126:5:0 +X 2391 . T <*> 0 . DP=18;I16=5,12,0,0,624,23122,0,0,989,58441,0,0,298,6412,0,0;QS=2,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,0,0:0:0 0,15,140:5:0 +X 2392 . C <*> 0 . DP=18;I16=5,12,0,0,660,25910,0,0,989,58441,0,0,291,6171,0,0;QS=2,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,0,0:0:0 0,15,131:5:0 +X 2393 . T <*> 0 . DP=18;I16=5,13,0,0,669,25099,0,0,1049,62041,0,0,309,6577,0,0;QS=3,0;MQSB=0.970092;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,38:1:0 0,15,134:5:0 +X 2394 . C <*> 0 . DP=17;I16=5,12,0,0,653,25323,0,0,989,58441,0,0,303,6379,0,0;QS=3,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,3,29:1:0 0,15,133:5:0 +X 2395 . T <*> 0 . DP=17;I16=5,12,0,0,613,22621,0,0,989,58441,0,0,297,6201,0,0;QS=3,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,3,19:1:0 0,15,128:5:0 +X 2396 . A <*> 0 . DP=17;I16=5,11,0,0,584,21426,0,0,929,54841,0,0,266,5418,0,0;QS=2,0;MQSB=0.960687;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,0,0:0:0 0,15,130:5:0 +X 2397 . C <*> 0 . DP=18;I16=5,13,0,0,650,24046,0,0,1049,62041,0,0,284,5856,0,0;QS=3,0;MQSB=0.970092;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,18:1:0 0,15,129:5:0 +X 2398 . A <*> 0 . DP=18;I16=5,13,0,0,617,21907,0,0,1049,62041,0,0,278,5692,0,0;QS=3,0;MQSB=0.970092;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,19:1:0 0,15,128:5:0 +X 2399 . A <*> 0 . DP=17;I16=5,11,0,0,592,22176,0,0,929,54841,0,0,248,4926,0,0;QS=2,0;MQSB=0.960687;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,0,0:0:0 0,12,115:4:0 +X 2400 . A <*> 0 . DP=16;I16=5,11,0,0,576,21010,0,0,929,54841,0,0,269,5431,0,0;QS=3,0;MQSB=0.960687;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,26:1:0 0,9,99:3:0 +X 2401 . A <*> 0 . DP=17;I16=6,11,0,0,594,21126,0,0,989,58441,0,0,265,5331,0,0;QS=3,0;MQSB=0.955563;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,3,23:1:0 0,9,98:3:0 +X 2402 . A <*> 0 . DP=17;I16=6,11,0,0,606,21986,0,0,989,58441,0,0,262,5252,0,0;QS=3,0;MQSB=0.955563;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,3,27:1:0 0,9,99:3:0 +X 2403 . A <*> 0 . DP=17;I16=6,11,0,0,608,22130,0,0,989,58441,0,0,259,5195,0,0;QS=3,0;MQSB=0.955563;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,3,21:1:0 0,9,97:3:0 +X 2404 . T <*> 0 . DP=17;I16=6,11,0,0,567,19449,0,0,989,58441,0,0,256,5160,0,0;QS=3,0;MQSB=0.955563;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,3,14:1:0 0,9,87:3:0 +X 2405 . A <*> 0 . DP=18;I16=7,11,0,0,618,21666,0,0,1049,62041,0,0,253,5147,0,0;QS=3,0;MQSB=0.951002;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,3,17:1:0 0,9,88:3:0 +X 2406 . C <*> 0 . DP=18;I16=7,11,0,0,676,25664,0,0,1049,62041,0,0,250,5108,0,0;QS=3,0;MQSB=0.951002;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,3,27:1:0 0,9,90:3:0 +X 2407 . A <*> 0 . DP=19;I16=8,11,0,0,673,24197,0,0,1109,65641,0,0,246,5046,0,0;QS=3,0;MQSB=0.946915;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,3,34:1:0 0,9,89:3:0 +X 2408 . A <*> 0 . DP=18;I16=8,10,0,0,619,21951,0,0,1049,62041,0,0,243,4961,0,0;QS=3,0;MQSB=0.938795;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,3,22:1:0 0,6,73:2:0 +X 2409 . A <*> 0 . DP=17;I16=8,9,0,0,615,22687,0,0,1020,61200,0,0,240,4852,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,3,39:1:0 0,6,74:2:0 +X 2410 . A <*> 0 . DP=17;I16=8,9,0,0,604,21938,0,0,1020,61200,0,0,237,4769,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,3,39:1:0 0,6,73:2:0 +X 2411 . A <*> 0 . DP=16;I16=7,9,0,0,567,20551,0,0,960,57600,0,0,235,4711,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,3,25:1:0 0,6,70:2:0 +X 2412 . A <*> 0 . DP=15;I16=7,8,0,0,527,18903,0,0,900,54000,0,0,234,4676,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,21:1:0 0,6,70:2:0 +X 2413 . C <*> 0 . DP=15;I16=7,8,0,0,559,21161,0,0,900,54000,0,0,233,4663,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,22:1:0 0,6,72:2:0 +X 2414 . A <*> 0 . DP=16;I16=8,8,0,0,570,20822,0,0,929,54841,0,0,232,4672,0,0;QS=3,0;MQSB=0.915545;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,3,25:1:0 0,6,73:2:0 +X 2415 . A <*> 0 . DP=16;I16=9,7,0,0,574,20768,0,0,929,54841,0,0,232,4652,0,0;QS=3,0;MQSB=0.933674;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,3,30:1:0 0,6,64:2:0 +X 2416 . C <*> 0 . DP=17;I16=8,8,0,0,576,21424,0,0,960,57600,0,0,231,4649,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,42:2:0 0,6,68:2:0 +X 2417 . T <*> 0 . DP=17;I16=10,7,0,0,612,22740,0,0,958,55682,0,0,235,4627,0,0;QS=3,0;MQSB=0.79189;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,57:2:0 0,9,92:3:0 +X 2418 . A <*> 0 . DP=17;I16=10,7,0,0,624,23210,0,0,958,55682,0,0,238,4626,0,0;QS=3,0;MQSB=0.79189;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,62:2:0 0,9,105:3:0 +X 2419 . G <*> 0 . DP=19;I16=11,7,0,0,651,24113,0,0,1018,59282,0,0,241,4651,0,0;QS=3,0;MQSB=0.817948;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,51:2:0 0,12,126:4:0 +X 2420 . C <*> 0 . DP=19;I16=11,8,0,0,663,23999,0,0,1078,62882,0,0,246,4704,0,0;QS=3,0;MQSB=0.803979;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,44:2:0 0,12,127:4:0 +X 2421 . C <*> 0 . DP=19;I16=10,8,0,0,657,24779,0,0,1049,62041,0,0,244,4738,0,0;QS=3,0;MQSB=0.938795;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,45:2:0 0,12,126:4:0 +X 2422 . A <*> 0 . DP=18;I16=11,6,0,0,647,24747,0,0,958,55682,0,0,238,4538,0,0;QS=3,0;MQSB=0.833753;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,33:1:0 0,12,137:4:0 +X 2423 . G <*> 0 . DP=18;I16=11,6,0,0,634,24250,0,0,958,55682,0,0,258,4972,0,0;QS=3,0;MQSB=0.833753;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,54:2:0 0,12,126:4:0 +X 2424 . G <*> 0 . DP=18;I16=10,6,0,0,595,22361,0,0,929,54841,0,0,240,4714,0,0;QS=3,0;MQSB=0.948436;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,3,36:1:0 0,12,126:4:0 +X 2425 . C <*> 0 . DP=18;I16=10,7,0,0,596,21716,0,0,989,58441,0,0,260,5074,0,0;QS=3,0;MQSB=0.943335;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,45:2:0 0,12,114:4:0 +X 2426 . G <*> 0 . DP=18;I16=10,7,0,0,550,18088,0,0,989,58441,0,0,263,5171,0,0;QS=3,0;MQSB=0.943335;MQ0F=0 PL:DP:DV 0,33,232:11:0 0,6,59:2:0 0,12,113:4:0 +X 2427 . T <*> 0 . DP=18;I16=11,6,0,0,618,22654,0,0,958,55682,0,0,275,5403,0,0;QS=3,0;MQSB=0.833753;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,62:2:0 0,9,99:3:0 +X 2428 . G <*> 0 . DP=18;I16=11,7,0,0,649,24633,0,0,1018,59282,0,0,281,5535,0,0;QS=3,0;MQSB=0.817948;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,48:2:0 0,12,128:4:0 +X 2429 . G <*> 0 . DP=18;I16=10,7,0,0,553,19057,0,0,989,58441,0,0,269,5459,0,0;QS=3,0;MQSB=0.943335;MQ0F=0 PL:DP:DV 0,33,241:11:0 0,6,55:2:0 0,12,117:4:0 +X 2430 . T A,<*> 0 . DP=18;I16=10,7,1,0,552,18556,21,441,989,58441,29,841,271,5603,16,256;QS=2.94278,0.0572207,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.817948;BQB=1;MQ0F=0 PL:DP:DV 0,15,212,33,215,222:12:1 0,6,60,6,60,60:2:0 0,12,125,12,125,125:4:0 +X 2431 . G <*> 0 . DP=18;I16=11,5,0,0,580,21766,0,0,898,52082,0,0,268,5764,0,0;QS=3,0;MQSB=0.851779;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,37:1:0 0,9,98:3:0 +X 2432 . G <*> 0 . DP=17;I16=10,7,0,0,593,21479,0,0,958,55682,0,0,295,6179,0,0;QS=3,0;MQSB=0.79189;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,53:2:0 0,9,97:3:0 +X 2433 . T <*> 0 . DP=17;I16=10,7,0,0,577,20425,0,0,958,55682,0,0,299,6321,0,0;QS=3,0;MQSB=0.79189;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,57:2:0 0,9,94:3:0 +X 2434 . G <*> 0 . DP=17;I16=10,6,0,0,546,19340,0,0,929,54841,0,0,284,6082,0,0;QS=3,0;MQSB=0.948436;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,46:2:0 0,6,62:2:0 +X 2435 . C <*> 0 . DP=18;I16=12,5,0,0,597,21843,0,0,958,55682,0,0,304,6626,0,0;QS=3,0;MQSB=0.870325;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,58:2:0 0,6,60:2:0 +X 2436 . A <*> 0 . DP=18;I16=11,6,0,0,545,18599,0,0,989,58441,0,0,295,6379,0,0;QS=3,0;MQSB=0.955563;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,64:3:0 0,6,61:2:0 +X 2437 . C <*> 0 . DP=18;I16=11,5,0,0,573,21195,0,0,929,54841,0,0,297,6541,0,0;QS=3,0;MQSB=0.960687;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,63:2:0 0,6,63:2:0 +X 2438 . A <*> 0 . DP=19;I16=12,6,0,0,583,20111,0,0,1018,59282,0,0,328,7322,0,0;QS=3,0;MQSB=0.85394;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,65:2:0 0,6,65:2:0 +X 2439 . C <*> 0 . DP=19;I16=11,7,0,0,635,22997,0,0,1049,62041,0,0,314,6974,0,0;QS=3,0;MQSB=0.951002;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,91:3:0 0,6,57:2:0 +X 2440 . C <*> 0 . DP=21;I16=13,7,0,0,701,26195,0,0,1138,66482,0,0,346,7840,0,0;QS=3,0;MQSB=0.857404;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,114:4:0 0,6,66:2:0 +X 2441 . T <*> 0 . DP=21;I16=13,8,0,0,788,29910,0,0,1198,70082,0,0,360,8068,0,0;QS=3,0;MQSB=0.845496;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,164:5:0 0,6,67:2:0 +X 2442 . G <*> 0 . DP=20;I16=12,7,0,0,695,25957,0,0,1109,65641,0,0,342,7596,0,0;QS=3,0;MQSB=0.957193;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,128:4:0 0,6,66:2:0 +X 2443 . T <*> 0 . DP=20;I16=13,7,0,0,697,24685,0,0,1138,66482,0,0,373,8345,0,0;QS=3,0;MQSB=0.857404;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,130:4:0 0,6,64:2:0 +X 2444 . A <*> 0 . DP=21;I16=13,8,0,0,755,27981,0,0,1198,70082,0,0,379,8489,0,0;QS=3,0;MQSB=0.845496;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,140:4:0 0,6,64:2:0 +X 2445 . G <*> 0 . DP=21;I16=12,8,0,0,731,27427,0,0,1169,69241,0,0,359,7927,0,0;QS=3,0;MQSB=0.953497;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,130:4:0 0,6,65:2:0 +X 2446 . T <*> 0 . DP=21;I16=13,8,0,0,723,25707,0,0,1198,70082,0,0,389,8633,0,0;QS=3,0;MQSB=0.845496;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,128:4:0 0,6,65:2:0 +X 2447 . C <*> 0 . DP=22;I16=14,8,0,0,770,27950,0,0,1258,73682,0,0,394,8732,0,0;QS=3,0;MQSB=0.86151;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,127:4:0 0,6,64:2:0 +X 2448 . C <*> 0 . DP=23;I16=14,7,0,0,727,26165,0,0,1167,67323,0,0,388,8674,0,0;QS=3,0;MQSB=0.735784;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,129:5:0 0,6,66:2:0 +X 2449 . C <*> 0 . DP=23;I16=13,8,0,0,727,26415,0,0,1198,70082,0,0,363,7787,0,0;QS=3,0;MQSB=0.845496;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,128:5:0 0,6,62:2:0 +X 2450 . A <*> 0 . DP=22;I16=12,8,0,0,673,24267,0,0,1138,66482,0,0,371,7959,0,0;QS=3,0;MQSB=0.826565;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,143:5:0 0,6,65:2:0 +X 2451 . G <*> 0 . DP=22;I16=14,8,0,0,821,31595,0,0,1227,70923,0,0,429,9401,0,0;QS=3,0;MQSB=0.715049;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,151:5:0 0,6,67:2:0 +X 2452 . C <*> 0 . DP=22;I16=14,8,0,0,743,26557,0,0,1227,70923,0,0,437,9613,0,0;QS=3,0;MQSB=0.715049;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,137:5:0 0,6,66:2:0 +X 2453 . T <*> 0 . DP=22;I16=14,8,0,0,775,28215,0,0,1227,70923,0,0,445,9845,0,0;QS=3,0;MQSB=0.715049;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,143:5:0 0,6,68:2:0 +X 2454 . A <*> 0 . DP=22;I16=14,8,0,0,721,24545,0,0,1227,70923,0,0,453,10097,0,0;QS=3,0;MQSB=0.715049;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,145:5:0 0,6,64:2:0 +X 2455 . C <*> 0 . DP=22;I16=14,8,0,0,776,28212,0,0,1227,70923,0,0,461,10369,0,0;QS=3,0;MQSB=0.715049;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,138:5:0 0,6,65:2:0 +X 2456 . T <*> 0 . DP=24;I16=14,9,0,0,834,30902,0,0,1318,77282,0,0,444,10036,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,168:6:0 0,6,60:2:0 +X 2457 . C <*> 0 . DP=24;I16=15,9,0,0,816,29244,0,0,1347,78123,0,0,478,10924,0,0;QS=3,0;MQSB=0.72325;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,159:6:0 0,6,65:2:0 +X 2458 . A <*> 0 . DP=24;I16=15,9,0,0,869,32555,0,0,1347,78123,0,0,487,11209,0,0;QS=3,0;MQSB=0.72325;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,166:6:0 0,6,65:2:0 +X 2459 . G T,<*> 0 . DP=24;I16=13,9,1,0,822,31186,13,169,1289,76441,29,841,453,10551,17,289;QS=2.92973,0.0702703,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.851535;BQB=1;MQ0F=0 PL:DP:DV 0,45,255,45,255,255:15:0 0,5,138,15,141,144:6:1 0,6,64,6,64,64:2:0 +X 2460 . G <*> 0 . DP=24;I16=14,9,0,0,834,31432,0,0,1318,77282,0,0,477,11065,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,160:6:0 0,6,65:2:0 +X 2461 . A G,<*> 0 . DP=24;I16=14,9,1,0,839,31487,13,169,1318,77282,29,841,489,11521,19,361;QS=2.93401,0.0659898,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.72325;BQB=1;MQ0F=0 PL:DP:DV 0,48,255,48,255,255:16:0 0,5,148,15,151,154:6:1 0,6,67,6,67,67:2:0 +X 2462 . G <*> 0 . DP=25;I16=15,10,0,0,893,33155,0,0,1407,81723,0,0,514,12090,0,0;QS=3,0;MQSB=0.707404;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,165:6:0 0,6,66:2:0 +X 2463 . G T,<*> 0 . DP=25;I16=12,10,1,0,777,28525,14,196,1289,76441,29,841,452,10720,25,625;QS=2.975,0.025,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.825053;BQB=1;MQ0F=0 PL:DP:DV 0,36,255,48,255,255:17:1 0,12,133,12,133,133:4:0 0,6,68,6,68,68:2:0 +X 2464 . C <*> 0 . DP=25;I16=15,10,0,0,904,34194,0,0,1407,81723,0,0,526,12458,0,0;QS=3,0;MQSB=0.707404;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,149:6:0 0,6,67:2:0 +X 2465 . T <*> 0 . DP=25;I16=14,10,0,0,857,32235,0,0,1347,78123,0,0,506,11994,0,0;QS=3,0;MQSB=0.679965;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,163:6:0 0,6,69:2:0 +X 2466 . G <*> 0 . DP=24;I16=14,9,0,0,852,32336,0,0,1318,77282,0,0,509,12025,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,157:6:0 0,6,63:2:0 +X 2467 . A <*> 0 . DP=24;I16=14,9,0,0,829,30725,0,0,1318,77282,0,0,513,12121,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,168:6:0 0,6,67:2:0 +X 2468 . G <*> 0 . DP=24;I16=15,9,0,0,890,34034,0,0,1347,78123,0,0,541,12807,0,0;QS=3,0;MQSB=0.72325;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,169:6:0 0,6,64:2:0 +X 2469 . G <*> 0 . DP=24;I16=15,9,0,0,865,32303,0,0,1347,78123,0,0,544,12882,0,0;QS=3,0;MQSB=0.72325;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,174:6:0 0,6,58:2:0 +X 2470 . G <*> 0 . DP=24;I16=14,9,0,0,829,30785,0,0,1318,77282,0,0,521,12295,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,178:6:0 0,6,58:2:0 +X 2471 . G <*> 0 . DP=24;I16=14,9,0,0,833,31429,0,0,1318,77282,0,0,523,12345,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,170:5:0 0,6,64:2:0 +X 2472 . G <*> 0 . DP=24;I16=13,9,0,0,774,28428,0,0,1289,76441,0,0,499,11733,0,0;QS=3,0;MQSB=0.955854;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,154:5:0 0,6,56:2:0 +X 2473 . A <*> 0 . DP=24;I16=13,9,0,0,775,28137,0,0,1258,73682,0,0,508,12078,0,0;QS=3,0;MQSB=0.834768;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,160:5:0 0,6,63:2:0 +X 2474 . A <*> 0 . DP=25;I16=15,9,0,0,851,31665,0,0,1378,80882,0,0,524,12322,0,0;QS=3,0;MQSB=0.865888;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,160:5:0 0,9,80:3:0 +X 2475 . G <*> 0 . DP=25;I16=15,9,0,0,913,35239,0,0,1378,80882,0,0,525,12323,0,0;QS=3,0;MQSB=0.865888;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,167:5:0 0,9,84:3:0 +X 2476 . G <*> 0 . DP=25;I16=13,9,0,0,776,28584,0,0,1289,76441,0,0,488,11544,0,0;QS=3,0;MQSB=0.955854;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,138:5:0 0,9,82:3:0 +X 2477 . A <*> 0 . DP=25;I16=14,9,0,0,867,34329,0,0,1318,77282,0,0,515,12223,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,178:5:0 0,9,91:3:0 +X 2478 . C <*> 0 . DP=25;I16=14,9,0,0,897,36911,0,0,1318,77282,0,0,517,12289,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,175:5:0 0,9,87:3:0 +X 2479 . T <*> 0 . DP=25;I16=15,9,0,0,921,37957,0,0,1378,80882,0,0,529,12467,0,0;QS=3,0;MQSB=0.865888;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,176:5:0 0,9,97:3:0 +X 2480 . G <*> 0 . DP=25;I16=14,9,0,0,877,35485,0,0,1349,80041,0,0,504,11864,0,0;QS=3,0;MQSB=0.960618;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,176:5:0 0,9,88:3:0 +X 2481 . C <*> 0 . DP=25;I16=13,9,0,0,848,34542,0,0,1289,76441,0,0,496,11838,0,0;QS=3,0;MQSB=0.955854;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,183:5:0 0,9,88:3:0 +X 2482 . T <*> 0 . DP=25;I16=15,9,0,0,905,37331,0,0,1378,80882,0,0,526,12430,0,0;QS=3,0;MQSB=0.865888;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,178:5:0 0,9,96:3:0 +X 2483 . T <*> 0 . DP=25;I16=14,9,0,0,879,36187,0,0,1318,77282,0,0,517,12311,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,180:5:0 0,9,89:3:0 +X 2484 . G <*> 0 . DP=25;I16=14,9,0,0,884,35142,0,0,1349,80041,0,0,494,11604,0,0;QS=3,0;MQSB=0.960618;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,174:5:0 0,9,84:3:0 +X 2485 . A T,<*> 0 . DP=25;I16=14,9,1,0,891,36757,17,289,1349,80041,29,841,490,11502,25,625;QS=2.96926,0.0307414,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.865888;BQB=1;MQ0F=0 PL:DP:DV 0,31,255,45,255,255:16:1 0,15,193,15,193,193:5:0 0,9,93,9,93,93:3:0 +X 2486 . G <*> 0 . DP=25;I16=15,9,0,0,898,36230,0,0,1378,80882,0,0,511,12041,0,0;QS=3,0;MQSB=0.865888;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,153:5:0 0,9,90:3:0 +X 2487 . C <*> 0 . DP=25;I16=14,9,0,0,793,30695,0,0,1349,80041,0,0,482,11346,0,0;QS=3,0;MQSB=0.960618;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,175:5:0 0,9,91:3:0 +X 2488 . C <*> 0 . DP=25;I16=13,9,0,0,841,34597,0,0,1289,76441,0,0,457,10841,0,0;QS=3,0;MQSB=0.955854;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,174:5:0 0,9,93:3:0 +X 2489 . C <*> 0 . DP=23;I16=11,9,0,0,801,34227,0,0,1169,69241,0,0,454,10788,0,0;QS=3,0;MQSB=0.943233;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,187:5:0 0,9,93:3:0 +X 2490 . A <*> 0 . DP=23;I16=11,10,0,0,818,34642,0,0,1229,72841,0,0,451,10695,0,0;QS=3,0;MQSB=0.939898;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,175:5:0 0,12,128:4:0 +X 2491 . G <*> 0 . DP=23;I16=12,10,0,0,845,35143,0,0,1258,73682,0,0,471,11097,0,0;QS=3,0;MQSB=0.804615;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,178:5:0 0,12,121:4:0 +X 2492 . G A,<*> 0 . DP=23;I16=11,10,1,0,845,36207,16,256,1229,72841,29,841,446,10494,21,441;QS=2.96708,0.0329218,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.804615;BQB=1;MQ0F=0 PL:DP:DV 0,22,255,36,255,255:13:1 0,15,187,15,187,187:5:0 0,12,124,12,124,124:4:0 +X 2493 . A G,<*> 0 . DP=23;I16=11,10,1,0,855,37007,13,169,1229,72841,29,841,442,10340,20,400;QS=2.97269,0.0273109,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.804615;BQB=1;MQ0F=0 PL:DP:DV 0,25,255,36,255,255:13:1 0,15,191,15,191,191:5:0 0,12,127,12,127,127:4:0 +X 2494 . G <*> 0 . DP=23;I16=11,10,0,0,802,32720,0,0,1229,72841,0,0,437,10153,0,0;QS=3,0;MQSB=0.939898;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,179:5:0 0,12,118:4:0 +X 2495 . T <*> 0 . DP=23;I16=10,10,0,0,737,29861,0,0,1138,66482,0,0,413,9513,0,0;QS=3,0;MQSB=0.751477;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,172:5:0 0,12,113:4:0 +X 2496 . T <*> 0 . DP=23;I16=12,10,0,0,815,32793,0,0,1258,73682,0,0,442,10026,0,0;QS=3,0;MQSB=0.804615;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,183:5:0 0,12,123:4:0 +X 2497 . T <*> 0 . DP=22;I16=12,9,0,0,807,33723,0,0,1198,70082,0,0,436,9814,0,0;QS=3,0;MQSB=0.815018;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,177:5:0 0,12,131:4:0 +X 2498 . G <*> 0 . DP=22;I16=12,9,0,0,808,33264,0,0,1198,70082,0,0,430,9622,0,0;QS=3,0;MQSB=0.815018;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,173:5:0 0,12,127:4:0 +X 2499 . A <*> 0 . DP=22;I16=12,9,0,0,847,36803,0,0,1198,70082,0,0,424,9450,0,0;QS=3,0;MQSB=0.815018;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,185:5:0 0,12,133:4:0 +X 2500 . G <*> 0 . DP=22;I16=11,9,0,0,772,32546,0,0,1169,69241,0,0,404,9078,0,0;QS=3,0;MQSB=0.943233;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,168:5:0 0,12,129:4:0 +X 2501 . G <*> 0 . DP=22;I16=11,8,0,0,768,33120,0,0,1109,65641,0,0,373,8293,0,0;QS=3,0;MQSB=0.946915;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,146:4:0 0,12,118:4:0 +X 2502 . C <*> 0 . DP=22;I16=12,8,0,0,798,33902,0,0,1138,66482,0,0,378,8270,0,0;QS=3,0;MQSB=0.826565;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,155:4:0 0,12,125:4:0 +X 2503 . T <*> 0 . DP=22;I16=12,9,0,0,851,36841,0,0,1198,70082,0,0,396,8746,0,0;QS=3,0;MQSB=0.815018;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,180:5:0 0,12,139:4:0 +X 2504 . G <*> 0 . DP=22;I16=12,9,0,0,787,31955,0,0,1198,70082,0,0,389,8615,0,0;QS=3,0;MQSB=0.815018;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,171:5:0 0,12,129:4:0 +X 2505 . C <*> 0 . DP=21;I16=11,9,0,0,792,33440,0,0,1138,66482,0,0,383,8501,0,0;QS=3,0;MQSB=0.791547;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,169:5:0 0,12,132:4:0 +X 2506 . T <*> 0 . DP=22;I16=11,10,0,0,798,32868,0,0,1198,70082,0,0,376,8354,0,0;QS=3,0;MQSB=0.780412;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,175:5:0 0,15,169:5:0 +X 2507 . G <*> 0 . DP=21;I16=9,10,0,0,716,30074,0,0,1109,65641,0,0,365,8189,0,0;QS=3,0;MQSB=0.920044;MQ0F=0 PL:DP:DV 0,27,241:9:0 0,15,163:5:0 0,15,153:5:0 +X 2508 . T <*> 0 . DP=21;I16=9,10,0,0,724,30396,0,0,1109,65641,0,0,361,8089,0,0;QS=3,0;MQSB=0.920044;MQ0F=0 PL:DP:DV 0,27,241:9:0 0,15,158:5:0 0,15,162:5:0 +X 2509 . G T,<*> 0 . DP=21;I16=8,10,1,0,710,30408,35,1225,1049,62041,60,3600,330,7282,25,625;QS=2.80663,0.19337,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.920044;BQB=1;MQ0F=0 PL:DP:DV 0,27,253,27,253,253:9:0 20,0,122,32,125,150:5:1 0,15,163,15,163,163:5:0 +X 2510 . A <*> 0 . DP=21;I16=10,10,0,0,778,33128,0,0,1138,66482,0,0,352,7754,0,0;QS=3,0;MQSB=0.751477;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,174:5:0 0,15,161:5:0 +X 2511 . G <*> 0 . DP=21;I16=10,10,0,0,771,32165,0,0,1138,66482,0,0,344,7558,0,0;QS=3,0;MQSB=0.751477;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,161:5:0 0,15,159:5:0 +X 2512 . C <*> 0 . DP=21;I16=10,10,0,0,790,33406,0,0,1138,66482,0,0,336,7386,0,0;QS=3,0;MQSB=0.751477;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,175:5:0 0,15,160:5:0 +X 2513 . T <*> 0 . DP=21;I16=10,10,0,0,755,31503,0,0,1138,66482,0,0,327,7189,0,0;QS=3,0;MQSB=0.751477;MQ0F=0 PL:DP:DV 0,30,246:10:0 0,15,180:5:0 0,15,156:5:0 +X 2514 . G <*> 0 . DP=20;I16=9,10,0,0,702,28002,0,0,1109,65641,0,0,319,7017,0,0;QS=3,0;MQSB=0.920044;MQ0F=0 PL:DP:DV 0,27,228:9:0 0,15,171:5:0 0,15,155:5:0 +X 2515 . T <*> 0 . DP=19;I16=8,10,0,0,642,25888,0,0,1049,62041,0,0,312,6868,0,0;QS=3,0;MQSB=0.906029;MQ0F=0 PL:DP:DV 0,24,182:8:0 0,15,172:5:0 0,15,141:5:0 +X 2516 . G <*> 0 . DP=19;I16=8,10,0,0,685,28155,0,0,1049,62041,0,0,303,6641,0,0;QS=3,0;MQSB=0.906029;MQ0F=0 PL:DP:DV 0,24,211:8:0 0,15,175:5:0 0,15,147:5:0 +X 2517 . A <*> 0 . DP=18;I16=8,9,0,0,660,27600,0,0,989,58441,0,0,295,6435,0,0;QS=3,0;MQSB=0.91051;MQ0F=0 PL:DP:DV 0,24,215:8:0 0,12,139:4:0 0,15,161:5:0 +X 2518 . T <*> 0 . DP=17;I16=6,9,0,0,611,26911,0,0,900,54000,0,0,273,6023,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,188:7:0 0,12,144:4:0 0,12,146:4:0 +X 2519 . C <*> 0 . DP=16;I16=7,8,0,0,531,20111,0,0,900,54000,0,0,282,6078,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,175:7:0 0,12,141:4:0 0,12,125:4:0 +X 2520 . G <*> 0 . DP=15;I16=6,8,0,0,501,19731,0,0,840,50400,0,0,277,5923,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,187:7:0 0,12,129:4:0 0,9,101:3:0 +X 2521 . C <*> 0 . DP=15;I16=6,8,0,0,583,25777,0,0,840,50400,0,0,272,5782,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,214:7:0 0,12,149:4:0 0,9,111:3:0 +X 2522 . A <*> 0 . DP=16;I16=6,8,0,0,516,20930,0,0,840,50400,0,0,266,5606,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,173:7:0 0,12,139:4:0 0,9,114:3:0 +X 2523 . T <*> 0 . DP=16;I16=6,9,0,0,588,25538,0,0,900,54000,0,0,270,5546,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,207:7:0 0,15,157:5:0 0,9,117:3:0 +X 2524 . C <*> 0 . DP=16;I16=5,9,0,0,548,23502,0,0,840,50400,0,0,256,5342,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,182:6:0 0,15,156:5:0 0,9,112:3:0 +X 2525 . A C,<*> 0 . DP=17;I16=6,9,0,1,550,23138,28,784,900,54000,60,3600,248,5174,12,144;QS=2.86,0.14,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=1;BQB=1;MQ0F=0 PL:DP:DV 0,24,168,24,168,168:8:0 13,0,138,25,141,159:5:1 0,9,117,9,117,117:3:0 +X 2526 . C <*> 0 . DP=18;I16=6,11,0,0,677,28649,0,0,1020,61200,0,0,256,5232,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,229:9:0 0,15,183:5:0 0,9,113:3:0 +X 2527 . T <*> 0 . DP=18;I16=6,11,0,0,674,29286,0,0,1020,61200,0,0,252,5118,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,217:9:0 0,15,183:5:0 0,9,119:3:0 +X 2528 . G <*> 0 . DP=18;I16=6,11,0,0,701,30729,0,0,1020,61200,0,0,248,5028,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,234:9:0 0,15,184:5:0 0,9,119:3:0 +X 2529 . C <*> 0 . DP=18;I16=6,11,0,0,676,28974,0,0,1020,61200,0,0,244,4962,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,228:9:0 0,15,175:5:0 0,9,117:3:0 +X 2530 . A <*> 0 . DP=18;I16=6,10,0,0,624,26620,0,0,960,57600,0,0,223,4631,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,209:9:0 0,12,153:4:0 0,9,116:3:0 +X 2531 . T <*> 0 . DP=17;I16=6,10,0,0,641,27911,0,0,960,57600,0,0,236,4852,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,210:8:0 0,15,175:5:0 0,9,122:3:0 +X 2532 . T <*> 0 . DP=17;I16=6,10,0,0,634,27460,0,0,960,57600,0,0,230,4708,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,212:8:0 0,15,173:5:0 0,9,117:3:0 +X 2533 . C <*> 0 . DP=18;I16=6,11,0,0,614,24196,0,0,1020,61200,0,0,224,4588,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,212:9:0 0,15,159:5:0 0,9,104:3:0 +X 2534 . C <*> 0 . DP=16;I16=5,10,0,0,595,25141,0,0,900,54000,0,0,221,4491,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,202:8:0 0,12,144:4:0 0,9,110:3:0 +X 2535 . A <*> 0 . DP=16;I16=5,10,0,0,617,27711,0,0,900,54000,0,0,218,4416,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,204:8:0 0,12,136:4:0 0,9,123:3:0 +X 2536 . G <*> 0 . DP=15;I16=4,10,0,0,543,23023,0,0,840,50400,0,0,216,4362,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,195:8:0 0,9,102:3:0 0,9,117:3:0 +X 2537 . C <*> 0 . DP=15;I16=4,10,0,0,555,24075,0,0,840,50400,0,0,213,4279,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,195:8:0 0,9,113:3:0 0,9,115:3:0 +X 2538 . C <*> 0 . DP=15;I16=5,9,0,0,510,21070,0,0,840,50400,0,0,211,4217,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,157:7:0 0,9,129:3:0 0,12,126:4:0 +X 2539 . C <*> 0 . DP=15;I16=5,9,0,0,464,16896,0,0,840,50400,0,0,209,4125,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,146:7:0 0,9,122:3:0 0,12,111:4:0 +X 2540 . G <*> 0 . DP=16;I16=6,9,0,0,548,21860,0,0,900,54000,0,0,207,4053,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,189:7:0 0,12,139:4:0 0,12,110:4:0 +X 2541 . G <*> 0 . DP=15;I16=5,9,0,0,535,22527,0,0,840,50400,0,0,207,4001,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,170:7:0 0,9,117:3:0 0,12,140:4:0 +X 2542 . T <*> 0 . DP=15;I16=4,9,0,0,527,23207,0,0,780,46800,0,0,203,3953,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,183:7:0 0,9,125:3:0 0,9,109:3:0 +X 2543 . G <*> 0 . DP=15;I16=5,9,0,0,540,23004,0,0,840,50400,0,0,207,3957,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,196:7:0 0,9,117:3:0 0,12,117:4:0 +X 2544 . A <*> 0 . DP=16;I16=6,9,0,0,569,24139,0,0,900,54000,0,0,207,3965,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,202:8:0 0,9,119:3:0 0,12,132:4:0 +X 2545 . C <*> 0 . DP=16;I16=6,9,0,0,583,24657,0,0,900,54000,0,0,208,3994,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,217:8:0 0,9,118:3:0 0,12,130:4:0 +X 2546 . A <*> 0 . DP=16;I16=6,9,0,0,608,27290,0,0,900,54000,0,0,209,4045,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,206:8:0 0,9,133:3:0 0,12,144:4:0 +X 2547 . G <*> 0 . DP=16;I16=6,9,0,0,597,26215,0,0,900,54000,0,0,211,4117,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,191:7:0 0,9,131:3:0 0,15,150:5:0 +X 2548 . A <*> 0 . DP=16;I16=6,9,0,0,632,28806,0,0,900,54000,0,0,214,4210,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,196:7:0 0,9,131:3:0 0,15,171:5:0 +X 2549 . G <*> 0 . DP=16;I16=6,9,0,0,594,25254,0,0,900,54000,0,0,217,4325,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,180:7:0 0,9,132:3:0 0,15,160:5:0 +X 2550 . T <*> 0 . DP=16;I16=6,9,0,0,572,24134,0,0,900,54000,0,0,219,4413,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,182:7:0 0,9,122:3:0 0,15,148:5:0 +X 2551 . G <*> 0 . DP=16;I16=6,9,0,0,578,24606,0,0,900,54000,0,0,220,4474,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,181:7:0 0,9,131:3:0 0,15,151:5:0 +X 2552 . A <*> 0 . DP=15;I16=6,8,0,0,585,26419,0,0,840,50400,0,0,221,4505,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,178:6:0 0,9,129:3:0 0,15,168:5:0 +X 2553 . G <*> 0 . DP=15;I16=6,8,0,0,528,21944,0,0,840,50400,0,0,222,4554,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,170:6:0 0,9,117:3:0 0,15,142:5:0 +X 2554 . T <*> 0 . DP=15;I16=6,8,0,0,543,23015,0,0,840,50400,0,0,223,4621,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,156:6:0 0,9,129:3:0 0,15,160:5:0 +X 2555 . C <*> 0 . DP=15;I16=6,8,0,0,566,24416,0,0,840,50400,0,0,224,4706,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,173:6:0 0,9,131:3:0 0,15,159:5:0 +X 2556 . A <*> 0 . DP=14;I16=6,7,0,0,487,20095,0,0,780,46800,0,0,226,4808,0,0;QS=3,0;MQSB=0.961166;MQ0F=0 PL:DP:DV 0,15,141:5:0 0,9,125:3:0 0,15,146:5:0 +X 2557 . C <*> 0 . DP=13;I16=5,8,0,0,471,17481,0,0,780,46800,0,0,249,5325,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,15,161:5:0 0,9,96:3:0 0,15,151:5:0 +X 2558 . T <*> 0 . DP=14;I16=5,9,0,0,535,20597,0,0,840,50400,0,0,251,5417,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,173:6:0 0,9,99:3:0 0,15,174:5:0 +X 2559 . G <*> 0 . DP=14;I16=5,9,0,0,509,18693,0,0,840,50400,0,0,253,5475,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,172:6:0 0,9,98:3:0 0,15,156:5:0 +X 2560 . T <*> 0 . DP=14;I16=5,9,0,0,489,17587,0,0,840,50400,0,0,255,5549,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,160:6:0 0,9,106:3:0 0,15,144:5:0 +X 2561 . C <*> 0 . DP=14;I16=5,9,0,0,489,17477,0,0,840,50400,0,0,257,5639,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,164:6:0 0,9,96:3:0 0,15,153:5:0 +X 2562 . T <*> 0 . DP=13;I16=5,8,0,0,460,17016,0,0,780,46800,0,0,260,5744,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,15,139:5:0 0,9,99:3:0 0,15,167:5:0 +X 2563 . C <*> 0 . DP=14;I16=5,8,0,0,433,15133,0,0,780,46800,0,0,263,5863,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,15,149:5:0 0,9,83:3:0 0,15,142:5:0 +X 2564 . A G,<*> 0 . DP=15;I16=1,4,4,5,174,6124,316,11352,300,18000,540,32400,61,1311,184,4034;QS=0.988263,2.01174,0;VDB=0.690812;SGB=-3.20711;RPB=0.197899;MQB=1;MQSB=1;BQB=0.965069;MQ0F=0 PL:DP:DV 88,0,78,98,87,171:6:3 57,0,56,63,62,117:4:2 124,12,0,124,12,124:4:4 +X 2565 . A <*> 0 . DP=15;I16=6,9,0,0,562,21216,0,0,900,54000,0,0,274,6076,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,178:6:0 0,12,134:4:0 0,15,166:5:0 +X 2566 . A <*> 0 . DP=15;I16=6,9,0,0,545,20019,0,0,900,54000,0,0,276,6098,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,181:6:0 0,12,120:4:0 0,15,162:5:0 +X 2567 . A <*> 0 . DP=16;I16=7,9,0,0,580,21342,0,0,960,57600,0,0,278,6136,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,177:6:0 0,15,151:5:0 0,15,166:5:0 +X 2568 . A <*> 0 . DP=16;I16=7,8,0,0,555,20795,0,0,900,54000,0,0,256,5566,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,180:6:0 0,12,132:4:0 0,15,167:5:0 +X 2569 . A <*> 0 . DP=17;I16=7,10,0,0,661,25943,0,0,1020,61200,0,0,284,6264,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,213:7:0 0,15,163:5:0 0,15,172:5:0 +X 2570 . G <*> 0 . DP=18;I16=8,10,0,0,664,24968,0,0,1080,64800,0,0,287,6305,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,213:7:0 0,15,152:5:0 0,18,176:6:0 +X 2571 . A <*> 0 . DP=18;I16=8,10,0,0,618,21870,0,0,1080,64800,0,0,291,6365,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,195:7:0 0,15,155:5:0 0,18,155:6:0 +X 2572 . A <*> 0 . DP=18;I16=8,10,0,0,631,22829,0,0,1080,64800,0,0,295,6445,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,194:7:0 0,15,150:5:0 0,18,173:6:0 +X 2573 . A <*> 0 . DP=18;I16=8,10,0,0,690,26830,0,0,1080,64800,0,0,298,6494,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,210:7:0 0,15,170:5:0 0,18,183:6:0 +X 2574 . G <*> 0 . DP=18;I16=8,10,0,0,664,24884,0,0,1080,64800,0,0,301,6561,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,211:7:0 0,15,152:5:0 0,18,176:6:0 +X 2575 . G <*> 0 . DP=18;I16=8,10,0,0,642,23904,0,0,1080,64800,0,0,305,6645,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,242:8:0 0,15,145:5:0 0,15,140:5:0 +X 2576 . A <*> 0 . DP=18;I16=7,10,0,0,595,21311,0,0,1020,61200,0,0,285,6121,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,210:8:0 0,15,153:5:0 0,12,131:4:0 +X 2577 . A <*> 0 . DP=19;I16=8,10,0,0,682,26398,0,0,1080,64800,0,0,290,6240,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,244:8:0 0,15,161:5:0 0,15,155:5:0 +X 2578 . G <*> 0 . DP=18;I16=9,9,0,0,643,24115,0,0,1080,64800,0,0,322,7002,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,249:8:0 0,12,114:4:0 0,18,161:6:0 +X 2579 . A <*> 0 . DP=18;I16=9,8,0,0,634,23870,0,0,1020,61200,0,0,304,6532,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,229:8:0 0,9,110:3:0 0,18,176:6:0 +X 2580 . A <*> 0 . DP=18;I16=9,9,0,0,629,22593,0,0,1080,64800,0,0,336,7330,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,223:8:0 0,12,117:4:0 0,18,169:6:0 +X 2581 . A <*> 0 . DP=19;I16=10,9,0,0,691,25669,0,0,1140,68400,0,0,343,7521,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,12,133:4:0 0,18,166:6:0 +X 2582 . T <*> 0 . DP=19;I16=10,9,0,0,674,24218,0,0,1140,68400,0,0,350,7682,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,235:9:0 0,12,138:4:0 0,18,168:6:0 +X 2583 . A <*> 0 . DP=19;I16=10,9,0,0,693,25465,0,0,1140,68400,0,0,357,7865,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,247:9:0 0,12,126:4:0 0,18,178:6:0 +X 2584 . A <*> 0 . DP=19;I16=10,9,0,0,702,26340,0,0,1140,68400,0,0,363,8019,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,243:9:0 0,12,134:4:0 0,18,187:6:0 +X 2585 . A <*> 0 . DP=19;I16=9,9,0,0,690,26700,0,0,1080,64800,0,0,350,7818,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,250:9:0 0,9,114:3:0 0,18,190:6:0 +X 2586 . G <*> 0 . DP=19;I16=10,9,0,0,714,27314,0,0,1140,68400,0,0,373,8283,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,12,127:4:0 0,18,176:6:0 +X 2587 . A <*> 0 . DP=20;I16=9,9,0,0,665,24781,0,0,1049,62041,0,0,343,7717,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,137:4:0 0,12,136:4:0 +X 2588 . A <*> 0 . DP=21;I16=12,9,0,0,737,26531,0,0,1229,72841,0,0,384,8620,0,0;QS=3,0;MQSB=0.950149;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,138:4:0 0,18,162:6:0 +X 2589 . A <*> 0 . DP=22;I16=13,9,0,0,780,28412,0,0,1289,76441,0,0,390,8770,0,0;QS=3,0;MQSB=0.955854;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,142:4:0 0,18,170:6:0 +X 2590 . A <*> 0 . DP=22;I16=13,9,0,0,774,28352,0,0,1289,76441,0,0,396,8894,0,0;QS=3,0;MQSB=0.955854;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,135:4:0 0,18,160:6:0 +X 2591 . C <*> 0 . DP=21;I16=13,8,0,0,765,28617,0,0,1229,72841,0,0,403,9041,0,0;QS=3,0;MQSB=0.95891;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,136:4:0 0,15,136:5:0 +X 2592 . A <*> 0 . DP=21;I16=13,8,0,0,763,28325,0,0,1229,72841,0,0,410,9210,0,0;QS=3,0;MQSB=0.95891;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,140:4:0 0,15,139:5:0 +X 2593 . A <*> 0 . DP=21;I16=13,8,0,0,754,27888,0,0,1229,72841,0,0,416,9350,0,0;QS=3,0;MQSB=0.95891;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,141:4:0 0,15,147:5:0 +X 2594 . A <*> 0 . DP=21;I16=13,8,0,0,775,29179,0,0,1229,72841,0,0,422,9510,0,0;QS=3,0;MQSB=0.95891;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,130:4:0 0,15,153:5:0 +X 2595 . T <*> 0 . DP=22;I16=14,8,0,0,766,27472,0,0,1289,76441,0,0,427,9639,0,0;QS=3,0;MQSB=0.963419;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,119:4:0 0,15,143:5:0 +X 2596 . A <*> 0 . DP=22;I16=13,8,0,0,751,27409,0,0,1229,72841,0,0,407,9111,0,0;QS=3,0;MQSB=0.95891;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,123:4:0 0,12,129:4:0 +X 2597 . A <*> 0 . DP=22;I16=14,8,0,0,811,30147,0,0,1289,76441,0,0,437,9851,0,0;QS=3,0;MQSB=0.963419;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,145:4:0 0,15,145:5:0 +X 2598 . A <*> 0 . DP=22;I16=14,8,0,0,817,30915,0,0,1289,76441,0,0,442,9984,0,0;QS=3,0;MQSB=0.963419;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,136:4:0 0,15,159:5:0 +X 2599 . A <*> 0 . DP=22;I16=14,8,0,0,800,29912,0,0,1289,76441,0,0,447,10135,0,0;QS=3,0;MQSB=0.963419;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,126:4:0 0,15,150:5:0 +X 2600 . A <*> 0 . DP=22;I16=14,8,0,0,784,29138,0,0,1289,76441,0,0,451,10255,0,0;QS=3,0;MQSB=0.963419;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,113:4:0 0,15,150:5:0 +X 2601 . T <*> 0 . DP=22;I16=14,8,0,0,770,27820,0,0,1289,76441,0,0,454,10344,0,0;QS=3,0;MQSB=0.963419;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,118:4:0 0,15,142:5:0 +X 2602 . A <*> 0 . DP=23;I16=15,8,0,0,825,29971,0,0,1349,80041,0,0,457,10451,0,0;QS=3,0;MQSB=0.967216;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,143:4:0 0,18,154:6:0 +X 2603 . A <*> 0 . DP=23;I16=15,8,0,0,862,32840,0,0,1349,80041,0,0,460,10526,0,0;QS=3,0;MQSB=0.967216;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,138:4:0 0,18,172:6:0 +X 2604 . T <*> 0 . DP=23;I16=15,8,0,0,822,29902,0,0,1349,80041,0,0,463,10619,0,0;QS=3,0;MQSB=0.967216;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,129:4:0 0,18,154:6:0 +X 2605 . A <*> 0 . DP=23;I16=14,8,0,0,845,32617,0,0,1289,76441,0,0,441,10105,0,0;QS=3,0;MQSB=0.963419;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,143:4:0 0,15,157:5:0 +X 2606 . G <*> 0 . DP=23;I16=14,8,0,0,812,30796,0,0,1289,76441,0,0,444,10234,0,0;QS=3,0;MQSB=0.963419;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,129:4:0 0,15,142:5:0 +X 2607 . T <*> 0 . DP=22;I16=15,7,0,0,782,28440,0,0,1289,76441,0,0,472,10954,0,0;QS=3,0;MQSB=0.970024;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,119:4:0 0,15,132:5:0 +X 2608 . G <*> 0 . DP=22;I16=15,7,0,0,851,33169,0,0,1289,76441,0,0,474,11014,0,0;QS=3,0;MQSB=0.970024;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,132:4:0 0,15,127:5:0 +X 2609 . C <*> 0 . DP=22;I16=15,7,0,0,796,29454,0,0,1289,76441,0,0,475,11041,0,0;QS=3,0;MQSB=0.970024;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,137:4:0 0,15,124:5:0 +X 2610 . A <*> 0 . DP=22;I16=15,7,0,0,830,31684,0,0,1289,76441,0,0,476,11086,0,0;QS=3,0;MQSB=0.970024;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,146:4:0 0,15,121:5:0 +X 2611 . G <*> 0 . DP=22;I16=15,7,0,0,824,32048,0,0,1289,76441,0,0,477,11149,0,0;QS=3,0;MQSB=0.970024;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,129:4:0 0,15,122:5:0 +X 2612 . A <*> 0 . DP=22;I16=14,7,0,0,771,29035,0,0,1229,72841,0,0,453,10605,0,0;QS=3,0;MQSB=0.966484;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,130:4:0 0,12,117:4:0 +X 2613 . C <*> 0 . DP=22;I16=15,7,0,0,832,31926,0,0,1289,76441,0,0,478,11278,0,0;QS=3,0;MQSB=0.970024;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,138:4:0 0,15,120:5:0 +X 2614 . A <*> 0 . DP=21;I16=15,6,0,0,791,30065,0,0,1229,72841,0,0,477,11241,0,0;QS=3,0;MQSB=0.973096;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,110:3:0 0,15,140:5:0 +X 2615 . A <*> 0 . DP=21;I16=15,6,0,0,777,29101,0,0,1229,72841,0,0,475,11167,0,0;QS=3,0;MQSB=0.973096;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,99:3:0 0,15,142:5:0 +X 2616 . A <*> 0 . DP=21;I16=15,6,0,0,734,26922,0,0,1229,72841,0,0,472,11056,0,0;QS=3,0;MQSB=0.973096;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,90:3:0 0,15,144:5:0 +X 2617 . A <*> 0 . DP=21;I16=15,6,0,0,810,31654,0,0,1229,72841,0,0,469,10959,0,0;QS=3,0;MQSB=0.973096;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,95:3:0 0,15,140:5:0 +X 2618 . G <*> 0 . DP=23;I16=16,6,0,0,863,34219,0,0,1289,76441,0,0,441,10251,0,0;QS=3,0;MQSB=0.97584;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,74:2:0 0,15,132:5:0 +X 2619 . G <*> 0 . DP=23;I16=16,6,0,0,807,30109,0,0,1289,76441,0,0,439,10135,0,0;QS=3,0;MQSB=0.97584;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,66:2:0 0,15,127:5:0 +X 2620 . C <*> 0 . DP=23;I16=16,7,0,0,780,28242,0,0,1349,80041,0,0,462,10664,0,0;QS=3,0;MQSB=0.973027;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,87:3:0 0,15,115:5:0 +X 2621 . C <*> 0 . DP=23;I16=16,7,0,0,860,32944,0,0,1349,80041,0,0,459,10537,0,0;QS=3,0;MQSB=0.973027;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,112:3:0 0,15,124:5:0 +X 2622 . T <*> 0 . DP=24;I16=17,7,0,0,908,35474,0,0,1409,83641,0,0,456,10428,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,115:3:0 0,15,134:5:0 +X 2623 . T <*> 0 . DP=24;I16=17,7,0,0,850,30978,0,0,1409,83641,0,0,453,10289,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,114:3:0 0,15,129:5:0 +X 2624 . G <*> 0 . DP=24;I16=17,7,0,0,882,33332,0,0,1409,83641,0,0,450,10172,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,101:3:0 0,15,133:5:0 +X 2625 . A <*> 0 . DP=23;I16=17,6,0,0,855,32593,0,0,1349,80041,0,0,448,10076,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,114:3:0 0,15,135:5:0 +X 2626 . C <*> 0 . DP=23;I16=17,6,0,0,847,31625,0,0,1349,80041,0,0,446,10000,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,100:3:0 0,15,122:5:0 +X 2627 . C <*> 0 . DP=23;I16=17,6,0,0,863,32865,0,0,1349,80041,0,0,444,9944,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,104:3:0 0,15,129:5:0 +X 2628 . C <*> 0 . DP=24;I16=17,6,0,0,793,28559,0,0,1349,80041,0,0,431,9757,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,95:3:0 0,15,127:5:0 +X 2629 . A <*> 0 . DP=24;I16=18,6,0,0,893,33537,0,0,1409,83641,0,0,439,9789,0,0;QS=3,0;MQSB=0.980199;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,101:3:0 0,18,148:6:0 +X 2630 . T <*> 0 . DP=24;I16=17,6,0,0,836,31094,0,0,1380,82800,0,0,412,9116,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,112:3:0 0,18,140:6:0 +X 2631 . C <*> 0 . DP=24;I16=18,6,0,0,900,34378,0,0,1409,83641,0,0,435,9713,0,0;QS=3,0;MQSB=0.980199;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,104:3:0 0,18,142:6:0 +X 2632 . T <*> 0 . DP=24;I16=18,6,0,0,937,37097,0,0,1409,83641,0,0,433,9705,0,0;QS=3,0;MQSB=0.980199;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,113:3:0 0,18,164:6:0 +X 2633 . A <*> 0 . DP=23;I16=18,5,0,0,801,28913,0,0,1349,80041,0,0,431,9667,0,0;QS=3,0;MQSB=0.982789;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,95:3:0 0,18,148:6:0 +X 2634 . G <*> 0 . DP=23;I16=19,3,0,0,861,34125,0,0,1289,76441,0,0,405,9023,0,0;QS=3,0;MQSB=0.989755;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,74:2:0 0,18,149:6:0 +X 2635 . C <*> 0 . DP=23;I16=19,4,0,0,848,32154,0,0,1349,80041,0,0,429,9599,0,0;QS=3,0;MQSB=0.986928;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,107:3:0 0,18,148:6:0 +X 2636 . T <*> 0 . DP=24;I16=19,4,0,0,871,33973,0,0,1349,80041,0,0,428,9572,0,0;QS=3,0;MQSB=0.986928;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,98:3:0 0,18,160:6:0 +X 2637 . T <*> 0 . DP=24;I16=19,5,0,0,871,32073,0,0,1409,83641,0,0,428,9568,0,0;QS=3,0;MQSB=0.984335;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,111:3:0 0,18,144:6:0 +X 2638 . T <*> 0 . DP=24;I16=19,5,0,0,821,28851,0,0,1409,83641,0,0,428,9588,0,0;QS=3,0;MQSB=0.984335;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,103:3:0 0,18,135:6:0 +X 2639 . G <*> 0 . DP=24;I16=18,6,0,0,842,30840,0,0,1409,83641,0,0,428,9582,0,0;QS=3,0;MQSB=0.980199;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,106:3:0 0,15,125:5:0 +X 2640 . G <*> 0 . DP=24;I16=17,6,0,0,749,25957,0,0,1380,82800,0,0,404,8976,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,84:3:0 0,15,117:5:0 +X 2641 . C <*> 0 . DP=23;I16=17,6,0,0,834,31792,0,0,1349,80041,0,0,431,9645,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,61:2:0 0,15,129:5:0 +X 2642 . C <*> 0 . DP=23;I16=17,6,0,0,809,30033,0,0,1349,80041,0,0,433,9713,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,58:2:0 0,15,131:5:0 +X 2643 . C <*> 0 . DP=23;I16=17,6,0,0,856,33004,0,0,1349,80041,0,0,434,9756,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,57:2:0 0,15,133:5:0 +X 2644 . T <*> 0 . DP=22;I16=16,5,0,0,805,31419,0,0,1229,72841,0,0,428,9648,0,0;QS=3,0;MQSB=0.978919;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,73:2:0 0,15,143:5:0 +X 2645 . C <*> 0 . DP=22;I16=15,6,0,0,823,32499,0,0,1229,72841,0,0,415,9323,0,0;QS=3,0;MQSB=0.973096;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,78:2:0 0,12,122:4:0 +X 2646 . A <*> 0 . DP=22;I16=16,6,0,0,826,31566,0,0,1289,76441,0,0,430,9524,0,0;QS=3,0;MQSB=0.97584;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,79:2:0 0,15,129:5:0 +X 2647 . G <*> 0 . DP=22;I16=16,6,0,0,803,30643,0,0,1289,76441,0,0,428,9460,0,0;QS=3,0;MQSB=0.97584;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,77:2:0 0,15,129:5:0 +X 2648 . C <*> 0 . DP=21;I16=15,6,0,0,811,31709,0,0,1229,72841,0,0,426,9368,0,0;QS=3,0;MQSB=0.973096;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,80:2:0 0,12,118:4:0 +X 2649 . A <*> 0 . DP=23;I16=16,6,0,0,789,29215,0,0,1258,73682,0,0,414,9196,0,0;QS=3,0;MQSB=0.934321;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,93:3:0 0,12,105:4:0 +X 2650 . T <*> 0 . DP=23;I16=16,7,0,0,856,32340,0,0,1318,77282,0,0,423,9197,0,0;QS=3,0;MQSB=0.955805;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,103:3:0 0,12,118:4:0 +X 2651 . C <*> 0 . DP=23;I16=16,7,0,0,871,33599,0,0,1318,77282,0,0,422,9124,0,0;QS=3,0;MQSB=0.955805;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,95:3:0 0,12,121:4:0 +X 2652 . A <*> 0 . DP=23;I16=16,7,0,0,820,30324,0,0,1318,77282,0,0,421,9077,0,0;QS=3,0;MQSB=0.955805;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,87:3:0 0,12,126:4:0 +X 2653 . A <*> 0 . DP=23;I16=15,6,0,0,759,28489,0,0,1198,70082,0,0,389,8395,0,0;QS=3,0;MQSB=0.940481;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,73:2:0 0,9,109:3:0 +X 2654 . C <*> 0 . DP=23;I16=16,7,0,0,836,31006,0,0,1318,77282,0,0,393,8385,0,0;QS=3,0;MQSB=0.955805;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,9,88:3:0 0,9,99:3:0 +X 2655 . C <*> 0 . DP=23;I16=16,7,0,0,774,27190,0,0,1318,77282,0,0,392,8364,0,0;QS=3,0;MQSB=0.955805;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,9,83:3:0 0,9,95:3:0 +X 2656 . G <*> 0 . DP=24;I16=17,7,0,0,781,25689,0,0,1378,80882,0,0,390,8320,0,0;QS=3,0;MQSB=0.95083;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,116:4:0 0,9,74:3:0 +X 2657 . C <*> 0 . DP=24;I16=17,6,0,0,871,33435,0,0,1349,80041,0,0,381,8241,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,9,98:3:0 0,9,99:3:0 +X 2658 . T <*> 0 . DP=23;I16=17,6,0,0,897,35255,0,0,1318,77282,0,0,389,8319,0,0;QS=3,0;MQSB=0.92854;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,133:4:0 0,9,107:3:0 +X 2659 . A <*> 0 . DP=23;I16=17,6,0,0,817,29729,0,0,1318,77282,0,0,389,8361,0,0;QS=3,0;MQSB=0.92854;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,120:4:0 0,9,93:3:0 +X 2660 . G <*> 0 . DP=23;I16=17,6,0,0,900,35462,0,0,1318,77282,0,0,389,8379,0,0;QS=3,0;MQSB=0.92854;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,126:4:0 0,9,94:3:0 +X 2661 . A <*> 0 . DP=24;I16=18,6,0,0,871,32185,0,0,1378,80882,0,0,390,8422,0,0;QS=3,0;MQSB=0.923116;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,127:4:0 0,9,104:3:0 +X 2662 . T <*> 0 . DP=24;I16=17,6,0,0,836,30812,0,0,1349,80041,0,0,366,7816,0,0;QS=3,0;MQSB=0.83771;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,122:4:0 0,9,99:3:0 +X 2663 . A <*> 0 . DP=24;I16=17,6,0,0,827,30583,0,0,1318,77282,0,0,389,8341,0,0;QS=3,0;MQSB=0.92854;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,104:4:0 0,9,101:3:0 +X 2664 . C <*> 0 . DP=23;I16=17,6,0,0,787,28083,0,0,1318,77282,0,0,388,8270,0,0;QS=3,0;MQSB=0.92854;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,107:4:0 0,9,91:3:0 +X 2665 . G <*> 0 . DP=23;I16=17,6,0,0,728,23290,0,0,1318,77282,0,0,386,8178,0,0;QS=3,0;MQSB=0.92854;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,112:4:0 0,9,78:3:0 +X 2666 . T <*> 0 . DP=23;I16=17,5,0,0,799,29273,0,0,1289,76441,0,0,367,7825,0,0;QS=3,0;MQSB=0.981001;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,105:3:0 0,9,94:3:0 +X 2667 . C <*> 0 . DP=23;I16=16,5,0,0,792,30190,0,0,1260,75600,0,0,345,7393,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,96:3:0 0,9,98:3:0 +X 2668 . C <*> 0 . DP=24;I16=18,6,0,0,832,29692,0,0,1378,80882,0,0,381,8069,0,0;QS=3,0;MQSB=0.923116;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,107:4:0 0,9,95:3:0 +X 2669 . C <*> 0 . DP=23;I16=18,5,0,0,829,30953,0,0,1318,77282,0,0,383,8087,0,0;QS=3,0;MQSB=0.889264;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,120:4:0 0,9,88:3:0 +X 2670 . T <*> 0 . DP=23;I16=17,5,0,0,841,32669,0,0,1289,76441,0,0,368,7828,0,0;QS=3,0;MQSB=0.801124;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,131:4:0 0,9,100:3:0 +X 2671 . C <*> 0 . DP=22;I16=17,5,0,0,842,32448,0,0,1258,73682,0,0,386,8110,0,0;QS=3,0;MQSB=0.895399;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,128:4:0 0,6,70:2:0 +X 2672 . C <*> 0 . DP=22;I16=17,5,0,0,808,30180,0,0,1258,73682,0,0,388,8164,0,0;QS=3,0;MQSB=0.895399;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,129:4:0 0,6,75:2:0 +X 2673 . C <*> 0 . DP=22;I16=17,5,0,0,842,32528,0,0,1258,73682,0,0,390,8246,0,0;QS=3,0;MQSB=0.895399;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,133:4:0 0,6,75:2:0 +X 2674 . T <*> 0 . DP=23;I16=17,6,0,0,860,33242,0,0,1318,77282,0,0,392,8356,0,0;QS=3,0;MQSB=0.92854;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,142:4:0 0,6,79:2:0 +X 2675 . T <*> 0 . DP=22;I16=16,6,0,0,756,26986,0,0,1258,73682,0,0,394,8392,0,0;QS=3,0;MQSB=0.934321;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,134:4:0 0,6,74:2:0 +X 2676 . T <*> 0 . DP=22;I16=16,6,0,0,774,28022,0,0,1258,73682,0,0,396,8452,0,0;QS=3,0;MQSB=0.934321;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,135:4:0 0,6,75:2:0 +X 2677 . C <*> 0 . DP=22;I16=16,6,0,0,866,34444,0,0,1258,73682,0,0,398,8536,0,0;QS=3,0;MQSB=0.934321;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,131:4:0 0,6,77:2:0 +X 2678 . T <*> 0 . DP=22;I16=16,5,0,0,818,32216,0,0,1229,72841,0,0,374,7970,0,0;QS=3,0;MQSB=0.978919;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,111:3:0 0,6,80:2:0 +X 2679 . T <*> 0 . DP=22;I16=16,6,0,0,808,29912,0,0,1258,73682,0,0,400,8680,0,0;QS=3,0;MQSB=0.934321;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,137:4:0 0,6,75:2:0 +X 2680 . C <*> 0 . DP=23;I16=16,7,0,0,873,33605,0,0,1318,77282,0,0,400,8740,0,0;QS=3,0;MQSB=0.955805;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,131:4:0 0,6,70:2:0 +X 2681 . T <*> 0 . DP=22;I16=15,7,0,0,820,31248,0,0,1258,73682,0,0,402,8824,0,0;QS=3,0;MQSB=0.961028;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,133:4:0 0,6,75:2:0 +X 2682 . G <*> 0 . DP=22;I16=15,7,0,0,831,31865,0,0,1258,73682,0,0,403,8881,0,0;QS=3,0;MQSB=0.961028;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,135:4:0 0,6,64:2:0 +X 2683 . G <*> 0 . DP=22;I16=13,6,0,0,702,26368,0,0,1109,65641,0,0,394,8926,0,0;QS=3,0;MQSB=0.850016;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,136:4:0 0,6,53:2:0 +X 2684 . G <*> 0 . DP=22;I16=14,7,0,0,754,27678,0,0,1229,72841,0,0,403,9057,0,0;QS=3,0;MQSB=0.872525;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,128:4:0 0,6,62:2:0 +X 2685 . G <*> 0 . DP=22;I16=15,7,0,0,736,25916,0,0,1258,73682,0,0,406,9184,0,0;QS=3,0;MQSB=0.961028;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,130:4:0 0,6,45:2:0 +X 2686 . C <*> 0 . DP=22;I16=15,7,0,0,803,29933,0,0,1258,73682,0,0,406,9278,0,0;QS=3,0;MQSB=0.961028;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,134:4:0 0,6,68:2:0 +X 2687 . A <*> 0 . DP=21;I16=13,7,0,0,716,26356,0,0,1169,69241,0,0,406,9340,0,0;QS=3,0;MQSB=0.875769;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,136:4:0 0,6,61:2:0 +X 2688 . C <*> 0 . DP=20;I16=13,7,0,0,750,28308,0,0,1169,69241,0,0,407,9417,0,0;QS=3,0;MQSB=0.875769;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,134:4:0 0,6,66:2:0 +X 2689 . A <*> 0 . DP=19;I16=12,7,0,0,741,29105,0,0,1109,65641,0,0,409,9507,0,0;QS=3,0;MQSB=0.879351;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,140:4:0 0,6,73:2:0 +X 2690 . G <*> 0 . DP=20;I16=12,8,0,0,751,28929,0,0,1169,69241,0,0,411,9609,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,135:4:0 0,6,61:2:0 +X 2691 . G <*> 0 . DP=20;I16=12,7,0,0,682,25006,0,0,1109,65641,0,0,403,9603,0,0;QS=3,0;MQSB=0.879351;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,132:4:0 0,6,63:2:0 +X 2692 . T <*> 0 . DP=20;I16=12,8,0,0,648,21758,0,0,1169,69241,0,0,417,9853,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,125:4:0 0,6,72:2:0 +X 2693 . C <*> 0 . DP=20;I16=12,8,0,0,779,30645,0,0,1169,69241,0,0,418,9898,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,130:4:0 0,6,70:2:0 +X 2694 . A <*> 0 . DP=21;I16=13,8,0,0,723,25649,0,0,1229,72841,0,0,417,9859,0,0;QS=3,0;MQSB=0.895122;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,126:4:0 0,6,73:2:0 +X 2695 . C <*> 0 . DP=20;I16=12,8,0,0,757,28835,0,0,1169,69241,0,0,418,9834,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,130:4:0 0,6,63:2:0 +X 2696 . A <*> 0 . DP=20;I16=12,8,0,0,733,27357,0,0,1169,69241,0,0,419,9823,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,130:4:0 0,6,69:2:0 +X 2697 . C <*> 0 . DP=20;I16=12,8,0,0,738,27604,0,0,1169,69241,0,0,419,9777,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,128:4:0 0,6,66:2:0 +X 2698 . T <*> 0 . DP=21;I16=12,8,0,0,788,31268,0,0,1169,69241,0,0,419,9747,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,144:4:0 0,6,77:2:0 +X 2699 . C <*> 0 . DP=22;I16=13,9,0,0,864,34148,0,0,1258,73682,0,0,443,10309,0,0;QS=3,0;MQSB=0.686045;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,135:4:0 0,9,98:3:0 +X 2700 . T <*> 0 . DP=22;I16=13,9,0,0,850,33296,0,0,1258,73682,0,0,444,10310,0,0;QS=3,0;MQSB=0.686045;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,141:4:0 0,9,105:3:0 +X 2701 . C <*> 0 . DP=22;I16=13,9,0,0,863,34157,0,0,1258,73682,0,0,444,10278,0,0;QS=3,0;MQSB=0.686045;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,140:4:0 0,9,94:3:0 +X 2702 . T <*> 0 . DP=22;I16=13,9,0,0,837,32525,0,0,1258,73682,0,0,444,10262,0,0;QS=3,0;MQSB=0.686045;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,143:4:0 0,9,83:3:0 +X 2703 . T <*> 0 . DP=21;I16=12,8,0,0,717,25881,0,0,1169,69241,0,0,420,9636,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,130:4:0 0,3,32:1:0 +X 2704 . C <*> 0 . DP=21;I16=12,9,0,0,794,30766,0,0,1198,70082,0,0,445,10225,0,0;QS=3,0;MQSB=0.695144;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,137:4:0 0,6,55:2:0 +X 2705 . C <*> 0 . DP=21;I16=12,9,0,0,809,31649,0,0,1198,70082,0,0,445,10205,0,0;QS=3,0;MQSB=0.695144;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,136:4:0 0,6,56:2:0 +X 2706 . A <*> 0 . DP=22;I16=12,10,0,0,820,31386,0,0,1258,73682,0,0,444,10150,0,0;QS=3,0;MQSB=0.731218;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,141:4:0 0,6,70:2:0 +X 2707 . G <*> 0 . DP=22;I16=12,10,0,0,832,32104,0,0,1258,73682,0,0,444,10110,0,0;QS=3,0;MQSB=0.731218;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,139:4:0 0,6,60:2:0 +X 2708 . G <*> 0 . DP=22;I16=12,10,0,0,777,28329,0,0,1258,73682,0,0,444,10086,0,0;QS=3,0;MQSB=0.731218;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,136:4:0 0,6,57:2:0 +X 2709 . T <*> 0 . DP=22;I16=12,9,0,0,761,28341,0,0,1229,72841,0,0,418,9404,0,0;QS=3,0;MQSB=0.913101;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,137:4:0 0,3,39:1:0 +X 2710 . C <*> 0 . DP=23;I16=12,10,0,0,840,32478,0,0,1289,76441,0,0,417,9365,0,0;QS=3,0;MQSB=0.924723;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,134:4:0 0,3,38:1:0 +X 2711 . T <*> 0 . DP=24;I16=13,11,0,0,893,33721,0,0,1378,80882,0,0,442,9970,0,0;QS=3,0;MQSB=0.75304;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,12,138:4:0 0,6,72:2:0 +X 2712 . A <*> 0 . DP=24;I16=13,11,0,0,889,33333,0,0,1378,80882,0,0,443,9971,0,0;QS=3,0;MQSB=0.75304;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,12,141:4:0 0,6,65:2:0 +X 2713 . G T,<*> 0 . DP=25;I16=13,11,0,1,915,35485,14,196,1378,80882,29,841,419,9369,25,625;QS=2.72549,0.27451,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.569783;BQB=1;MQ0F=0 PL:DP:DV 0,57,255,57,255,255:19:0 0,12,131,12,131,131:4:0 8,0,31,11,34,42:2:1 +X 2714 . G <*> 0 . DP=25;I16=13,11,0,0,891,33457,0,0,1378,80882,0,0,444,9990,0,0;QS=3,0;MQSB=0.75304;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,12,132:4:0 0,6,64:2:0 +X 2715 . A <*> 0 . DP=25;I16=13,12,0,0,888,32012,0,0,1407,81723,0,0,446,10014,0,0;QS=3,0;MQSB=0.569783;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,12,135:4:0 0,6,63:2:0 +X 2716 . T <*> 0 . DP=26;I16=13,13,0,0,937,34241,0,0,1467,85323,0,0,446,10012,0,0;QS=3,0;MQSB=0.606531;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,12,134:4:0 0,9,90:3:0 +X 2717 . G <*> 0 . DP=26;I16=13,12,0,0,939,35995,0,0,1438,84482,0,0,422,9410,0,0;QS=3,0;MQSB=0.778801;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,12,134:4:0 0,6,72:2:0 +X 2718 . C <*> 0 . DP=24;I16=12,11,0,0,864,33118,0,0,1318,77282,0,0,425,9457,0,0;QS=3,0;MQSB=0.7613;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,130:4:0 0,6,65:2:0 +X 2719 . A <*> 0 . DP=24;I16=12,12,0,0,911,35371,0,0,1347,78123,0,0,452,10102,0,0;QS=3,0;MQSB=0.582748;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,139:4:0 0,9,99:3:0 +X 2720 . G <*> 0 . DP=24;I16=12,12,0,0,940,37044,0,0,1347,78123,0,0,453,10095,0,0;QS=3,0;MQSB=0.582748;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,136:4:0 0,9,97:3:0 +X 2721 . C <*> 0 . DP=24;I16=12,11,0,0,881,34499,0,0,1318,77282,0,0,429,9485,0,0;QS=3,0;MQSB=0.7613;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,131:4:0 0,6,76:2:0 +X 2722 . T <*> 0 . DP=24;I16=11,13,0,0,898,34310,0,0,1347,78123,0,0,456,10146,0,0;QS=3,0;MQSB=0.633229;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,156:5:0 0,9,98:3:0 +X 2723 . G <*> 0 . DP=25;I16=12,13,0,0,941,36257,0,0,1407,81723,0,0,459,10203,0,0;QS=3,0;MQSB=0.619223;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,184:6:0 0,9,76:3:0 +X 2724 . A <*> 0 . DP=25;I16=12,13,0,0,917,34211,0,0,1407,81723,0,0,462,10234,0,0;QS=3,0;MQSB=0.619223;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,188:6:0 0,9,84:3:0 +X 2725 . G <*> 0 . DP=25;I16=12,12,0,0,916,35656,0,0,1378,80882,0,0,438,9566,0,0;QS=3,0;MQSB=0.786628;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,185:6:0 0,6,67:2:0 +X 2726 . G <*> 0 . DP=25;I16=11,12,0,0,841,31809,0,0,1287,74523,0,0,437,9545,0,0;QS=3,0;MQSB=0.597127;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,186:6:0 0,6,46:2:0 +X 2727 . G <*> 0 . DP=25;I16=12,13,0,0,889,32233,0,0,1407,81723,0,0,464,10182,0,0;QS=3,0;MQSB=0.619223;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,194:7:0 0,6,56:2:0 +X 2728 . G <*> 0 . DP=25;I16=12,13,0,0,883,32287,0,0,1407,81723,0,0,467,10219,0,0;QS=3,0;MQSB=0.619223;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,189:7:0 0,6,50:2:0 +X 2729 . T <*> 0 . DP=25;I16=12,13,0,0,871,31019,0,0,1407,81723,0,0,469,10233,0,0;QS=3,0;MQSB=0.619223;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,189:7:0 0,6,62:2:0 +X 2730 . G <*> 0 . DP=25;I16=12,13,0,0,907,34299,0,0,1407,81723,0,0,471,10275,0,0;QS=3,0;MQSB=0.619223;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,192:7:0 0,6,49:2:0 +X 2731 . C <*> 0 . DP=25;I16=12,13,0,0,893,33027,0,0,1407,81723,0,0,473,10345,0,0;QS=3,0;MQSB=0.619223;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,192:7:0 0,6,52:2:0 +X 2732 . C <*> 0 . DP=25;I16=12,13,0,0,882,32170,0,0,1407,81723,0,0,473,10343,0,0;QS=3,0;MQSB=0.619223;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,195:7:0 0,6,38:2:0 +X 2733 . C A,<*> 0 . DP=25;I16=12,12,0,1,835,30063,13,169,1378,80882,29,841,448,9744,25,625;QS=2.64865,0.351351,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.619223;BQB=1;MQ0F=0 PL:DP:DV 0,48,255,48,255,255:16:0 0,21,187,21,187,187:7:0 7,0,18,10,21,28:2:1 +X 2734 . C <*> 0 . DP=25;I16=12,12,0,0,890,33726,0,0,1378,80882,0,0,449,9797,0,0;QS=3,0;MQSB=0.786628;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,24,208:8:0 0,3,39:1:0 +X 2735 . T <*> 0 . DP=26;I16=13,12,0,0,955,36875,0,0,1438,84482,0,0,451,9877,0,0;QS=3,0;MQSB=0.778801;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,228:8:0 0,3,41:1:0 +X 2736 . C <*> 0 . DP=26;I16=13,11,0,0,921,35553,0,0,1409,83641,0,0,428,9308,0,0;QS=3,0;MQSB=0.931547;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,24,220:8:0 0,3,33:1:0 +X 2737 . T <*> 0 . DP=26;I16=13,13,0,0,967,36581,0,0,1467,85323,0,0,475,10403,0,0;QS=3,0;MQSB=0.606531;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,228:8:0 0,6,64:2:0 +X 2738 . T <*> 0 . DP=26;I16=13,13,0,0,895,31873,0,0,1467,85323,0,0,474,10374,0,0;QS=3,0;MQSB=0.606531;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,201:8:0 0,6,47:2:0 +X 2739 . A <*> 0 . DP=26;I16=13,12,0,0,871,31051,0,0,1407,81723,0,0,448,9698,0,0;QS=3,0;MQSB=0.569783;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,224:8:0 0,9,78:3:0 +X 2740 . C <*> 0 . DP=26;I16=14,11,0,0,952,36456,0,0,1438,84482,0,0,448,9674,0,0;QS=3,0;MQSB=0.745495;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,24,216:8:0 0,6,71:2:0 +X 2741 . C <*> 0 . DP=26;I16=14,11,0,0,945,36141,0,0,1438,84482,0,0,448,9678,0,0;QS=3,0;MQSB=0.745495;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,24,215:8:0 0,6,75:2:0 +X 2742 . A <*> 0 . DP=27;I16=15,12,0,0,949,34263,0,0,1527,88923,0,0,472,10284,0,0;QS=3,0;MQSB=0.547344;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,27,230:9:0 0,9,92:3:0 +X 2743 . T <*> 0 . DP=27;I16=15,12,0,0,955,34479,0,0,1527,88923,0,0,471,10243,0,0;QS=3,0;MQSB=0.547344;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,27,224:9:0 0,9,99:3:0 +X 2744 . C <*> 0 . DP=26;I16=15,10,0,0,955,36951,0,0,1438,84482,0,0,445,9557,0,0;QS=3,0;MQSB=0.707404;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,234:9:0 0,6,76:2:0 +X 2745 . T <*> 0 . DP=26;I16=15,11,0,0,962,36786,0,0,1467,85323,0,0,469,10151,0,0;QS=3,0;MQSB=0.505697;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,243:9:0 0,9,104:3:0 +X 2746 . A <*> 0 . DP=26;I16=15,10,0,0,912,33536,0,0,1438,84482,0,0,443,9525,0,0;QS=3,0;MQSB=0.707404;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,235:9:0 0,6,78:2:0 +X 2747 . A <*> 0 . DP=26;I16=15,11,0,0,945,35117,0,0,1467,85323,0,0,467,10179,0,0;QS=3,0;MQSB=0.505697;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,238:9:0 0,9,96:3:0 +X 2748 . T <*> 0 . DP=27;I16=15,12,0,0,1005,37901,0,0,1527,88923,0,0,465,10187,0,0;QS=3,0;MQSB=0.547344;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,27,246:9:0 0,9,103:3:0 +X 2749 . C <*> 0 . DP=26;I16=14,12,0,0,975,37353,0,0,1467,85323,0,0,463,10123,0,0;QS=3,0;MQSB=0.558035;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,232:9:0 0,9,98:3:0 +X 2750 . T <*> 0 . DP=26;I16=15,11,0,0,982,37714,0,0,1498,88082,0,0,462,10086,0,0;QS=3,0;MQSB=0.738577;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,227:8:0 0,12,130:4:0 +X 2751 . G <*> 0 . DP=26;I16=15,10,0,0,945,36031,0,0,1469,87241,0,0,437,9451,0,0;QS=3,0;MQSB=0.9171;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,205:8:0 0,9,103:3:0 +X 2752 . T <*> 0 . DP=26;I16=15,11,0,0,870,30288,0,0,1498,88082,0,0,460,9998,0,0;QS=3,0;MQSB=0.738577;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,189:8:0 0,12,119:4:0 +X 2753 . G <*> 0 . DP=26;I16=15,11,0,0,867,30913,0,0,1498,88082,0,0,458,9948,0,0;QS=3,0;MQSB=0.738577;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,202:8:0 0,12,116:4:0 +X 2754 . C <*> 0 . DP=25;I16=14,10,0,0,873,32607,0,0,1409,83641,0,0,436,9484,0,0;QS=3,0;MQSB=0.919431;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,24,205:8:0 0,9,104:3:0 +X 2755 . C <*> 0 . DP=25;I16=14,10,0,0,865,32243,0,0,1409,83641,0,0,436,9528,0,0;QS=3,0;MQSB=0.919431;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,24,209:8:0 0,9,97:3:0 +X 2756 . C <*> 0 . DP=25;I16=14,9,0,0,838,31276,0,0,1380,82800,0,0,411,8971,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,204:8:0 0,9,97:3:0 +X 2757 . T <*> 0 . DP=25;I16=14,11,0,0,904,33980,0,0,1438,84482,0,0,455,10011,0,0;QS=3,0;MQSB=0.745495;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,212:7:0 0,15,147:5:0 +X 2758 . T <*> 0 . DP=25;I16=14,10,0,0,841,30293,0,0,1409,83641,0,0,439,9801,0,0;QS=3,0;MQSB=0.919431;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,195:7:0 0,12,133:4:0 +X 2759 . A <*> 0 . DP=25;I16=14,11,0,0,884,31728,0,0,1438,84482,0,0,457,10195,0,0;QS=3,0;MQSB=0.745495;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,192:7:0 0,15,147:5:0 +X 2760 . T <*> 0 . DP=25;I16=14,11,0,0,907,33965,0,0,1438,84482,0,0,457,10275,0,0;QS=3,0;MQSB=0.745495;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,204:7:0 0,15,150:5:0 +X 2761 . T <*> 0 . DP=23;I16=13,9,0,0,838,32530,0,0,1289,76441,0,0,444,10130,0,0;QS=3,0;MQSB=0.910098;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,185:6:0 0,12,141:4:0 +X 2762 . T <*> 0 . DP=24;I16=13,11,0,0,869,32261,0,0,1378,80882,0,0,459,10395,0,0;QS=3,0;MQSB=0.75304;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,178:6:0 0,18,177:6:0 +X 2763 . C A,<*> 0 . DP=24;I16=13,10,0,1,843,31711,13,169,1349,80041,29,841,448,10290,12,144;QS=2.93333,0.0666667,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.75304;BQB=1;MQ0F=0 PL:DP:DV 0,36,255,36,255,255:12:0 0,18,170,18,170,170:6:0 0,5,147,15,150,153:6:1 +X 2764 . C <*> 0 . DP=24;I16=13,10,0,0,854,32376,0,0,1349,80041,0,0,450,10374,0,0;QS=3,0;MQSB=0.921963;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,163:6:0 0,15,162:5:0 +X 2765 . T <*> 0 . DP=24;I16=12,11,0,0,853,32173,0,0,1318,77282,0,0,457,10469,0,0;QS=3,0;MQSB=0.7613;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,154:5:0 0,18,189:6:0 +X 2766 . C <*> 0 . DP=24;I16=12,11,0,0,887,34485,0,0,1349,80041,0,0,448,10398,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,160:5:0 0,18,186:6:0 +X 2767 . T <*> 0 . DP=24;I16=12,12,0,0,905,34757,0,0,1378,80882,0,0,458,10510,0,0;QS=3,0;MQSB=0.786628;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,153:5:0 0,21,217:7:0 +X 2768 . G <*> 0 . DP=23;I16=11,11,0,0,852,33258,0,0,1289,76441,0,0,452,10462,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,141:5:0 0,18,197:6:0 +X 2769 . C <*> 0 . DP=23;I16=11,12,0,0,832,31390,0,0,1318,77282,0,0,459,10481,0,0;QS=3,0;MQSB=0.795196;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,142:5:0 0,21,202:7:0 +X 2770 . T <*> 0 . DP=23;I16=11,12,0,0,828,30854,0,0,1318,77282,0,0,459,10471,0,0;QS=3,0;MQSB=0.795196;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,152:5:0 0,21,199:7:0 +X 2771 . T <*> 0 . DP=23;I16=11,11,0,0,817,30957,0,0,1258,73682,0,0,454,10456,0,0;QS=3,0;MQSB=0.770381;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,154:5:0 0,18,198:6:0 +X 2772 . T <*> 0 . DP=23;I16=11,12,0,0,856,32206,0,0,1318,77282,0,0,459,10511,0,0;QS=3,0;MQSB=0.795196;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,160:5:0 0,21,210:7:0 +X 2773 . A <*> 0 . DP=23;I16=11,12,0,0,828,30664,0,0,1318,77282,0,0,459,10561,0,0;QS=3,0;MQSB=0.795196;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,140:5:0 0,21,209:7:0 +X 2774 . G <*> 0 . DP=22;I16=11,11,0,0,843,32715,0,0,1258,73682,0,0,458,10530,0,0;QS=3,0;MQSB=0.770381;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,154:5:0 0,21,207:7:0 +X 2775 . T <*> 0 . DP=22;I16=10,11,0,0,748,27720,0,0,1198,70082,0,0,432,9892,0,0;QS=3,0;MQSB=0.780412;MQ0F=0 PL:DP:DV 0,30,253:10:0 0,12,115:4:0 0,21,203:7:0 +X 2776 . G <*> 0 . DP=22;I16=12,10,0,0,803,30251,0,0,1289,76441,0,0,456,10470,0,0;QS=3,0;MQSB=0.924723;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,135:5:0 0,21,210:7:0 +X 2777 . A <*> 0 . DP=22;I16=12,10,0,0,852,33524,0,0,1289,76441,0,0,456,10438,0,0;QS=3,0;MQSB=0.924723;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,148:5:0 0,21,220:7:0 +X 2778 . G <*> 0 . DP=23;I16=12,11,0,0,861,33049,0,0,1349,80041,0,0,456,10422,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,154:5:0 0,21,224:7:0 +X 2779 . G <*> 0 . DP=23;I16=11,11,0,0,834,32014,0,0,1289,76441,0,0,432,9798,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,136:4:0 0,21,219:7:0 +X 2780 . A <*> 0 . DP=23;I16=11,11,0,0,792,29162,0,0,1289,76441,0,0,433,9817,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,33,244:11:0 0,12,133:4:0 0,21,215:7:0 +X 2781 . A <*> 0 . DP=23;I16=11,11,0,0,844,33092,0,0,1289,76441,0,0,441,10141,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,30,253:10:0 0,15,151:5:0 0,21,233:7:0 +X 2782 . G <*> 0 . DP=23;I16=12,11,0,0,840,31826,0,0,1349,80041,0,0,458,10438,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,154:5:0 0,21,218:7:0 +X 2783 . A <*> 0 . DP=23;I16=11,11,0,0,860,33888,0,0,1289,76441,0,0,432,9790,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,142:4:0 0,21,230:7:0 +X 2784 . G <*> 0 . DP=23;I16=12,11,0,0,860,33092,0,0,1349,80041,0,0,456,10410,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,143:5:0 0,21,212:7:0 +X 2785 . G <*> 0 . DP=23;I16=11,11,0,0,797,29747,0,0,1289,76441,0,0,429,9749,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,134:4:0 0,21,204:7:0 +X 2786 . C <*> 0 . DP=24;I16=12,12,0,0,831,29497,0,0,1409,83641,0,0,451,10309,0,0;QS=3,0;MQSB=0.941765;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,141:5:0 0,21,199:7:0 +X 2787 . C <*> 0 . DP=24;I16=11,12,0,0,792,28454,0,0,1349,80041,0,0,424,9642,0,0;QS=3,0;MQSB=0.944319;MQ0F=0 PL:DP:DV 0,36,252:12:0 0,12,127:4:0 0,21,200:7:0 +X 2788 . C <*> 0 . DP=23;I16=11,11,0,0,791,29517,0,0,1289,76441,0,0,421,9523,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,125:4:0 0,21,209:7:0 +X 2789 . C <*> 0 . DP=24;I16=13,11,0,0,880,33470,0,0,1409,83641,0,0,443,10051,0,0;QS=3,0;MQSB=0.931547;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,150:5:0 0,21,226:7:0 +X 2790 . T <*> 0 . DP=23;I16=13,10,0,0,886,34738,0,0,1349,80041,0,0,442,9976,0,0;QS=3,0;MQSB=0.921963;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,165:5:0 0,21,227:7:0 +X 2791 . G <*> 0 . DP=23;I16=13,10,0,0,873,34037,0,0,1349,80041,0,0,441,9923,0,0;QS=3,0;MQSB=0.921963;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,155:5:0 0,21,226:7:0 +X 2792 . G <*> 0 . DP=23;I16=13,10,0,0,832,30870,0,0,1349,80041,0,0,438,9792,0,0;QS=3,0;MQSB=0.921963;MQ0F=0 PL:DP:DV 0,33,254:11:0 0,15,146:5:0 0,21,221:7:0 +X 2793 . T <*> 0 . DP=23;I16=13,10,0,0,827,30693,0,0,1349,80041,0,0,435,9683,0,0;QS=3,0;MQSB=0.921963;MQ0F=0 PL:DP:DV 0,33,247:11:0 0,15,157:5:0 0,21,214:7:0 +X 2794 . C <*> 0 . DP=22;I16=12,10,0,0,786,29122,0,0,1289,76441,0,0,433,9595,0,0;QS=3,0;MQSB=0.924723;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,145:5:0 0,21,201:7:0 +X 2795 . C <*> 0 . DP=22;I16=11,10,0,0,814,31804,0,0,1229,72841,0,0,428,9518,0,0;QS=3,0;MQSB=0.927743;MQ0F=0 PL:DP:DV 0,27,240:9:0 0,15,159:5:0 0,21,222:7:0 +X 2796 . A <*> 0 . DP=22;I16=11,10,0,0,762,28412,0,0,1229,72841,0,0,427,9475,0,0;QS=3,0;MQSB=0.927743;MQ0F=0 PL:DP:DV 0,27,221:9:0 0,15,156:5:0 0,21,211:7:0 +X 2797 . T <*> 0 . DP=22;I16=12,10,0,0,792,29116,0,0,1289,76441,0,0,427,9451,0,0;QS=3,0;MQSB=0.924723;MQ0F=0 PL:DP:DV 0,30,243:10:0 0,15,148:5:0 0,21,214:7:0 +X 2798 . G <*> 0 . DP=22;I16=12,10,0,0,817,31105,0,0,1289,76441,0,0,424,9394,0,0;QS=3,0;MQSB=0.924723;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,152:5:0 0,21,205:7:0 +X 2799 . A <*> 0 . DP=21;I16=11,10,0,0,788,30210,0,0,1229,72841,0,0,421,9309,0,0;QS=3,0;MQSB=0.927743;MQ0F=0 PL:DP:DV 0,27,220:9:0 0,15,167:5:0 0,21,218:7:0 +X 2800 . A <*> 0 . DP=21;I16=11,10,0,0,836,33616,0,0,1229,72841,0,0,418,9246,0,0;QS=3,0;MQSB=0.927743;MQ0F=0 PL:DP:DV 0,27,237:9:0 0,15,164:5:0 0,21,237:7:0 +X 2801 . G <*> 0 . DP=21;I16=11,10,0,0,792,30182,0,0,1229,72841,0,0,415,9205,0,0;QS=3,0;MQSB=0.927743;MQ0F=0 PL:DP:DV 0,27,234:9:0 0,15,157:5:0 0,21,214:7:0 +X 2802 . G <*> 0 . DP=21;I16=11,9,0,0,729,27275,0,0,1169,69241,0,0,387,8559,0,0;QS=3,0;MQSB=0.916401;MQ0F=0 PL:DP:DV 0,24,229:8:0 0,15,135:5:0 0,21,215:7:0 +X 2803 . G <*> 0 . DP=21;I16=11,10,0,0,737,26709,0,0,1229,72841,0,0,406,9036,0,0;QS=3,0;MQSB=0.927743;MQ0F=0 PL:DP:DV 0,27,233:9:0 0,15,125:5:0 0,21,207:7:0 +X 2804 . G <*> 0 . DP=21;I16=11,10,0,0,727,26103,0,0,1229,72841,0,0,400,8908,0,0;QS=3,0;MQSB=0.927743;MQ0F=0 PL:DP:DV 0,27,218:9:0 0,15,129:5:0 0,21,210:7:0 +X 2805 . C <*> 0 . DP=21;I16=10,10,0,0,714,26194,0,0,1169,69241,0,0,372,8316,0,0;QS=3,0;MQSB=0.931063;MQ0F=0 PL:DP:DV 0,27,229:9:0 0,12,111:4:0 0,21,205:7:0 +X 2806 . C <*> 0 . DP=20;I16=11,8,0,0,682,25074,0,0,1109,65641,0,0,379,8611,0,0;QS=3,0;MQSB=0.902014;MQ0F=0 PL:DP:DV 0,24,215:8:0 0,15,138:5:0 0,18,191:6:0 +X 2807 . T <*> 0 . DP=20;I16=11,9,0,0,755,29373,0,0,1169,69241,0,0,384,8640,0,0;QS=3,0;MQSB=0.916401;MQ0F=0 PL:DP:DV 0,24,221:8:0 0,15,152:5:0 0,21,227:7:0 +X 2808 . T <*> 0 . DP=20;I16=11,9,0,0,749,28383,0,0,1169,69241,0,0,379,8587,0,0;QS=3,0;MQSB=0.916401;MQ0F=0 PL:DP:DV 0,24,209:8:0 0,15,157:5:0 0,21,225:7:0 +X 2809 . T <*> 0 . DP=20;I16=11,8,0,0,697,26019,0,0,1109,65641,0,0,349,7927,0,0;QS=3,0;MQSB=0.902014;MQ0F=0 PL:DP:DV 0,21,189:7:0 0,15,148:5:0 0,21,226:7:0 +X 2810 . C <*> 0 . DP=20;I16=12,8,0,0,754,28900,0,0,1169,69241,0,0,368,8436,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,24,229:8:0 0,15,150:5:0 0,21,215:7:0 +X 2811 . A <*> 0 . DP=19;I16=11,8,0,0,759,30405,0,0,1109,65641,0,0,364,8340,0,0;QS=3,0;MQSB=0.902014;MQ0F=0 PL:DP:DV 0,21,209:7:0 0,15,166:5:0 0,21,228:7:0 +X 2812 . G <*> 0 . DP=20;I16=11,9,0,0,758,29062,0,0,1169,69241,0,0,359,8213,0,0;QS=3,0;MQSB=0.916401;MQ0F=0 PL:DP:DV 0,24,229:8:0 0,15,150:5:0 0,21,216:7:0 +X 2813 . A <*> 0 . DP=19;I16=11,8,0,0,702,27106,0,0,1140,68400,0,0,356,8104,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,195:7:0 0,15,160:5:0 0,21,217:7:0 +X 2814 . G <*> 0 . DP=19;I16=11,8,0,0,703,26579,0,0,1140,68400,0,0,353,8013,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,217:7:0 0,15,147:5:0 0,21,204:7:0 +X 2815 . A <*> 0 . DP=19;I16=10,7,0,0,597,21979,0,0,1020,61200,0,0,326,7470,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,170:6:0 0,12,122:4:0 0,21,208:7:0 +X 2816 . C <*> 0 . DP=19;I16=11,8,0,0,630,21880,0,0,1140,68400,0,0,343,7685,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,193:7:0 0,15,134:5:0 0,21,180:7:0 +X 2817 . G <*> 0 . DP=20;I16=11,8,0,0,612,20368,0,0,1140,68400,0,0,339,7547,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,200:7:0 0,15,115:5:0 0,21,178:7:0 +X 2818 . G <*> 0 . DP=20;I16=11,8,0,0,688,25280,0,0,1140,68400,0,0,335,7377,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,216:7:0 0,15,132:5:0 0,21,206:7:0 +X 2819 . G <*> 0 . DP=20;I16=11,8,0,0,696,25880,0,0,1140,68400,0,0,331,7227,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,222:7:0 0,15,142:5:0 0,21,195:7:0 +X 2820 . G <*> 0 . DP=20;I16=10,8,0,0,624,22228,0,0,1080,64800,0,0,320,7048,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,205:7:0 0,12,119:4:0 0,21,188:7:0 +X 2821 . A <*> 0 . DP=20;I16=9,7,0,0,496,16222,0,0,960,57600,0,0,279,6157,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,159:6:0 0,9,93:3:0 0,21,171:7:0 +X 2822 . C <*> 0 . DP=19;I16=8,9,0,0,543,18163,0,0,1020,61200,0,0,310,7064,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,203:7:0 0,9,79:3:0 0,21,168:7:0 +X 2823 . C <*> 0 . DP=18;I16=9,7,0,0,550,19506,0,0,960,57600,0,0,300,6640,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,201:7:0 0,6,58:2:0 0,21,192:7:0 +X 2824 . C <*> 0 . DP=18;I16=9,7,0,0,584,21560,0,0,960,57600,0,0,299,6567,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,219:8:0 0,3,37:1:0 0,21,210:7:0 +X 2825 . C <*> 0 . DP=18;I16=9,8,0,0,606,22286,0,0,1020,61200,0,0,324,7134,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,234:8:0 0,3,37:1:0 0,24,208:8:0 +X 2826 . T <*> 0 . DP=18;I16=9,8,0,0,604,21766,0,0,1020,61200,0,0,323,7043,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,222:8:0 0,3,33:1:0 0,24,220:8:0 +X 2827 . G <*> 0 . DP=18;I16=9,8,0,0,597,21643,0,0,1020,61200,0,0,322,6970,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,230:8:0 0,3,28:1:0 0,24,214:8:0 +X 2828 . A <*> 0 . DP=20;I16=9,9,0,0,598,20740,0,0,1080,64800,0,0,321,6915,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,213:9:0 0,3,36:1:0 0,24,219:8:0 +X 2829 . G <*> 0 . DP=20;I16=9,9,0,0,649,23719,0,0,1080,64800,0,0,305,6591,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,239:8:0 0,3,31:1:0 0,27,227:9:0 +X 2830 . G <*> 0 . DP=20;I16=9,10,0,0,661,23841,0,0,1140,68400,0,0,323,6867,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,248:9:0 0,3,34:1:0 0,27,222:9:0 +X 2831 . A <*> 0 . DP=21;I16=10,10,0,0,682,24052,0,0,1200,72000,0,0,324,6876,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,223:9:0 0,3,34:1:0 0,30,254:10:0 +X 2832 . G <*> 0 . DP=21;I16=10,8,0,0,626,22384,0,0,1080,64800,0,0,281,5883,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,230:8:0 0,3,31:1:0 0,27,223:9:0 +X 2833 . C <*> 0 . DP=21;I16=10,10,0,0,712,25708,0,0,1200,72000,0,0,327,6915,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,233:9:0 0,3,37:1:0 0,30,255:10:0 +X 2834 . C <*> 0 . DP=21;I16=10,9,0,0,674,24470,0,0,1140,68400,0,0,306,6464,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,230:8:0 0,3,36:1:0 0,30,243:10:0 +X 2835 . C <*> 0 . DP=20;I16=9,9,0,0,617,21835,0,0,1080,64800,0,0,305,6381,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,202:8:0 0,3,39:1:0 0,27,235:9:0 +X 2836 . C <*> 0 . DP=20;I16=9,9,0,0,580,19624,0,0,1080,64800,0,0,306,6412,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,206:8:0 0,3,39:1:0 0,27,200:9:0 +X 2837 . G <*> 0 . DP=21;I16=9,10,0,0,558,17614,0,0,1140,68400,0,0,330,7086,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,207:9:0 0,3,31:1:0 0,27,193:9:0 +X 2838 . A <*> 0 . DP=20;I16=9,10,0,0,640,22674,0,0,1140,68400,0,0,331,7065,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,245:9:0 0,3,17:1:0 0,27,220:9:0 +X 2839 . G <*> 0 . DP=20;I16=9,8,0,0,623,23267,0,0,1020,61200,0,0,282,5816,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,248:8:0 0,3,26:1:0 0,24,212:8:0 +X 2840 . C <*> 0 . DP=20;I16=9,10,0,0,644,22798,0,0,1140,68400,0,0,333,7089,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,233:9:0 0,3,32:1:0 0,27,227:9:0 +X 2841 . A <*> 0 . DP=20;I16=9,9,0,0,675,25801,0,0,1080,64800,0,0,309,6509,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,252:9:0 0,3,35:1:0 0,24,234:8:0 +X 2842 . G <*> 0 . DP=20;I16=9,10,0,0,688,25554,0,0,1140,68400,0,0,332,7056,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,3,31:1:0 0,27,233:9:0 +X 2843 . C <*> 0 . DP=20;I16=8,10,0,0,651,23969,0,0,1080,64800,0,0,309,6517,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,0,0:0:0 0,24,211:8:0 +X 2844 . A <*> 0 . DP=20;I16=8,11,0,0,685,25399,0,0,1140,68400,0,0,331,6969,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,0,0:0:0 0,27,231:9:0 +X 2845 . G <*> 0 . DP=20;I16=8,10,0,0,673,25399,0,0,1080,64800,0,0,311,6561,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,0,0:0:0 0,24,228:8:0 +X 2846 . C <*> 0 . DP=20;I16=8,10,0,0,617,22007,0,0,1080,64800,0,0,311,6577,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,243:10:0 0,0,0:0:0 0,24,218:8:0 +X 2847 . C <*> 0 . DP=20;I16=7,11,0,0,580,19468,0,0,1080,64800,0,0,321,6917,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,241:10:0 0,0,0:0:0 0,24,187:8:0 +X 2848 . G <*> 0 . DP=19;I16=7,10,0,0,542,17884,0,0,1020,61200,0,0,323,6999,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,218:9:0 0,0,0:0:0 0,24,191:8:0 +X 2849 . T <*> 0 . DP=19;I16=7,11,0,0,609,21717,0,0,1080,64800,0,0,341,7357,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,231:9:0 0,0,0:0:0 0,27,214:9:0 +X 2850 . C <*> 0 . DP=19;I16=7,11,0,0,574,18980,0,0,1080,64800,0,0,343,7461,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,234:9:0 0,0,0:0:0 0,27,188:9:0 +X 2851 . G <*> 0 . DP=17;I16=6,11,0,0,589,20831,0,0,1020,61200,0,0,346,7584,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,239:9:0 0,0,0:0:0 0,24,194:8:0 +X 2852 . T <*> 0 . DP=17;I16=6,11,0,0,625,23241,0,0,1020,61200,0,0,348,7676,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,244:9:0 0,0,0:0:0 0,24,214:8:0 +X 2853 . G <*> 0 . DP=17;I16=6,11,0,0,635,23949,0,0,1020,61200,0,0,349,7739,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,0,0:0:0 0,24,202:8:0 +X 2854 . T <*> 0 . DP=17;I16=6,11,0,0,602,21990,0,0,1020,61200,0,0,348,7722,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,238:9:0 0,0,0:0:0 0,24,207:8:0 +X 2855 . C <*> 0 . DP=17;I16=6,10,0,0,577,21539,0,0,960,57600,0,0,337,7623,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,0,0:0:0 0,21,185:7:0 +X 2856 . T <*> 0 . DP=17;I16=6,8,0,0,530,20570,0,0,840,50400,0,0,289,6507,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,252:9:0 0,0,0:0:0 0,15,167:5:0 +X 2857 . C <*> 0 . DP=18;I16=6,10,0,0,577,21641,0,0,960,57600,0,0,336,7664,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,0,0:0:0 0,21,185:7:0 +X 2858 . A <*> 0 . DP=19;I16=6,12,0,0,634,23006,0,0,1080,64800,0,0,355,8081,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,254:10:0 0,3,39:1:0 0,21,185:7:0 +X 2859 . C <*> 0 . DP=19;I16=6,13,0,0,646,23056,0,0,1140,68400,0,0,361,8139,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,3,26:1:0 0,24,194:8:0 +X 2860 . C <*> 0 . DP=19;I16=6,13,0,0,655,23687,0,0,1140,68400,0,0,360,8166,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,251:10:0 0,3,37:1:0 0,24,200:8:0 +X 2861 . C <*> 0 . DP=20;I16=7,12,0,0,708,26756,0,0,1140,68400,0,0,333,7537,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,3,38:1:0 0,21,203:7:0 +X 2862 . A <*> 0 . DP=20;I16=6,13,0,0,749,29753,0,0,1140,68400,0,0,332,7554,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,3,43:1:0 0,24,225:8:0 +X 2863 . G <*> 0 . DP=19;I16=7,12,0,0,707,26901,0,0,1140,68400,0,0,356,8166,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,3,35:1:0 0,21,195:7:0 +X 2864 . G <*> 0 . DP=19;I16=7,11,0,0,677,25833,0,0,1080,64800,0,0,352,8070,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,3,36:1:0 0,18,185:6:0 +X 2865 . G <*> 0 . DP=19;I16=7,12,0,0,671,24569,0,0,1140,68400,0,0,350,7994,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,3,27:1:0 0,21,193:7:0 +X 2866 . T <*> 0 . DP=18;I16=6,11,0,0,591,21071,0,0,1020,61200,0,0,338,7834,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,3,32:1:0 0,15,147:5:0 +X 2867 . G <*> 0 . DP=18;I16=7,11,0,0,655,24279,0,0,1080,64800,0,0,347,7889,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,58:2:0 0,15,150:5:0 +X 2868 . T <*> 0 . DP=18;I16=7,11,0,0,640,23702,0,0,1080,64800,0,0,347,7859,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,68:2:0 0,15,157:5:0 +X 2869 . C <*> 0 . DP=18;I16=7,11,0,0,655,24737,0,0,1080,64800,0,0,346,7794,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,56:2:0 0,15,165:5:0 +X 2870 . T <*> 0 . DP=18;I16=7,11,0,0,700,27480,0,0,1080,64800,0,0,345,7743,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,70:2:0 0,15,176:5:0 +X 2871 . G <*> 0 . DP=18;I16=7,11,0,0,700,27554,0,0,1080,64800,0,0,344,7706,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,68:2:0 0,15,172:5:0 +X 2872 . A <*> 0 . DP=18;I16=7,11,0,0,651,23869,0,0,1080,64800,0,0,343,7683,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,66:2:0 0,15,171:5:0 +X 2873 . A <*> 0 . DP=18;I16=7,11,0,0,664,25000,0,0,1080,64800,0,0,342,7674,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,61:2:0 0,15,159:5:0 +X 2874 . A <*> 0 . DP=18;I16=7,11,0,0,636,23286,0,0,1080,64800,0,0,341,7679,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,57:2:0 0,15,162:5:0 +X 2875 . C <*> 0 . DP=18;I16=7,11,0,0,664,25148,0,0,1080,64800,0,0,340,7698,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,63:2:0 0,15,166:5:0 +X 2876 . A <*> 0 . DP=18;I16=6,11,0,0,666,26684,0,0,1020,61200,0,0,314,7106,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,6,74:2:0 0,15,185:5:0 +X 2877 . G <*> 0 . DP=17;I16=6,11,0,0,659,26009,0,0,1020,61200,0,0,339,7777,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,67:2:0 0,12,148:4:0 +X 2878 . A <*> 0 . DP=17;I16=7,10,0,0,628,23656,0,0,1020,61200,0,0,340,7834,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,6,69:2:0 0,15,166:5:0 +X 2879 . T <*> 0 . DP=18;I16=7,11,0,0,671,25359,0,0,1080,64800,0,0,342,7902,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,253:10:0 0,9,96:3:0 0,15,175:5:0 +X 2880 . G <*> 0 . DP=19;I16=8,11,0,0,708,26694,0,0,1140,68400,0,0,345,7983,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,118:4:0 0,15,173:5:0 +X 2881 . T <*> 0 . DP=19;I16=6,11,0,0,618,23304,0,0,1020,61200,0,0,299,6829,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,209:8:0 0,12,124:4:0 0,15,178:5:0 +X 2882 . G <*> 0 . DP=19;I16=8,11,0,0,700,26464,0,0,1140,68400,0,0,353,8191,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,118:4:0 0,15,176:5:0 +X 2883 . G <*> 0 . DP=19;I16=8,11,0,0,707,26939,0,0,1140,68400,0,0,357,8319,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,121:4:0 0,15,175:5:0 +X 2884 . A <*> 0 . DP=19;I16=7,11,0,0,649,24531,0,0,1080,64800,0,0,335,7787,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,229:9:0 0,12,121:4:0 0,15,181:5:0 +X 2885 . G <*> 0 . DP=19;I16=8,11,0,0,737,29253,0,0,1140,68400,0,0,362,8470,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,113:4:0 0,15,182:5:0 +X 2886 . G A,<*> 0 . DP=18;I16=7,9,1,0,571,21281,20,400,960,57600,60,3600,334,7882,6,36;QS=2.76471,0.235294,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=1;BQB=1;MQ0F=0 PL:DP:DV 0,27,236,27,236,236:9:0 11,0,51,17,54,66:3:1 0,15,171,15,171,171:5:0 +X 2887 . T <*> 0 . DP=19;I16=9,9,0,0,581,20407,0,0,1080,64800,0,0,341,7905,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,213:10:0 0,9,94:3:0 0,15,166:5:0 +X 2888 . C <*> 0 . DP=20;I16=10,10,0,0,714,26630,0,0,1200,72000,0,0,368,8532,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,94:4:0 0,15,159:5:0 +X 2889 . T <*> 0 . DP=19;I16=9,10,0,0,712,27106,0,0,1140,68400,0,0,372,8550,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,114:4:0 0,15,175:5:0 +X 2890 . C <*> 0 . DP=19;I16=9,10,0,0,613,20711,0,0,1140,68400,0,0,376,8584,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,247:10:0 0,12,95:4:0 0,15,139:5:0 +X 2891 . G <*> 0 . DP=20;I16=9,11,0,0,674,23754,0,0,1200,72000,0,0,380,8634,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,242:10:0 0,15,141:5:0 0,15,143:5:0 +X 2892 . G <*> 0 . DP=21;I16=9,12,0,0,731,26677,0,0,1260,75600,0,0,385,8701,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,142:5:0 0,15,164:5:0 +X 2893 . G <*> 0 . DP=21;I16=9,12,0,0,696,24498,0,0,1260,75600,0,0,389,8687,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,251:11:0 0,15,141:5:0 0,15,150:5:0 +X 2894 . T <*> 0 . DP=21;I16=9,12,0,0,716,25490,0,0,1260,75600,0,0,393,8693,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,137:5:0 0,15,155:5:0 +X 2895 . G <*> 0 . DP=22;I16=9,12,0,0,773,29225,0,0,1260,75600,0,0,372,8094,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,149:6:0 0,15,166:5:0 +X 2896 . A <*> 0 . DP=22;I16=8,12,0,0,732,27684,0,0,1200,72000,0,0,361,7885,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,151:5:0 0,15,163:5:0 +X 2897 . G <*> 0 . DP=22;I16=10,12,0,0,783,28783,0,0,1320,79200,0,0,407,8835,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,161:6:0 0,15,168:5:0 +X 2898 . G <*> 0 . DP=22;I16=10,12,0,0,724,25596,0,0,1320,79200,0,0,412,8926,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,254:11:0 0,18,143:6:0 0,15,169:5:0 +X 2899 . C <*> 0 . DP=22;I16=8,11,0,0,625,21143,0,0,1140,68400,0,0,356,7640,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,228:9:0 0,15,130:5:0 0,15,147:5:0 +X 2900 . G <*> 0 . DP=24;I16=11,13,0,0,782,26700,0,0,1440,86400,0,0,420,9078,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,164:6:0 0,15,153:5:0 +X 2901 . T <*> 0 . DP=24;I16=11,13,0,0,821,29195,0,0,1440,86400,0,0,426,9192,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,174:6:0 0,15,166:5:0 +X 2902 . G <*> 0 . DP=24;I16=11,13,0,0,898,34176,0,0,1440,86400,0,0,432,9334,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,171:6:0 0,15,164:5:0 +X 2903 . G <*> 0 . DP=24;I16=11,13,0,0,894,33764,0,0,1440,86400,0,0,437,9455,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,183:6:0 0,15,168:5:0 +X 2904 . C <*> 0 . DP=24;I16=11,13,0,0,892,34010,0,0,1440,86400,0,0,440,9506,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,176:6:0 0,15,169:5:0 +X 2905 . T <*> 0 . DP=25;I16=12,13,0,0,926,34994,0,0,1500,90000,0,0,442,9536,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,175:6:0 0,15,174:5:0 +X 2906 . C <*> 0 . DP=25;I16=12,13,0,0,960,37070,0,0,1500,90000,0,0,444,9544,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,178:6:0 0,15,173:5:0 +X 2907 . A <*> 0 . DP=25;I16=11,13,0,0,933,36707,0,0,1440,86400,0,0,429,9275,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,202:6:0 0,15,170:5:0 +X 2908 . G <*> 0 . DP=25;I16=12,13,0,0,943,36315,0,0,1500,90000,0,0,446,9548,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,167:6:0 0,15,164:5:0 +X 2909 . A <*> 0 . DP=25;I16=10,13,0,0,864,32764,0,0,1380,82800,0,0,425,9105,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,182:6:0 0,15,171:5:0 +X 2910 . T <*> 0 . DP=25;I16=11,13,0,0,870,32054,0,0,1440,86400,0,0,447,9575,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,181:6:0 0,15,166:5:0 +X 2911 . A <*> 0 . DP=25;I16=11,14,0,0,871,31227,0,0,1500,90000,0,0,473,10259,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,174:6:0 0,18,188:6:0 +X 2912 . C <*> 0 . DP=24;I16=11,13,0,0,899,34121,0,0,1440,86400,0,0,474,10298,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,173:6:0 0,18,189:6:0 +X 2913 . A <*> 0 . DP=24;I16=10,13,0,0,879,34357,0,0,1380,82800,0,0,449,9691,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,164:5:0 0,18,199:6:0 +X 2914 . G <*> 0 . DP=24;I16=11,13,0,0,899,34575,0,0,1440,86400,0,0,472,10262,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,170:6:0 0,18,187:6:0 +X 2915 . G <*> 0 . DP=24;I16=11,13,0,0,867,32523,0,0,1440,86400,0,0,470,10236,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,177:6:0 0,18,178:6:0 +X 2916 . G <*> 0 . DP=24;I16=11,12,0,0,813,29935,0,0,1380,82800,0,0,443,9613,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,173:6:0 0,15,155:5:0 +X 2917 . A <*> 0 . DP=25;I16=11,13,0,0,864,31926,0,0,1440,86400,0,0,459,10181,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,185:6:0 0,18,178:6:0 +X 2918 . G <*> 0 . DP=25;I16=13,12,0,0,903,33489,0,0,1500,90000,0,0,462,10122,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,165:6:0 0,18,170:6:0 +X 2919 . T <*> 0 . DP=25;I16=12,12,0,0,837,29647,0,0,1440,86400,0,0,443,9765,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,169:6:0 0,18,178:6:0 +X 2920 . G <*> 0 . DP=25;I16=12,12,0,0,850,31266,0,0,1440,86400,0,0,433,9389,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,132:5:0 0,18,180:6:0 +X 2921 . G <*> 0 . DP=25;I16=13,12,0,0,874,31518,0,0,1500,90000,0,0,455,9951,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,159:6:0 0,18,176:6:0 +X 2922 . C <*> 0 . DP=26;I16=13,12,0,0,872,31374,0,0,1500,90000,0,0,438,9718,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,160:6:0 0,18,172:6:0 +X 2923 . C <*> 0 . DP=26;I16=13,12,0,0,873,31687,0,0,1500,90000,0,0,437,9735,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,172:6:0 0,18,175:6:0 +X 2924 . C <*> 0 . DP=25;I16=13,12,0,0,940,36016,0,0,1500,90000,0,0,449,9921,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,173:6:0 0,18,184:6:0 +X 2925 . A <*> 0 . DP=25;I16=13,12,0,0,912,33580,0,0,1500,90000,0,0,448,9964,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,174:6:0 0,18,189:6:0 +X 2926 . C <*> 0 . DP=25;I16=13,12,0,0,902,33224,0,0,1500,90000,0,0,445,9931,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,176:6:0 0,18,174:6:0 +X 2927 . A <*> 0 . DP=25;I16=12,12,0,0,896,33828,0,0,1440,86400,0,0,417,9295,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,162:5:0 0,18,191:6:0 +X 2928 . G <*> 0 . DP=24;I16=13,11,0,0,862,32078,0,0,1440,86400,0,0,440,9930,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,170:6:0 0,18,161:6:0 +X 2929 . C <*> 0 . DP=23;I16=13,9,0,0,794,29716,0,0,1320,79200,0,0,430,9878,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,153:5:0 0,15,149:5:0 +X 2930 . T <*> 0 . DP=23;I16=13,10,0,0,822,30260,0,0,1380,82800,0,0,438,10006,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,168:6:0 0,15,157:5:0 +X 2931 . C <*> 0 . DP=23;I16=13,10,0,0,803,28963,0,0,1380,82800,0,0,436,10020,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,162:6:0 0,15,140:5:0 +X 2932 . G <*> 0 . DP=22;I16=12,10,0,0,728,25158,0,0,1320,79200,0,0,435,10049,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,171:6:0 0,12,117:4:0 +X 2933 . G <*> 0 . DP=22;I16=11,10,0,0,760,28336,0,0,1260,75600,0,0,430,10034,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,175:6:0 0,12,116:4:0 +X 2934 . C <*> 0 . DP=21;I16=12,9,0,0,759,28241,0,0,1260,75600,0,0,432,10052,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,161:6:0 0,9,104:3:0 +X 2935 . C <*> 0 . DP=21;I16=12,9,0,0,766,28494,0,0,1260,75600,0,0,431,10075,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,178:6:0 0,9,94:3:0 +X 2936 . T <*> 0 . DP=21;I16=11,9,0,0,760,29284,0,0,1200,72000,0,0,429,10063,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,188:6:0 0,9,98:3:0 +X 2937 . G <*> 0 . DP=20;I16=11,9,0,0,728,27374,0,0,1200,72000,0,0,428,10066,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,177:6:0 0,9,79:3:0 +X 2938 . T <*> 0 . DP=20;I16=11,9,0,0,719,26217,0,0,1200,72000,0,0,427,10083,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,188:6:0 0,9,101:3:0 +X 2939 . C <*> 0 . DP=19;I16=11,8,0,0,729,28277,0,0,1140,68400,0,0,427,10113,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,163:5:0 0,9,106:3:0 +X 2940 . T <*> 0 . DP=19;I16=11,8,0,0,739,29133,0,0,1140,68400,0,0,427,10155,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,171:5:0 0,9,109:3:0 +X 2941 . T <*> 0 . DP=19;I16=11,8,0,0,702,26358,0,0,1140,68400,0,0,427,10209,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,170:5:0 0,9,99:3:0 +X 2942 . T <*> 0 . DP=19;I16=11,8,0,0,695,25671,0,0,1140,68400,0,0,427,10275,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,169:5:0 0,9,100:3:0 +X 2943 . G <*> 0 . DP=18;I16=11,6,0,0,621,23187,0,0,1020,61200,0,0,401,9627,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,228:9:0 0,15,170:5:0 0,9,86:3:0 +X 2944 . A <*> 0 . DP=18;I16=10,7,0,0,642,24406,0,0,1020,61200,0,0,399,9563,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,239:9:0 0,15,168:5:0 0,9,111:3:0 +X 2945 . A <*> 0 . DP=18;I16=11,7,0,0,637,23199,0,0,1080,64800,0,0,422,10132,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,242:10:0 0,15,152:5:0 0,9,107:3:0 +X 2946 . A <*> 0 . DP=18;I16=11,7,0,0,692,26794,0,0,1080,64800,0,0,420,10084,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,174:5:0 0,9,108:3:0 +X 2947 . G <*> 0 . DP=18;I16=11,7,0,0,639,23329,0,0,1080,64800,0,0,418,10044,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,160:5:0 0,9,78:3:0 +X 2948 . G <*> 0 . DP=19;I16=11,8,0,0,702,26272,0,0,1140,68400,0,0,415,9961,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,163:5:0 0,12,116:4:0 +X 2949 . C <*> 0 . DP=19;I16=10,8,0,0,657,24565,0,0,1080,64800,0,0,388,9260,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,125:4:0 0,12,124:4:0 +X 2950 . C <*> 0 . DP=19;I16=11,8,0,0,667,24359,0,0,1140,68400,0,0,411,9817,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,131:5:0 0,12,115:4:0 +X 2951 . A <*> 0 . DP=20;I16=11,8,0,0,682,24956,0,0,1140,68400,0,0,409,9757,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,250:10:0 0,15,149:5:0 0,12,133:4:0 +X 2952 . C <*> 0 . DP=20;I16=11,9,0,0,647,21709,0,0,1200,72000,0,0,408,9706,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,128:5:0 0,12,112:4:0 +X 2953 . G <*> 0 . DP=21;I16=11,9,0,0,620,19954,0,0,1200,72000,0,0,407,9665,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,237:11:0 0,15,132:5:0 0,12,111:4:0 +X 2954 . T <*> 0 . DP=21;I16=11,10,0,0,742,26662,0,0,1260,75600,0,0,414,9666,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,175:6:0 0,12,135:4:0 +X 2955 . G <*> 0 . DP=22;I16=11,11,0,0,787,28475,0,0,1320,79200,0,0,412,9568,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,170:6:0 0,12,127:4:0 +X 2956 . A <*> 0 . DP=22;I16=11,11,0,0,747,26449,0,0,1320,79200,0,0,410,9438,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,161:6:0 0,12,125:4:0 +X 2957 . C <*> 0 . DP=22;I16=10,10,0,0,693,24757,0,0,1200,72000,0,0,358,8078,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,143:6:0 0,9,104:3:0 +X 2958 . C <*> 0 . DP=21;I16=11,10,0,0,784,29744,0,0,1260,75600,0,0,407,9237,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,172:6:0 0,12,135:4:0 +X 2959 . T <*> 0 . DP=21;I16=11,10,0,0,791,30411,0,0,1260,75600,0,0,406,9164,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,182:6:0 0,12,139:4:0 +X 2960 . G <*> 0 . DP=21;I16=11,10,0,0,778,29502,0,0,1260,75600,0,0,405,9109,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,178:6:0 0,12,126:4:0 +X 2961 . G <*> 0 . DP=20;I16=10,9,0,0,657,23303,0,0,1140,68400,0,0,380,8446,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,231:10:0 0,18,176:6:0 0,9,111:3:0 +X 2962 . C <*> 0 . DP=21;I16=10,10,0,0,731,27459,0,0,1200,72000,0,0,385,8615,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,151:5:0 0,12,132:4:0 +X 2963 . C <*> 0 . DP=21;I16=10,10,0,0,722,26502,0,0,1200,72000,0,0,378,8274,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,169:6:0 0,9,100:3:0 +X 2964 . C <*> 0 . DP=22;I16=11,10,0,0,752,27740,0,0,1260,75600,0,0,379,8275,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,148:5:0 0,15,151:5:0 +X 2965 . A <*> 0 . DP=22;I16=11,11,0,0,804,29606,0,0,1320,79200,0,0,397,8539,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,176:6:0 0,15,155:5:0 +X 2966 . C <*> 0 . DP=22;I16=11,11,0,0,705,23557,0,0,1320,79200,0,0,396,8468,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,254:11:0 0,18,146:6:0 0,15,142:5:0 +X 2967 . G <*> 0 . DP=24;I16=11,13,0,0,767,25405,0,0,1440,86400,0,0,393,8325,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,162:6:0 0,18,135:6:0 +X 2968 . G <*> 0 . DP=23;I16=11,12,0,0,812,29824,0,0,1380,82800,0,0,393,8213,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,152:5:0 0,18,162:6:0 +X 2969 . C <*> 0 . DP=23;I16=11,12,0,0,866,32982,0,0,1380,82800,0,0,393,8133,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,151:5:0 0,18,181:6:0 +X 2970 . T <*> 0 . DP=24;I16=11,12,0,0,816,29806,0,0,1380,82800,0,0,393,8085,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,154:5:0 0,18,189:6:0 +X 2971 . G <*> 0 . DP=24;I16=12,12,0,0,878,33010,0,0,1440,86400,0,0,392,7970,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,173:6:0 0,18,184:6:0 +X 2972 . G <*> 0 . DP=24;I16=12,12,0,0,839,30363,0,0,1440,86400,0,0,391,7889,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,175:6:0 0,18,161:6:0 +X 2973 . C <*> 0 . DP=24;I16=12,12,0,0,854,31154,0,0,1440,86400,0,0,390,7842,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,177:6:0 0,18,165:6:0 +X 2974 . A <*> 0 . DP=24;I16=12,12,0,0,869,32231,0,0,1440,86400,0,0,388,7778,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,169:6:0 0,18,174:6:0 +X 2975 . G <*> 0 . DP=24;I16=12,12,0,0,857,31835,0,0,1440,86400,0,0,384,7648,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,173:6:0 0,18,167:6:0 +X 2976 . G <*> 0 . DP=25;I16=13,12,0,0,866,31118,0,0,1500,90000,0,0,380,7554,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,180:7:0 0,18,171:6:0 +X 2977 . T <*> 0 . DP=26;I16=13,12,0,0,760,25216,0,0,1469,87241,0,0,373,7437,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,151:6:0 0,18,155:6:0 +X 2978 . G <*> 0 . DP=25;I16=12,12,0,0,862,31574,0,0,1409,83641,0,0,362,7290,0,0;QS=3,0;MQSB=0.941765;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,168:6:0 0,18,167:6:0 +X 2979 . G <*> 0 . DP=24;I16=12,12,0,0,816,28440,0,0,1409,83641,0,0,370,7340,0,0;QS=3,0;MQSB=0.941765;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,164:6:0 0,15,142:5:0 +X 2980 . G <*> 0 . DP=23;I16=12,11,0,0,834,30882,0,0,1349,80041,0,0,369,7293,0,0;QS=3,0;MQSB=0.944319;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,144:5:0 0,15,148:5:0 +X 2981 . A <*> 0 . DP=23;I16=9,11,0,0,622,20306,0,0,1169,69241,0,0,318,6244,0,0;QS=3,0;MQSB=0.916401;MQ0F=0 PL:DP:DV 0,30,201:10:0 0,15,145:5:0 0,15,150:5:0 +X 2982 . C <*> 0 . DP=23;I16=10,11,0,0,706,24366,0,0,1229,72841,0,0,340,6884,0,0;QS=3,0;MQSB=0.927743;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,93:3:0 0,15,144:5:0 +X 2983 . C <*> 0 . DP=23;I16=12,11,0,0,781,27427,0,0,1349,80041,0,0,363,7197,0,0;QS=3,0;MQSB=0.944319;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,137:5:0 0,15,142:5:0 +X 2984 . C <*> 0 . DP=23;I16=12,11,0,0,861,32655,0,0,1349,80041,0,0,361,7229,0,0;QS=3,0;MQSB=0.944319;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,154:5:0 0,15,157:5:0 +X 2985 . A <*> 0 . DP=23;I16=12,11,0,0,798,28906,0,0,1349,80041,0,0,359,7293,0,0;QS=3,0;MQSB=0.944319;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,161:5:0 0,15,151:5:0 +X 2986 . G <*> 0 . DP=21;I16=11,10,0,0,701,24335,0,0,1229,72841,0,0,358,7388,0,0;QS=3,0;MQSB=0.939898;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,129:5:0 0,12,126:4:0 +X 2987 . C <*> 0 . DP=21;I16=10,10,0,0,720,26782,0,0,1169,69241,0,0,350,7448,0,0;QS=3,0;MQSB=0.931063;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,136:4:0 0,12,132:4:0 +X 2988 . T <*> 0 . DP=20;I16=10,10,0,0,693,25143,0,0,1169,69241,0,0,358,7612,0,0;QS=3,0;MQSB=0.931063;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,132:5:0 0,12,136:4:0 +X 2989 . G <*> 0 . DP=20;I16=10,10,0,0,708,25886,0,0,1169,69241,0,0,358,7736,0,0;QS=3,0;MQSB=0.931063;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,141:5:0 0,12,125:4:0 +X 2990 . C <*> 0 . DP=20;I16=10,10,0,0,697,25083,0,0,1169,69241,0,0,357,7833,0,0;QS=3,0;MQSB=0.931063;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,149:5:0 0,12,129:4:0 +X 2991 . A <*> 0 . DP=20;I16=10,10,0,0,717,26309,0,0,1169,69241,0,0,356,7952,0,0;QS=3,0;MQSB=0.931063;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,151:5:0 0,12,131:4:0 +X 2992 . G <*> 0 . DP=18;I16=10,8,0,0,625,22505,0,0,1049,62041,0,0,356,8042,0,0;QS=3,0;MQSB=0.938795;MQ0F=0 PL:DP:DV 0,30,243:10:0 0,12,130:4:0 0,12,120:4:0 +X 2993 . G <*> 0 . DP=18;I16=10,8,0,0,646,23620,0,0,1049,62041,0,0,354,8050,0,0;QS=3,0;MQSB=0.938795;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,118:4:0 0,12,123:4:0 +X 2994 . G <*> 0 . DP=18;I16=10,8,0,0,620,21828,0,0,1049,62041,0,0,351,8025,0,0;QS=3,0;MQSB=0.938795;MQ0F=0 PL:DP:DV 0,30,254:10:0 0,12,115:4:0 0,12,116:4:0 +X 2995 . G <*> 0 . DP=18;I16=10,8,0,0,628,22284,0,0,1049,62041,0,0,348,8018,0,0;QS=3,0;MQSB=0.938795;MQ0F=0 PL:DP:DV 0,30,248:10:0 0,12,110:4:0 0,12,135:4:0 +X 2996 . T <*> 0 . DP=17;I16=8,8,0,0,497,16697,0,0,929,54841,0,0,323,7493,0,0;QS=3,0;MQSB=0.915545;MQ0F=0 PL:DP:DV 0,30,215:10:0 0,9,75:3:0 0,9,107:3:0 +X 2997 . C <*> 0 . DP=17;I16=9,8,0,0,603,21925,0,0,989,58441,0,0,341,7901,0,0;QS=3,0;MQSB=0.928603;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,85:3:0 0,12,115:4:0 +X 2998 . C <*> 0 . DP=17;I16=9,8,0,0,576,19964,0,0,989,58441,0,0,337,7841,0,0;QS=3,0;MQSB=0.928603;MQ0F=0 PL:DP:DV 0,30,247:10:0 0,9,84:3:0 0,12,123:4:0 +X 2999 . A <*> 0 . DP=17;I16=9,8,0,0,599,22077,0,0,989,58441,0,0,333,7797,0,0;QS=3,0;MQSB=0.928603;MQ0F=0 PL:DP:DV 0,30,238:10:0 0,9,109:3:0 0,12,136:4:0 +X 3000 . G <*> 0 . DP=15;I16=8,7,0,0,554,20620,0,0,869,51241,0,0,331,7767,0,0;QS=3,0;MQSB=0.921243;MQ0F=0 PL:DP:DV 0,24,220:8:0 0,9,102:3:0 0,12,135:4:0 +X 3001 . C <*> 0 . DP=15;I16=7,7,0,0,521,19695,0,0,809,47641,0,0,309,7349,0,0;QS=3,0;MQSB=0.885987;MQ0F=0 PL:DP:DV 0,21,213:7:0 0,9,103:3:0 0,12,128:4:0 +X 3002 . A <*> 0 . DP=15;I16=8,7,0,0,542,20082,0,0,869,51241,0,0,326,7692,0,0;QS=3,0;MQSB=0.921243;MQ0F=0 PL:DP:DV 0,24,224:8:0 0,9,92:3:0 0,12,139:4:0 +X 3003 . G <*> 0 . DP=15;I16=8,7,0,0,540,19814,0,0,869,51241,0,0,322,7594,0,0;QS=3,0;MQSB=0.921243;MQ0F=0 PL:DP:DV 0,24,230:8:0 0,9,96:3:0 0,12,120:4:0 +X 3004 . C <*> 0 . DP=15;I16=8,7,0,0,525,19113,0,0,869,51241,0,0,318,7504,0,0;QS=3,0;MQSB=0.921243;MQ0F=0 PL:DP:DV 0,24,211:8:0 0,9,100:3:0 0,12,129:4:0 +X 3005 . A <*> 0 . DP=14;I16=7,7,0,0,491,17343,0,0,809,47641,0,0,315,7421,0,0;QS=3,0;MQSB=0.885987;MQ0F=0 PL:DP:DV 0,21,197:7:0 0,9,95:3:0 0,12,124:4:0 +X 3006 . C <*> 0 . DP=16;I16=7,8,0,0,516,18376,0,0,869,51241,0,0,312,7344,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,24,200:8:0 0,9,95:3:0 0,12,135:4:0 +X 3007 . C <*> 0 . DP=16;I16=7,8,0,0,553,20853,0,0,869,51241,0,0,310,7274,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,24,214:8:0 0,9,103:3:0 0,12,144:4:0 +X 3008 . C <*> 0 . DP=16;I16=7,8,0,0,576,22238,0,0,869,51241,0,0,308,7212,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,24,228:8:0 0,9,105:3:0 0,12,145:4:0 +X 3009 . A <*> 0 . DP=16;I16=7,8,0,0,493,16739,0,0,869,51241,0,0,306,7158,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,24,200:8:0 0,9,83:3:0 0,12,130:4:0 +X 3010 . C <*> 0 . DP=15;I16=7,7,0,0,534,20464,0,0,809,47641,0,0,300,7096,0,0;QS=3,0;MQSB=0.885987;MQ0F=0 PL:DP:DV 0,21,211:7:0 0,9,106:3:0 0,12,135:4:0 +X 3011 . A <*> 0 . DP=16;I16=7,8,0,0,559,21173,0,0,869,51241,0,0,302,7074,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,24,218:8:0 0,9,104:3:0 0,12,145:4:0 +X 3012 . G <*> 0 . DP=16;I16=7,8,0,0,503,17903,0,0,869,51241,0,0,300,7044,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,24,193:8:0 0,9,93:3:0 0,12,141:4:0 +X 3013 . C <*> 0 . DP=16;I16=7,9,0,0,549,19967,0,0,898,52082,0,0,305,7071,0,0;QS=3,0;MQSB=0.994413;MQ0F=0 PL:DP:DV 0,27,207:9:0 0,9,98:3:0 0,12,141:4:0 +X 3014 . A <*> 0 . DP=18;I16=6,9,0,0,542,20362,0,0,838,48482,0,0,289,6959,0,0;QS=3,0;MQSB=0.984496;MQ0F=0 PL:DP:DV 0,24,195:8:0 0,9,109:3:0 0,12,141:4:0 +X 3015 . G <*> 0 . DP=20;I16=7,9,0,0,549,19441,0,0,929,54841,0,0,311,7547,0,0;QS=3,0;MQSB=0.892753;MQ0F=0 PL:DP:DV 0,24,206:8:0 0,12,116:4:0 0,12,131:4:0 +X 3016 . C <*> 0 . DP=20;I16=7,13,0,0,690,24374,0,0,1138,66482,0,0,337,7783,0,0;QS=3,0;MQSB=0.972138;MQ0F=0 PL:DP:DV 0,33,248:11:0 0,15,136:5:0 0,12,132:4:0 +X 3017 . C A,<*> 0 . DP=20;I16=7,12,0,1,650,23264,23,529,1109,65641,29,841,329,7715,11,121;QS=2.93801,0.0619946,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.972138;BQB=1;MQ0F=0 PL:DP:DV 0,10,224,30,227,236:11:1 0,15,133,15,133,133:5:0 0,12,128,12,128,128:4:0 +X 3018 . A <*> 0 . DP=21;I16=6,10,0,0,475,15057,0,0,929,54841,0,0,295,6991,0,0;QS=3,0;MQSB=0.863243;MQ0F=0 PL:DP:DV 0,27,192:9:0 0,12,111:4:0 0,9,81:3:0 +X 3019 . C <*> 0 . DP=20;I16=6,12,0,0,618,21842,0,0,1049,62041,0,0,336,7818,0,0;QS=3,0;MQSB=0.85394;MQ0F=0 PL:DP:DV 0,30,242:10:0 0,15,129:5:0 0,9,104:3:0 +X 3020 . C <*> 0 . DP=20;I16=6,12,0,0,588,21046,0,0,1049,62041,0,0,340,7888,0,0;QS=3,0;MQSB=0.85394;MQ0F=0 PL:DP:DV 0,30,221:10:0 0,15,129:5:0 0,9,114:3:0 +X 3021 . T <*> 0 . DP=21;I16=5,13,0,0,618,22454,0,0,1049,62041,0,0,343,7921,0,0;QS=3,0;MQSB=0.814433;MQ0F=0 PL:DP:DV 0,30,216:10:0 0,15,147:5:0 0,9,109:3:0 +X 3022 . G <*> 0 . DP=20;I16=5,13,0,0,672,25292,0,0,1049,62041,0,0,348,7968,0,0;QS=3,0;MQSB=0.814433;MQ0F=0 PL:DP:DV 0,30,234:10:0 0,15,153:5:0 0,9,109:3:0 +X 3023 . T G,<*> 0 . DP=20;I16=5,12,0,1,554,19110,18,324,989,58441,60,3600,336,7740,17,289;QS=2.94231,0.0576923,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.814433;BQB=1;MQ0F=0 PL:DP:DV 0,12,191,27,194,199:10:1 0,15,125,15,125,125:5:0 0,9,111,9,111,111:3:0 +X 3024 . G <*> 0 . DP=20;I16=5,14,0,0,684,25122,0,0,1109,65641,0,0,382,8680,0,0;QS=3,0;MQSB=0.810584;MQ0F=0 PL:DP:DV 0,30,235:10:0 0,18,152:6:0 0,9,113:3:0 +X 3025 . G <*> 0 . DP=20;I16=5,14,0,0,625,21465,0,0,1109,65641,0,0,386,8722,0,0;QS=3,0;MQSB=0.810584;MQ0F=0 PL:DP:DV 0,30,225:10:0 0,18,133:6:0 0,9,109:3:0 +X 3026 . C <*> 0 . DP=20;I16=5,13,0,0,632,23132,0,0,1018,59282,0,0,367,8217,0,0;QS=3,0;MQSB=0.925212;MQ0F=0 PL:DP:DV 0,33,235:11:0 0,12,105:4:0 0,9,107:3:0 +X 3027 . A <*> 0 . DP=21;I16=6,15,0,0,693,24199,0,0,1198,70082,0,0,413,9199,0,0;QS=3,0;MQSB=0.940481;MQ0F=0 PL:DP:DV 0,33,222:11:0 0,21,175:7:0 0,9,108:3:0 +X 3028 . G <*> 0 . DP=21;I16=6,15,0,0,753,27935,0,0,1198,70082,0,0,417,9239,0,0;QS=3,0;MQSB=0.940481;MQ0F=0 PL:DP:DV 0,33,241:11:0 0,21,192:7:0 0,9,107:3:0 +X 3029 . G <*> 0 . DP=21;I16=6,15,0,0,787,29949,0,0,1198,70082,0,0,421,9303,0,0;QS=3,0;MQSB=0.940481;MQ0F=0 PL:DP:DV 0,33,251:11:0 0,21,189:7:0 0,9,109:3:0 +X 3030 . G <*> 0 . DP=22;I16=6,16,0,0,720,24728,0,0,1258,73682,0,0,424,9342,0,0;QS=3,0;MQSB=0.934321;MQ0F=0 PL:DP:DV 0,36,229:12:0 0,21,174:7:0 0,9,106:3:0 +X 3031 . A <*> 0 . DP=22;I16=5,16,0,0,693,24631,0,0,1198,70082,0,0,403,8783,0,0;QS=3,0;MQSB=0.902014;MQ0F=0 PL:DP:DV 0,36,222:12:0 0,18,162:6:0 0,9,113:3:0 +X 3032 . G <*> 0 . DP=22;I16=6,15,0,0,727,26093,0,0,1229,72841,0,0,405,8775,0,0;QS=3,0;MQSB=0.843281;MQ0F=0 PL:DP:DV 0,33,237:11:0 0,21,180:7:0 0,9,106:3:0 +X 3033 . G <*> 0 . DP=22;I16=6,15,0,0,697,24039,0,0,1198,70082,0,0,429,9407,0,0;QS=3,0;MQSB=0.940481;MQ0F=0 PL:DP:DV 0,33,235:11:0 0,21,160:7:0 0,9,106:3:0 +X 3034 . A <*> 0 . DP=23;I16=6,14,0,0,617,20947,0,0,1138,66482,0,0,387,8491,0,0;QS=3,0;MQSB=0.947033;MQ0F=0 PL:DP:DV 0,33,203:11:0 0,15,134:5:0 0,12,126:4:0 +X 3035 . G <*> 0 . DP=23;I16=7,13,0,0,641,22007,0,0,1138,66482,0,0,385,8379,0,0;QS=3,0;MQSB=0.972138;MQ0F=0 PL:DP:DV 0,30,208:10:0 0,18,151:6:0 0,12,128:4:0 +X 3036 . C <*> 0 . DP=23;I16=6,15,0,0,688,23652,0,0,1198,70082,0,0,388,8258,0,0;QS=3,0;MQSB=0.940481;MQ0F=0 PL:DP:DV 0,36,216:12:0 0,15,132:5:0 0,12,140:4:0 +X 3037 . T <*> 0 . DP=24;I16=7,16,0,0,797,28671,0,0,1318,77282,0,0,439,9521,0,0;QS=3,0;MQSB=0.955805;MQ0F=0 PL:DP:DV 0,36,242:12:0 0,21,170:7:0 0,12,143:4:0 +X 3038 . T <*> 0 . DP=25;I16=8,17,0,0,815,27469,0,0,1438,84482,0,0,441,9561,0,0;QS=3,0;MQSB=0.966223;MQ0F=0 PL:DP:DV 0,42,249:14:0 0,21,190:7:0 0,12,125:4:0 +X 3039 . G <*> 0 . DP=25;I16=8,17,0,0,780,25946,0,0,1438,84482,0,0,444,9630,0,0;QS=3,0;MQSB=0.966223;MQ0F=0 PL:DP:DV 0,42,249:14:0 0,21,156:7:0 0,12,127:4:0 +X 3040 . T <*> 0 . DP=25;I16=7,15,0,0,701,23777,0,0,1258,73682,0,0,385,8279,0,0;QS=3,0;MQSB=0.961028;MQ0F=0 PL:DP:DV 0,36,239:12:0 0,18,154:6:0 0,12,130:4:0 +X 3041 . G <*> 0 . DP=25;I16=8,16,0,0,824,29228,0,0,1378,80882,0,0,420,8982,0,0;QS=3,0;MQSB=0.970446;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,186:7:0 0,12,135:4:0 +X 3042 . G <*> 0 . DP=25;I16=8,15,0,0,795,28227,0,0,1349,80041,0,0,409,8839,0,0;QS=3,0;MQSB=0.889418;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,148:6:0 0,12,120:4:0 +X 3043 . T <*> 0 . DP=25;I16=8,16,0,0,723,23191,0,0,1378,80882,0,0,435,9415,0,0;QS=3,0;MQSB=0.970446;MQ0F=0 PL:DP:DV 0,39,233:13:0 0,21,151:7:0 0,12,124:4:0 +X 3044 . A C,<*> 0 . DP=26;I16=8,15,0,1,665,20809,15,225,1318,77282,60,3600,392,8498,14,196;QS=2.96104,0.038961,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.970446;BQB=1;MQ0F=0 PL:DP:DV 0,26,216,39,219,220:14:1 0,18,133,18,133,133:6:0 0,12,124,12,124,124:4:0 +X 3045 . C <*> 0 . DP=26;I16=8,16,0,0,754,25232,0,0,1378,80882,0,0,403,8627,0,0;QS=3,0;MQSB=0.970446;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,133:6:0 0,12,122:4:0 +X 3046 . A <*> 0 . DP=25;I16=8,15,0,0,748,26170,0,0,1349,80041,0,0,400,8540,0,0;QS=3,0;MQSB=0.889418;MQ0F=0 PL:DP:DV 0,39,245:13:0 0,18,160:6:0 0,12,141:4:0 +X 3047 . G <*> 0 . DP=25;I16=8,15,0,0,766,26998,0,0,1318,77282,0,0,396,8432,0,0;QS=3,0;MQSB=0.974802;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,143:6:0 0,12,129:4:0 +X 3048 . T <*> 0 . DP=25;I16=8,11,0,0,608,20554,0,0,1109,65641,0,0,320,6762,0,0;QS=3,0;MQSB=0.902014;MQ0F=0 PL:DP:DV 0,30,226:10:0 0,15,128:5:0 0,12,129:4:0 +X 3049 . G <*> 0 . DP=24;I16=8,16,0,0,831,29557,0,0,1378,80882,0,0,426,9068,0,0;QS=3,0;MQSB=0.970446;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,161:6:0 0,9,105:3:0 +X 3050 . G <*> 0 . DP=24;I16=8,14,0,0,729,25093,0,0,1258,73682,0,0,379,8041,0,0;QS=3,0;MQSB=0.979255;MQ0F=0 PL:DP:DV 0,39,253:13:0 0,18,159:6:0 0,9,100:3:0 +X 3051 . A <*> 0 . DP=23;I16=8,15,0,0,724,24200,0,0,1318,77282,0,0,423,9091,0,0;QS=3,0;MQSB=0.974802;MQ0F=0 PL:DP:DV 0,42,243:14:0 0,18,152:6:0 0,9,103:3:0 +X 3052 . C <*> 0 . DP=23;I16=7,13,0,0,612,19876,0,0,1169,69241,0,0,363,7779,0,0;QS=3,0;MQSB=0.962269;MQ0F=0 PL:DP:DV 0,36,226:12:0 0,15,117:5:0 0,9,93:3:0 +X 3053 . A <*> 0 . DP=22;I16=8,11,0,0,616,21288,0,0,1078,62882,0,0,360,7740,0,0;QS=3,0;MQSB=0.992359;MQ0F=0 PL:DP:DV 0,33,234:11:0 0,15,118:5:0 0,9,110:3:0 +X 3054 . G <*> 0 . DP=22;I16=8,14,0,0,761,27617,0,0,1258,73682,0,0,414,8932,0,0;QS=3,0;MQSB=0.979255;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,126:5:0 0,9,99:3:0 +X 3055 . G <*> 0 . DP=22;I16=8,9,0,0,566,19890,0,0,958,55682,0,0,333,7219,0,0;QS=3,0;MQSB=0.998843;MQ0F=0 PL:DP:DV 0,30,228:10:0 0,12,111:4:0 0,9,105:3:0 +X 3056 . C <*> 0 . DP=22;I16=7,14,0,0,701,24685,0,0,1198,70082,0,0,420,9298,0,0;QS=3,0;MQSB=0.966484;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,125:4:0 0,12,122:4:0 +X 3057 . C <*> 0 . DP=23;I16=8,13,0,0,706,24988,0,0,1198,70082,0,0,411,9253,0,0;QS=3,0;MQSB=0.983744;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,128:5:0 0,9,92:3:0 +X 3058 . C <*> 0 . DP=23;I16=9,14,0,0,707,23327,0,0,1318,77282,0,0,429,9471,0,0;QS=3,0;MQSB=0.987676;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,131:5:0 0,12,116:4:0 +X 3059 . T G,<*> 0 . DP=23;I16=9,11,0,1,638,21954,16,256,1169,69241,60,3600,355,7761,22,484;QS=2.95876,0.0412371,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.913101;BQB=1;MQ0F=0 PL:DP:DV 0,22,234,36,237,239:13:1 0,15,144,15,144,144:5:0 0,9,94,9,94,94:3:0 +X 3060 . G <*> 0 . DP=24;I16=9,10,0,0,578,19136,0,0,1109,65641,0,0,324,6992,0,0;QS=3,0;MQSB=0.920044;MQ0F=0 PL:DP:DV 0,33,221:11:0 0,12,121:4:0 0,12,116:4:0 +X 3061 . C <*> 0 . DP=24;I16=9,15,0,0,770,25918,0,0,1378,80882,0,0,446,10136,0,0;QS=3,0;MQSB=0.984127;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,138:5:0 0,15,145:5:0 +X 3062 . C <*> 0 . DP=23;I16=9,13,0,0,727,25019,0,0,1289,76441,0,0,419,9551,0,0;QS=3,0;MQSB=0.910098;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,137:5:0 0,15,134:5:0 +X 3063 . C <*> 0 . DP=23;I16=9,13,0,0,651,21695,0,0,1258,73682,0,0,415,9511,0,0;QS=3,0;MQSB=0.991121;MQ0F=0 PL:DP:DV 0,36,233:12:0 0,15,130:5:0 0,15,133:5:0 +X 3064 . A <*> 0 . DP=23;I16=9,12,0,0,691,24125,0,0,1198,70082,0,0,385,8815,0,0;QS=3,0;MQSB=0.994334;MQ0F=0 PL:DP:DV 0,36,254:12:0 0,12,118:4:0 0,15,144:5:0 +X 3065 . G <*> 0 . DP=22;I16=7,14,0,0,653,21733,0,0,1198,70082,0,0,426,9986,0,0;QS=3,0;MQSB=0.966484;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,109:4:0 0,12,118:4:0 +X 3066 . A <*> 0 . DP=21;I16=7,10,0,0,501,16143,0,0,989,58441,0,0,326,7598,0,0;QS=3,0;MQSB=0.887766;MQ0F=0 PL:DP:DV 0,27,202:9:0 0,12,109:4:0 0,12,104:4:0 +X 3067 . T <*> 0 . DP=21;I16=7,12,0,0,535,16779,0,0,1078,62882,0,0,373,8787,0,0;QS=3,0;MQSB=0.977926;MQ0F=0 PL:DP:DV 0,36,223:12:0 0,9,82:3:0 0,12,103:4:0 +X 3068 . G <*> 0 . DP=20;I16=7,12,0,0,645,22781,0,0,1109,65641,0,0,396,9312,0,0;QS=3,0;MQSB=0.879351;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,115:4:0 0,9,84:3:0 +X 3069 . G <*> 0 . DP=20;I16=7,10,0,0,468,14412,0,0,989,58441,0,0,346,8070,0,0;QS=3,0;MQSB=0.887766;MQ0F=0 PL:DP:DV 0,33,203:11:0 0,12,102:4:0 0,6,57:2:0 +X 3070 . C <*> 0 . DP=20;I16=6,13,0,0,627,22135,0,0,1078,62882,0,0,414,9878,0,0;QS=3,0;MQSB=0.953977;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,98:3:0 0,9,98:3:0 +X 3071 . C <*> 0 . DP=20;I16=7,13,0,0,715,26563,0,0,1138,66482,0,0,419,9893,0,0;QS=3,0;MQSB=0.972138;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,123:4:0 0,9,98:3:0 +X 3072 . C <*> 0 . DP=20;I16=6,13,0,0,696,25784,0,0,1109,65641,0,0,414,9866,0,0;QS=3,0;MQSB=0.965977;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,128:4:0 0,9,106:3:0 +X 3073 . C <*> 0 . DP=20;I16=6,13,0,0,706,26822,0,0,1109,65641,0,0,414,9872,0,0;QS=3,0;MQSB=0.965977;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,135:4:0 0,9,115:3:0 +X 3074 . C <*> 0 . DP=20;I16=6,13,0,0,724,28052,0,0,1109,65641,0,0,414,9886,0,0;QS=3,0;MQSB=0.965977;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,135:4:0 0,9,116:3:0 +X 3075 . C <*> 0 . DP=21;I16=6,13,0,0,630,21614,0,0,1109,65641,0,0,389,9283,0,0;QS=3,0;MQSB=0.965977;MQ0F=0 PL:DP:DV 0,33,239:11:0 0,15,140:5:0 0,9,94:3:0 +X 3076 . G <*> 0 . DP=21;I16=6,14,0,0,645,21809,0,0,1169,69241,0,0,415,9939,0,0;QS=3,0;MQSB=0.969852;MQ0F=0 PL:DP:DV 0,36,252:12:0 0,15,126:5:0 0,9,91:3:0 +X 3077 . C <*> 0 . DP=20;I16=5,15,0,0,694,25228,0,0,1169,69241,0,0,417,9979,0,0;QS=3,0;MQSB=0.976472;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,116:4:0 0,9,111:3:0 +X 3078 . C <*> 0 . DP=20;I16=5,15,0,0,767,29761,0,0,1169,69241,0,0,420,10028,0,0;QS=3,0;MQSB=0.976472;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,113:4:0 0,9,111:3:0 +X 3079 . T <*> 0 . DP=20;I16=5,15,0,0,749,28479,0,0,1169,69241,0,0,422,10038,0,0;QS=3,0;MQSB=0.976472;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,119:4:0 0,9,116:3:0 +X 3080 . G <*> 0 . DP=21;I16=6,15,0,0,785,29901,0,0,1229,72841,0,0,424,10060,0,0;QS=3,0;MQSB=0.973096;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,124:4:0 0,9,103:3:0 +X 3081 . C <*> 0 . DP=21;I16=6,15,0,0,752,27438,0,0,1229,72841,0,0,425,9997,0,0;QS=3,0;MQSB=0.973096;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,118:4:0 0,9,92:3:0 +X 3082 . C <*> 0 . DP=21;I16=6,15,0,0,787,30211,0,0,1229,72841,0,0,426,9952,0,0;QS=3,0;MQSB=0.973096;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,118:4:0 0,9,112:3:0 +X 3083 . T C,<*> 0 . DP=21;I16=6,14,0,1,764,29458,33,1089,1169,69241,60,3600,401,9249,25,625;QS=2.93666,0.0633397,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.973096;BQB=1;MQ0F=0 PL:DP:DV 0,9,255,39,255,255:14:1 0,12,130,12,130,130:4:0 0,9,113,9,113,113:3:0 +X 3084 . G <*> 0 . DP=23;I16=6,17,0,0,859,32755,0,0,1349,80041,0,0,426,9812,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,118:4:0 0,12,135:4:0 +X 3085 . T <*> 0 . DP=23;I16=6,16,0,0,824,31132,0,0,1289,76441,0,0,426,9718,0,0;QS=3,0;MQSB=0.97584;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,124:4:0 0,12,135:4:0 +X 3086 . G <*> 0 . DP=23;I16=6,17,0,0,853,32429,0,0,1349,80041,0,0,428,9648,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,125:4:0 0,12,131:4:0 +X 3087 . G <*> 0 . DP=23;I16=6,17,0,0,897,35253,0,0,1349,80041,0,0,429,9599,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,130:4:0 0,12,137:4:0 +X 3088 . A <*> 0 . DP=22;I16=6,16,0,0,834,31738,0,0,1289,76441,0,0,431,9571,0,0;QS=3,0;MQSB=0.97584;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,110:3:0 0,12,135:4:0 +X 3089 . A <*> 0 . DP=23;I16=7,16,0,0,919,36903,0,0,1349,80041,0,0,432,9514,0,0;QS=3,0;MQSB=0.973027;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,113:3:0 0,15,175:5:0 +X 3090 . G <*> 0 . DP=23;I16=7,16,0,0,885,34349,0,0,1349,80041,0,0,433,9431,0,0;QS=3,0;MQSB=0.973027;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,103:3:0 0,15,160:5:0 +X 3091 . T <*> 0 . DP=23;I16=7,16,0,0,840,31352,0,0,1349,80041,0,0,434,9374,0,0;QS=3,0;MQSB=0.973027;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,105:3:0 0,15,153:5:0 +X 3092 . T <*> 0 . DP=24;I16=8,16,0,0,895,33673,0,0,1409,83641,0,0,434,9294,0,0;QS=3,0;MQSB=0.970446;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,109:3:0 0,15,165:5:0 +X 3093 . G <*> 0 . DP=25;I16=9,16,0,0,955,37033,0,0,1469,87241,0,0,434,9192,0,0;QS=3,0;MQSB=0.968069;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,133:4:0 0,15,157:5:0 +X 3094 . A <*> 0 . DP=25;I16=9,15,0,0,891,33319,0,0,1409,83641,0,0,425,9019,0,0;QS=3,0;MQSB=0.96464;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,134:4:0 0,15,161:5:0 +X 3095 . C <*> 0 . DP=25;I16=9,15,0,0,891,33469,0,0,1409,83641,0,0,425,8955,0,0;QS=3,0;MQSB=0.96464;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,131:4:0 0,15,163:5:0 +X 3096 . C <*> 0 . DP=25;I16=9,16,0,0,952,36626,0,0,1469,87241,0,0,436,9014,0,0;QS=3,0;MQSB=0.968069;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,121:4:0 0,15,167:5:0 +X 3097 . A <*> 0 . DP=25;I16=9,16,0,0,972,38200,0,0,1469,87241,0,0,436,8984,0,0;QS=3,0;MQSB=0.968069;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,144:4:0 0,15,174:5:0 +X 3098 . G <*> 0 . DP=25;I16=9,16,0,0,959,37269,0,0,1469,87241,0,0,436,8986,0,0;QS=3,0;MQSB=0.968069;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,134:4:0 0,15,166:5:0 +X 3099 . A <*> 0 . DP=25;I16=9,16,0,0,888,32632,0,0,1469,87241,0,0,435,8971,0,0;QS=3,0;MQSB=0.968069;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,124:4:0 0,15,165:5:0 +X 3100 . C <*> 0 . DP=25;I16=9,16,0,0,870,31084,0,0,1469,87241,0,0,434,8990,0,0;QS=3,0;MQSB=0.968069;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,126:4:0 0,15,159:5:0 +X 3101 . C <*> 0 . DP=25;I16=9,16,0,0,960,37090,0,0,1469,87241,0,0,432,8992,0,0;QS=3,0;MQSB=0.968069;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,134:4:0 0,15,161:5:0 +X 3102 . A <*> 0 . DP=26;I16=10,16,0,0,952,35186,0,0,1529,90841,0,0,430,9026,0,0;QS=3,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,134:4:0 0,18,189:6:0 +X 3103 . T <*> 0 . DP=26;I16=10,16,0,0,920,33094,0,0,1529,90841,0,0,427,8993,0,0;QS=3,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,131:4:0 0,18,187:6:0 +X 3104 . C T,<*> 0 . DP=25;I16=8,15,2,0,900,35584,80,3202,1349,80041,120,7200,385,8143,40,850;QS=2.58763,0.412371,0;VDB=0.8;SGB=0.346553;RPB=0.717391;MQB=0.956522;MQSB=0.962269;BQB=0.978261;MQ0F=0 PL:DP:DV 0,48,255,48,255,255:16:0 0,12,144,12,144,144:4:0 59,0,93,68,99,157:5:2 +X 3105 . T <*> 0 . DP=25;I16=10,15,0,0,959,37057,0,0,1469,87241,0,0,422,8976,0,0;QS=3,0;MQSB=0.962269;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,149:4:0 0,15,169:5:0 +X 3106 . G <*> 0 . DP=23;I16=10,13,0,0,881,33891,0,0,1380,82800,0,0,420,8940,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,132:4:0 0,15,167:5:0 +X 3107 . T <*> 0 . DP=24;I16=10,14,0,0,878,32496,0,0,1440,86400,0,0,418,8932,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,132:4:0 0,18,195:6:0 +X 3108 . C <*> 0 . DP=24;I16=10,14,0,0,909,34897,0,0,1440,86400,0,0,417,8953,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,137:4:0 0,18,189:6:0 +X 3109 . A <*> 0 . DP=24;I16=10,14,0,0,905,34249,0,0,1440,86400,0,0,416,9004,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,136:4:0 0,18,195:6:0 +X 3110 . C <*> 0 . DP=24;I16=10,13,0,0,919,37099,0,0,1380,82800,0,0,413,8933,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,105:3:0 0,18,189:6:0 +X 3111 . A <*> 0 . DP=25;I16=10,14,0,0,961,38943,0,0,1440,86400,0,0,410,8888,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,111:3:0 0,18,205:6:0 +X 3112 . G <*> 0 . DP=25;I16=10,14,0,0,958,39370,0,0,1440,86400,0,0,407,8821,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,116:3:0 0,18,191:6:0 +X 3113 . C <*> 0 . DP=25;I16=10,14,0,0,961,39641,0,0,1440,86400,0,0,403,8735,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,112:3:0 0,18,193:6:0 +X 3114 . A <*> 0 . DP=24;I16=10,13,0,0,928,38448,0,0,1380,82800,0,0,400,8680,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,116:3:0 0,18,200:6:0 +X 3115 . G <*> 0 . DP=23;I16=10,12,0,0,872,35800,0,0,1320,79200,0,0,397,8603,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,117:3:0 0,18,195:6:0 +X 3116 . G <*> 0 . DP=23;I16=10,12,0,0,870,35372,0,0,1320,79200,0,0,394,8552,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,108:3:0 0,18,194:6:0 +X 3117 . T <*> 0 . DP=22;I16=9,13,0,0,771,27537,0,0,1320,79200,0,0,399,8575,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,96:3:0 0,18,177:6:0 +X 3118 . A <*> 0 . DP=22;I16=9,13,0,0,813,30285,0,0,1320,79200,0,0,397,8537,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,111:3:0 0,18,193:6:0 +X 3119 . A <*> 0 . DP=22;I16=9,13,0,0,886,35954,0,0,1320,79200,0,0,393,8423,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,120:3:0 0,18,207:6:0 +X 3120 . G <*> 0 . DP=22;I16=9,13,0,0,839,32281,0,0,1320,79200,0,0,389,8333,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,104:3:0 0,18,182:6:0 +X 3121 . A <*> 0 . DP=22;I16=10,12,0,0,777,28399,0,0,1320,79200,0,0,386,8266,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,111:3:0 0,18,194:6:0 +X 3122 . C <*> 0 . DP=22;I16=10,12,0,0,848,33002,0,0,1320,79200,0,0,384,8222,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,110:3:0 0,18,192:6:0 +X 3123 . T <*> 0 . DP=22;I16=10,12,0,0,854,33456,0,0,1320,79200,0,0,382,8202,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,114:3:0 0,18,204:6:0 +X 3124 . C <*> 0 . DP=22;I16=10,11,0,0,882,38286,0,0,1260,75600,0,0,381,8205,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,104:3:0 0,15,178:5:0 +X 3125 . T <*> 0 . DP=22;I16=10,11,0,0,860,36764,0,0,1260,75600,0,0,380,8230,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,106:3:0 0,15,185:5:0 +X 3126 . G <*> 0 . DP=22;I16=10,11,0,0,834,34998,0,0,1260,75600,0,0,379,8277,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,97:3:0 0,15,174:5:0 +X 3127 . C <*> 0 . DP=23;I16=10,11,0,0,847,36381,0,0,1260,75600,0,0,378,8346,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,87:3:0 0,15,175:5:0 +X 3128 . T <*> 0 . DP=22;I16=9,12,0,0,850,35972,0,0,1229,72841,0,0,402,9010,0,0;QS=3,0;MQSB=0.950149;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,107:3:0 0,15,182:5:0 +X 3129 . T <*> 0 . DP=22;I16=9,12,0,0,809,32621,0,0,1229,72841,0,0,401,9067,0,0;QS=3,0;MQSB=0.950149;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,107:3:0 0,15,178:5:0 +X 3130 . T <*> 0 . DP=21;I16=9,10,0,0,744,30322,0,0,1140,68400,0,0,376,8516,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,82:2:0 0,15,169:5:0 +X 3131 . C <*> 0 . DP=21;I16=9,10,0,0,792,34778,0,0,1140,68400,0,0,376,8606,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,83:2:0 0,15,170:5:0 +X 3132 . T <*> 0 . DP=21;I16=9,11,0,0,819,35197,0,0,1169,69241,0,0,400,9288,0,0;QS=3,0;MQSB=0.943233;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,109:3:0 0,15,174:5:0 +X 3133 . G <*> 0 . DP=21;I16=9,11,0,0,800,34016,0,0,1169,69241,0,0,398,9312,0,0;QS=3,0;MQSB=0.943233;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,97:3:0 0,15,166:5:0 +X 3134 . G <*> 0 . DP=22;I16=10,11,0,0,773,30227,0,0,1229,72841,0,0,396,9352,0,0;QS=3,0;MQSB=0.939898;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,97:3:0 0,15,163:5:0 +X 3135 . G <*> 0 . DP=22;I16=9,12,0,0,812,33714,0,0,1229,72841,0,0,396,9408,0,0;QS=3,0;MQSB=0.950149;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,94:3:0 0,12,151:4:0 +X 3136 . C <*> 0 . DP=22;I16=9,12,0,0,811,33469,0,0,1229,72841,0,0,396,9430,0,0;QS=3,0;MQSB=0.950149;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,102:3:0 0,12,140:4:0 +X 3137 . A <*> 0 . DP=22;I16=10,11,0,0,786,31226,0,0,1229,72841,0,0,396,9416,0,0;QS=3,0;MQSB=0.939898;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,95:3:0 0,12,142:4:0 +X 3138 . A <*> 0 . DP=21;I16=9,11,0,0,720,28200,0,0,1169,69241,0,0,398,9414,0,0;QS=3,0;MQSB=0.943233;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,98:3:0 0,12,147:4:0 +X 3139 . C <*> 0 . DP=21;I16=9,11,0,0,755,31433,0,0,1169,69241,0,0,400,9424,0,0;QS=3,0;MQSB=0.943233;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,91:3:0 0,12,139:4:0 +X 3140 . C <*> 0 . DP=21;I16=9,11,0,0,790,33238,0,0,1169,69241,0,0,402,9446,0,0;QS=3,0;MQSB=0.943233;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,102:3:0 0,12,145:4:0 +X 3141 . C <*> 0 . DP=21;I16=9,11,0,0,819,35401,0,0,1169,69241,0,0,404,9480,0,0;QS=3,0;MQSB=0.943233;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,101:3:0 0,12,150:4:0 +X 3142 . A <*> 0 . DP=21;I16=9,11,0,0,822,35744,0,0,1169,69241,0,0,405,9477,0,0;QS=3,0;MQSB=0.943233;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,107:3:0 0,12,155:4:0 +X 3143 . G <*> 0 . DP=22;I16=10,11,0,0,846,36468,0,0,1198,70082,0,0,406,9488,0,0;QS=3,0;MQSB=0.99938;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,104:3:0 0,12,151:4:0 +X 3144 . C <*> 0 . DP=23;I16=12,10,0,0,855,35905,0,0,1258,73682,0,0,409,9513,0,0;QS=3,0;MQSB=0.997828;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,104:3:0 0,15,165:5:0 +X 3145 . A <*> 0 . DP=23;I16=12,10,0,0,869,35937,0,0,1258,73682,0,0,414,9554,0,0;QS=3,0;MQSB=0.997828;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,106:3:0 0,15,174:5:0 +X 3146 . G <*> 0 . DP=23;I16=12,10,0,0,895,38345,0,0,1258,73682,0,0,419,9613,0,0;QS=3,0;MQSB=0.997828;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,105:3:0 0,15,179:5:0 +X 3147 . G <*> 0 . DP=24;I16=11,11,0,0,851,34815,0,0,1289,76441,0,0,419,9623,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,123:4:0 0,15,172:5:0 +X 3148 . T <*> 0 . DP=24;I16=12,11,0,0,795,30097,0,0,1318,77282,0,0,428,9682,0,0;QS=3,0;MQSB=0.999527;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,107:4:0 0,15,149:5:0 +X 3149 . G <*> 0 . DP=24;I16=12,11,0,0,910,38142,0,0,1318,77282,0,0,433,9743,0,0;QS=3,0;MQSB=0.999527;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,120:4:0 0,15,167:5:0 +X 3150 . A <*> 0 . DP=24;I16=12,11,0,0,854,33784,0,0,1318,77282,0,0,438,9822,0,0;QS=3,0;MQSB=0.999527;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,129:4:0 0,15,167:5:0 +X 3151 . C <*> 0 . DP=24;I16=12,11,0,0,873,35315,0,0,1318,77282,0,0,442,9870,0,0;QS=3,0;MQSB=0.999527;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,125:4:0 0,15,163:5:0 +X 3152 . C <*> 0 . DP=24;I16=12,11,0,0,857,34239,0,0,1318,77282,0,0,445,9889,0,0;QS=3,0;MQSB=0.999527;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,123:4:0 0,15,155:5:0 +X 3153 . C <*> 0 . DP=24;I16=12,11,0,0,891,36711,0,0,1318,77282,0,0,448,9930,0,0;QS=3,0;MQSB=0.999527;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,125:4:0 0,15,166:5:0 +X 3154 . T <*> 0 . DP=25;I16=13,11,0,0,938,38052,0,0,1378,80882,0,0,451,9993,0,0;QS=3,0;MQSB=0.998323;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,133:4:0 0,18,194:6:0 +X 3155 . G <*> 0 . DP=25;I16=13,11,0,0,953,39423,0,0,1378,80882,0,0,454,10030,0,0;QS=3,0;MQSB=0.998323;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,127:4:0 0,18,180:6:0 +X 3156 . G <*> 0 . DP=25;I16=13,11,0,0,946,38818,0,0,1378,80882,0,0,457,10093,0,0;QS=3,0;MQSB=0.998323;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,126:4:0 0,18,189:6:0 +X 3157 . A <*> 0 . DP=24;I16=12,12,0,0,896,33648,0,0,1378,80882,0,0,486,10806,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,130:4:0 0,18,193:6:0 +X 3158 . A <*> 0 . DP=24;I16=12,12,0,0,856,31670,0,0,1378,80882,0,0,490,10918,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,125:4:0 0,18,192:6:0 +X 3159 . T <*> 0 . DP=24;I16=11,12,0,0,864,32952,0,0,1349,80041,0,0,477,10749,0,0;QS=3,0;MQSB=0.944319;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,134:4:0 0,18,194:6:0 +X 3160 . T <*> 0 . DP=24;I16=12,12,0,0,907,34719,0,0,1378,80882,0,0,494,11018,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,134:4:0 0,18,193:6:0 +X 3161 . C <*> 0 . DP=24;I16=12,12,0,0,880,33336,0,0,1378,80882,0,0,494,11006,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,123:4:0 0,18,196:6:0 +X 3162 . C <*> 0 . DP=24;I16=12,12,0,0,916,35764,0,0,1378,80882,0,0,494,11018,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,127:4:0 0,18,188:6:0 +X 3163 . T A,<*> 0 . DP=24;I16=11,12,1,0,895,35099,13,169,1349,80041,29,841,473,10603,20,400;QS=2.97436,0.025641,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=1;BQB=1;MQ0F=0 PL:DP:DV 0,28,255,39,255,255:14:1 0,12,137,12,137,137:4:0 0,18,200,18,200,200:6:0 +X 3164 . G <*> 0 . DP=24;I16=12,11,0,0,887,34437,0,0,1349,80041,0,0,467,10385,0,0;QS=3,0;MQSB=0.944319;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,106:3:0 0,18,188:6:0 +X 3165 . T <*> 0 . DP=24;I16=12,12,0,0,880,32654,0,0,1378,80882,0,0,490,10990,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,133:4:0 0,18,189:6:0 +X 3166 . C <*> 0 . DP=24;I16=12,11,0,0,871,33389,0,0,1349,80041,0,0,463,10369,0,0;QS=3,0;MQSB=0.944319;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,111:3:0 0,18,193:6:0 +X 3167 . C <*> 0 . DP=23;I16=12,11,0,0,879,34199,0,0,1318,77282,0,0,487,11021,0,0;QS=3,0;MQSB=0.999527;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,131:4:0 0,18,189:6:0 +X 3168 . A <*> 0 . DP=23;I16=12,11,0,0,874,33294,0,0,1318,77282,0,0,486,11070,0,0;QS=3,0;MQSB=0.999527;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,125:4:0 0,18,192:6:0 +X 3169 . T <*> 0 . DP=23;I16=11,11,0,0,824,31124,0,0,1289,76441,0,0,458,10416,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,128:4:0 0,18,187:6:0 +X 3170 . C <*> 0 . DP=23;I16=11,11,0,0,877,35167,0,0,1289,76441,0,0,453,10307,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,129:4:0 0,18,201:6:0 +X 3171 . T <*> 0 . DP=23;I16=11,11,0,0,843,32615,0,0,1289,76441,0,0,448,10216,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,127:4:0 0,18,201:6:0 +X 3172 . G <*> 0 . DP=23;I16=12,11,0,0,813,29605,0,0,1318,77282,0,0,468,10768,0,0;QS=3,0;MQSB=0.999527;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,120:4:0 0,18,176:6:0 +X 3173 . G <*> 0 . DP=23;I16=11,11,0,0,801,29659,0,0,1289,76441,0,0,436,9988,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,126:4:0 0,18,174:6:0 +X 3174 . C <*> 0 . DP=24;I16=13,11,0,0,938,36926,0,0,1378,80882,0,0,454,10476,0,0;QS=3,0;MQSB=0.998323;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,127:4:0 0,18,194:6:0 +X 3175 . A <*> 0 . DP=25;I16=13,11,0,0,914,35230,0,0,1409,83641,0,0,422,9684,0,0;QS=3,0;MQSB=0.931547;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,127:4:0 0,21,209:7:0 +X 3176 . G <*> 0 . DP=24;I16=14,10,0,0,909,34913,0,0,1378,80882,0,0,442,10164,0,0;QS=3,0;MQSB=0.993166;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,97:3:0 0,21,205:7:0 +X 3177 . G <*> 0 . DP=23;I16=14,9,0,0,793,28159,0,0,1318,77282,0,0,438,10040,0,0;QS=3,0;MQSB=0.987676;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,93:3:0 0,21,195:7:0 +X 3178 . T <*> 0 . DP=23;I16=13,9,0,0,754,26290,0,0,1289,76441,0,0,408,9262,0,0;QS=3,0;MQSB=0.910098;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,96:3:0 0,21,173:7:0 +X 3179 . G <*> 0 . DP=23;I16=13,9,0,0,802,29686,0,0,1289,76441,0,0,403,9131,0,0;QS=3,0;MQSB=0.910098;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,97:3:0 0,21,188:7:0 +X 3180 . G <*> 0 . DP=22;I16=12,9,0,0,701,24107,0,0,1229,72841,0,0,398,8970,0,0;QS=3,0;MQSB=0.913101;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,92:3:0 0,21,175:7:0 +X 3181 . G <*> 0 . DP=22;I16=13,9,0,0,795,29503,0,0,1258,73682,0,0,418,9452,0,0;QS=3,0;MQSB=0.991121;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,99:3:0 0,21,193:7:0 +X 3182 . C <*> 0 . DP=22;I16=12,9,0,0,772,28878,0,0,1198,70082,0,0,396,9038,0,0;QS=3,0;MQSB=0.994334;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,99:3:0 0,21,184:7:0 +X 3183 . A <*> 0 . DP=22;I16=12,9,0,0,766,28304,0,0,1229,72841,0,0,382,8546,0,0;QS=3,0;MQSB=0.913101;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,106:3:0 0,21,193:7:0 +X 3184 . T <*> 0 . DP=21;I16=12,8,0,0,721,26533,0,0,1169,69241,0,0,377,8409,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,30,248:10:0 0,9,106:3:0 0,21,196:7:0 +X 3185 . T <*> 0 . DP=20;I16=13,7,0,0,740,27660,0,0,1138,66482,0,0,397,8865,0,0;QS=3,0;MQSB=0.972138;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,103:3:0 0,18,174:6:0 +X 3186 . G <*> 0 . DP=20;I16=13,7,0,0,741,28311,0,0,1138,66482,0,0,391,8665,0,0;QS=3,0;MQSB=0.972138;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,103:3:0 0,18,169:6:0 +X 3187 . A <*> 0 . DP=20;I16=13,7,0,0,693,24927,0,0,1138,66482,0,0,385,8485,0,0;QS=3,0;MQSB=0.972138;MQ0F=0 PL:DP:DV 0,33,247:11:0 0,9,102:3:0 0,18,171:6:0 +X 3188 . A <*> 0 . DP=20;I16=13,7,0,0,704,25746,0,0,1138,66482,0,0,379,8325,0,0;QS=3,0;MQSB=0.972138;MQ0F=0 PL:DP:DV 0,33,249:11:0 0,9,100:3:0 0,18,174:6:0 +X 3189 . A <*> 0 . DP=21;I16=13,8,0,0,763,28171,0,0,1198,70082,0,0,373,8185,0,0;QS=3,0;MQSB=0.983744;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,125:4:0 0,18,174:6:0 +X 3190 . C <*> 0 . DP=20;I16=11,8,0,0,675,24915,0,0,1109,65641,0,0,344,7440,0,0;QS=3,0;MQSB=0.902014;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,123:4:0 0,15,148:5:0 +X 3191 . T <*> 0 . DP=21;I16=11,9,0,0,773,30203,0,0,1169,69241,0,0,340,7340,0,0;QS=3,0;MQSB=0.916401;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,130:4:0 0,15,171:5:0 +X 3192 . G <*> 0 . DP=21;I16=12,9,0,0,751,27785,0,0,1198,70082,0,0,362,7886,0,0;QS=3,0;MQSB=0.994334;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,125:4:0 0,15,152:5:0 +X 3193 . G <*> 0 . DP=21;I16=12,9,0,0,756,27614,0,0,1198,70082,0,0,359,7829,0,0;QS=3,0;MQSB=0.994334;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,121:4:0 0,15,148:5:0 +X 3194 . T C,<*> 0 . DP=21;I16=10,10,1,0,730,26992,18,324,1169,69241,29,841,332,7168,25,625;QS=2.95652,0.0434783,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.99938;BQB=1;MQ0F=0 PL:DP:DV 0,18,255,33,255,255:12:1 0,9,98,9,98,98:3:0 0,18,178,18,178,178:6:0 +X 3195 . T <*> 0 . DP=21;I16=11,10,0,0,776,29184,0,0,1198,70082,0,0,356,7778,0,0;QS=3,0;MQSB=0.99938;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,95:3:0 0,18,189:6:0 +X 3196 . T <*> 0 . DP=21;I16=10,10,0,0,722,26472,0,0,1169,69241,0,0,329,7111,0,0;QS=3,0;MQSB=0.931063;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,91:3:0 0,18,186:6:0 +X 3197 . A <*> 0 . DP=22;I16=12,9,0,0,715,24911,0,0,1229,72841,0,0,352,7718,0,0;QS=3,0;MQSB=0.950149;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,103:3:0 0,18,179:6:0 +X 3198 . A <*> 0 . DP=21;I16=12,8,0,0,745,28155,0,0,1169,69241,0,0,345,7675,0,0;QS=3,0;MQSB=0.953497;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,105:3:0 0,18,198:6:0 +X 3199 . A <*> 0 . DP=21;I16=11,9,0,0,736,27514,0,0,1200,72000,0,0,326,7080,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,105:3:0 0,18,196:6:0 +X 3200 . A <*> 0 . DP=20;I16=11,9,0,0,735,27533,0,0,1169,69241,0,0,350,7660,0,0;QS=3,0;MQSB=0.943233;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,108:3:0 0,18,195:6:0 +X 3201 . A <*> 0 . DP=20;I16=11,8,0,0,706,26814,0,0,1109,65641,0,0,338,7486,0,0;QS=3,0;MQSB=0.946915;MQ0F=0 PL:DP:DV 0,30,248:10:0 0,9,107:3:0 0,18,198:6:0 +X 3202 . T <*> 0 . DP=20;I16=10,9,0,0,692,25620,0,0,1140,68400,0,0,321,6907,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,249:10:0 0,9,109:3:0 0,18,187:6:0 +X 3203 . G A,<*> 0 . DP=19;I16=9,9,1,0,644,23760,19,361,1080,64800,29,841,320,6872,25,625;QS=2.94823,0.0517711,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.934728;BQB=1;MQ0F=0 PL:DP:DV 0,14,239,30,242,248:11:1 0,9,105,9,105,105:3:0 0,15,160,15,160,160:5:0 +X 3204 . T <*> 0 . DP=19;I16=9,8,0,0,619,22955,0,0,1020,61200,0,0,306,6686,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,234:9:0 0,9,101:3:0 0,15,169:5:0 +X 3205 . C <*> 0 . DP=19;I16=9,9,0,0,672,25340,0,0,1080,64800,0,0,318,6856,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,99:3:0 0,15,157:5:0 +X 3206 . A <*> 0 . DP=19;I16=10,9,0,0,661,23623,0,0,1109,65641,0,0,342,7500,0,0;QS=3,0;MQSB=0.934728;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,91:3:0 0,15,165:5:0 +X 3207 . C <*> 0 . DP=19;I16=9,9,0,0,642,23618,0,0,1080,64800,0,0,316,6912,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,90:3:0 0,15,158:5:0 +X 3208 . A <*> 0 . DP=18;I16=10,8,0,0,619,22023,0,0,1049,62041,0,0,341,7591,0,0;QS=3,0;MQSB=0.938795;MQ0F=0 PL:DP:DV 0,33,247:11:0 0,9,95:3:0 0,12,142:4:0 +X 3209 . C <*> 0 . DP=19;I16=11,8,0,0,681,24747,0,0,1109,65641,0,0,340,7612,0,0;QS=3,0;MQSB=0.946915;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,106:3:0 0,12,134:4:0 +X 3210 . C <*> 0 . DP=18;I16=11,7,0,0,664,24900,0,0,1049,62041,0,0,340,7602,0,0;QS=3,0;MQSB=0.951002;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,101:3:0 0,12,141:4:0 +X 3211 . A <*> 0 . DP=17;I16=11,6,0,0,645,24627,0,0,989,58441,0,0,341,7611,0,0;QS=3,0;MQSB=0.955563;MQ0F=0 PL:DP:DV 0,30,243:10:0 0,9,106:3:0 0,12,140:4:0 +X 3212 . T <*> 0 . DP=17;I16=10,6,0,0,575,21295,0,0,960,57600,0,0,316,6964,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,222:9:0 0,9,100:3:0 0,12,144:4:0 +X 3213 . A <*> 0 . DP=17;I16=10,6,0,0,597,22631,0,0,960,57600,0,0,316,6962,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,228:9:0 0,9,117:3:0 0,12,138:4:0 +X 3214 . G <*> 0 . DP=17;I16=11,6,0,0,615,23103,0,0,989,58441,0,0,341,7605,0,0;QS=3,0;MQSB=0.955563;MQ0F=0 PL:DP:DV 0,30,243:10:0 0,9,110:3:0 0,12,134:4:0 +X 3215 . G <*> 0 . DP=17;I16=11,6,0,0,591,21523,0,0,989,58441,0,0,340,7592,0,0;QS=3,0;MQSB=0.955563;MQ0F=0 PL:DP:DV 0,30,241:10:0 0,9,93:3:0 0,12,128:4:0 +X 3216 . C <*> 0 . DP=17;I16=11,6,0,0,623,23303,0,0,989,58441,0,0,339,7597,0,0;QS=3,0;MQSB=0.955563;MQ0F=0 PL:DP:DV 0,30,242:10:0 0,9,94:3:0 0,12,138:4:0 +X 3217 . C <*> 0 . DP=17;I16=11,6,0,0,570,19896,0,0,989,58441,0,0,337,7569,0,0;QS=3,0;MQSB=0.955563;MQ0F=0 PL:DP:DV 0,30,236:10:0 0,9,84:3:0 0,12,123:4:0 +X 3218 . G C,<*> 0 . DP=18;I16=10,7,1,0,547,18185,29,841,1020,61200,29,841,310,6932,24,576;QS=2.91667,0.0833333,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.951002;BQB=1;MQ0F=0 PL:DP:DV 0,4,202,30,205,221:11:1 0,9,96,9,96,96:3:0 0,12,112,12,112,112:4:0 +X 3219 . G A,<*> 0 . DP=18;I16=10,7,1,0,606,22158,19,361,1020,61200,29,841,308,6888,23,529;QS=2.94837,0.0516304,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.951002;BQB=1;MQ0F=0 PL:DP:DV 0,14,234,30,237,243:11:1 0,9,107,9,107,107:3:0 0,12,126,12,126,126:4:0 +X 3220 . G <*> 0 . DP=18;I16=11,7,0,0,631,22827,0,0,1049,62041,0,0,326,7248,0,0;QS=3,0;MQSB=0.951002;MQ0F=0 PL:DP:DV 0,33,252:11:0 0,9,112:3:0 0,12,126:4:0 +X 3221 . C <*> 0 . DP=17;I16=9,7,0,0,598,22586,0,0,960,57600,0,0,301,6659,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,244:9:0 0,9,103:3:0 0,12,139:4:0 +X 3222 . A <*> 0 . DP=17;I16=10,7,0,0,623,23037,0,0,989,58441,0,0,318,6972,0,0;QS=3,0;MQSB=0.943335;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,100:3:0 0,12,133:4:0 +X 3223 . C <*> 0 . DP=17;I16=10,7,0,0,611,22603,0,0,989,58441,0,0,312,6764,0,0;QS=3,0;MQSB=0.943335;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,96:3:0 0,12,132:4:0 +X 3224 . A <*> 0 . DP=16;I16=10,6,0,0,609,23381,0,0,929,54841,0,0,307,6575,0,0;QS=3,0;MQSB=0.948436;MQ0F=0 PL:DP:DV 0,27,238:9:0 0,9,97:3:0 0,12,141:4:0 +X 3225 . G <*> 0 . DP=17;I16=11,6,0,0,604,22692,0,0,989,58441,0,0,302,6404,0,0;QS=3,0;MQSB=0.955563;MQ0F=0 PL:DP:DV 0,27,247:9:0 0,12,108:4:0 0,12,134:4:0 +X 3226 . T <*> 0 . DP=18;I16=11,6,0,0,582,20466,0,0,1020,61200,0,0,282,5996,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,224:9:0 0,12,112:4:0 0,12,131:4:0 +X 3227 . G <*> 0 . DP=18;I16=12,5,0,0,618,23008,0,0,989,58441,0,0,270,5496,0,0;QS=3,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,91:3:0 0,12,125:4:0 +X 3228 . G <*> 0 . DP=18;I16=11,6,0,0,611,22581,0,0,1020,61200,0,0,278,5816,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,248:9:0 0,12,118:4:0 0,12,121:4:0 +X 3229 . C <*> 0 . DP=19;I16=12,7,0,0,686,25394,0,0,1109,65641,0,0,289,5925,0,0;QS=3,0;MQSB=0.957193;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,118:4:0 0,12,126:4:0 +X 3230 . T <*> 0 . DP=19;I16=12,6,0,0,669,25441,0,0,1049,62041,0,0,261,5187,0,0;QS=3,0;MQSB=0.961295;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,107:3:0 0,12,139:4:0 +X 3231 . C <*> 0 . DP=19;I16=12,7,0,0,682,25046,0,0,1109,65641,0,0,283,5725,0,0;QS=3,0;MQSB=0.957193;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,112:4:0 0,12,128:4:0 +X 3232 . A <*> 0 . DP=19;I16=11,7,0,0,597,20779,0,0,1080,64800,0,0,270,5564,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,229:10:0 0,12,117:4:0 0,12,132:4:0 +X 3233 . C <*> 0 . DP=19;I16=12,7,0,0,573,18239,0,0,1109,65641,0,0,277,5629,0,0;QS=3,0;MQSB=0.957193;MQ0F=0 PL:DP:DV 0,33,238:11:0 0,12,91:4:0 0,12,110:4:0 +X 3234 . G T,<*> 0 . DP=19;I16=10,6,1,0,511,17305,22,484,960,57600,29,841,233,4849,8,64;QS=2.93855,0.0614525,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.955563;BQB=1;MQ0F=0 PL:DP:DV 0,11,222,30,225,234:11:1 0,6,63,6,63,63:2:0 0,12,100,12,100,100:4:0 +X 3235 . C <*> 0 . DP=18;I16=12,6,0,0,625,22649,0,0,1049,62041,0,0,274,5582,0,0;QS=3,0;MQSB=0.961295;MQ0F=0 PL:DP:DV 0,30,249:10:0 0,12,119:4:0 0,12,123:4:0 +X 3236 . C <*> 0 . DP=18;I16=12,6,0,0,668,25124,0,0,1049,62041,0,0,273,5567,0,0;QS=3,0;MQSB=0.961295;MQ0F=0 PL:DP:DV 0,30,244:10:0 0,12,137:4:0 0,12,134:4:0 +X 3237 . T <*> 0 . DP=17;I16=11,6,0,0,589,21235,0,0,989,58441,0,0,273,5573,0,0;QS=3,0;MQSB=0.955563;MQ0F=0 PL:DP:DV 0,27,230:9:0 0,12,102:4:0 0,12,136:4:0 +X 3238 . G <*> 0 . DP=17;I16=11,6,0,0,609,22539,0,0,989,58441,0,0,273,5599,0,0;QS=3,0;MQSB=0.955563;MQ0F=0 PL:DP:DV 0,27,243:9:0 0,12,104:4:0 0,12,129:4:0 +X 3239 . T <*> 0 . DP=17;I16=11,6,0,0,574,20204,0,0,989,58441,0,0,273,5645,0,0;QS=3,0;MQSB=0.955563;MQ0F=0 PL:DP:DV 0,27,220:9:0 0,12,107:4:0 0,12,131:4:0 +X 3240 . A <*> 0 . DP=19;I16=12,7,0,0,624,21552,0,0,1109,65641,0,0,273,5711,0,0;QS=3,0;MQSB=0.957193;MQ0F=0 PL:DP:DV 0,33,248:11:0 0,12,101:4:0 0,12,132:4:0 +X 3241 . A <*> 0 . DP=19;I16=11,6,0,0,619,23121,0,0,1020,61200,0,0,249,5173,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,252:10:0 0,9,96:3:0 0,12,143:4:0 +X 3242 . T <*> 0 . DP=19;I16=12,7,0,0,655,23279,0,0,1140,68400,0,0,277,5911,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,252:10:0 0,12,104:4:0 0,15,152:5:0 +X 3243 . C <*> 0 . DP=19;I16=12,7,0,0,682,25216,0,0,1140,68400,0,0,281,6047,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,111:4:0 0,15,148:5:0 +X 3244 . C <*> 0 . DP=18;I16=11,6,0,0,587,21119,0,0,1020,61200,0,0,281,6139,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,221:8:0 0,12,116:4:0 0,15,142:5:0 +X 3245 . C <*> 0 . DP=17;I16=10,7,0,0,631,23851,0,0,1020,61200,0,0,290,6282,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,12,126:4:0 0,12,131:4:0 +X 3246 . A <*> 0 . DP=17;I16=10,7,0,0,646,24716,0,0,1020,61200,0,0,295,6427,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,12,129:4:0 0,12,139:4:0 +X 3247 . G <*> 0 . DP=17;I16=10,7,0,0,606,22554,0,0,1020,61200,0,0,300,6590,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,12,92:4:0 0,12,133:4:0 +X 3248 . C <*> 0 . DP=16;I16=10,6,0,0,603,23115,0,0,960,57600,0,0,306,6770,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,9,99:3:0 0,12,132:4:0 +X 3249 . C <*> 0 . DP=16;I16=10,6,0,0,587,21913,0,0,960,57600,0,0,311,6917,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,246:9:0 0,9,99:3:0 0,12,133:4:0 +X 3250 . C <*> 0 . DP=16;I16=10,6,0,0,616,24080,0,0,960,57600,0,0,316,7082,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,9,95:3:0 0,12,137:4:0 +X 3251 . T <*> 0 . DP=16;I16=10,6,0,0,585,22193,0,0,960,57600,0,0,319,7165,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,241:9:0 0,9,104:3:0 0,12,135:4:0 +X 3252 . T <*> 0 . DP=16;I16=10,6,0,0,553,19781,0,0,960,57600,0,0,321,7215,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,239:9:0 0,9,84:3:0 0,12,126:4:0 +X 3253 . T <*> 0 . DP=16;I16=10,6,0,0,589,21933,0,0,960,57600,0,0,323,7281,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,245:9:0 0,9,102:3:0 0,12,132:4:0 +X 3254 . G <*> 0 . DP=17;I16=10,7,0,0,631,23737,0,0,1020,61200,0,0,325,7363,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,9,100:3:0 0,15,154:5:0 +X 3255 . G <*> 0 . DP=16;I16=9,7,0,0,554,20088,0,0,960,57600,0,0,328,7410,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,243:9:0 0,9,93:3:0 0,12,120:4:0 +X 3256 . G <*> 0 . DP=16;I16=8,7,0,0,571,21985,0,0,900,54000,0,0,306,6846,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,6,62:2:0 0,12,142:4:0 +X 3257 . A <*> 0 . DP=16;I16=9,7,0,0,585,21881,0,0,960,57600,0,0,334,7546,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,243:9:0 0,9,94:3:0 0,12,144:4:0 +X 3258 . G <*> 0 . DP=17;I16=9,8,0,0,647,25407,0,0,1020,61200,0,0,337,7635,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,81:3:0 0,12,146:4:0 +X 3259 . G <*> 0 . DP=17;I16=9,8,0,0,605,22237,0,0,1020,61200,0,0,341,7739,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,79:3:0 0,12,139:4:0 +X 3260 . C <*> 0 . DP=17;I16=9,7,0,0,616,23908,0,0,960,57600,0,0,319,7183,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,6,64:2:0 0,12,133:4:0 +X 3261 . C <*> 0 . DP=18;I16=9,9,0,0,655,24475,0,0,1080,64800,0,0,347,7891,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,90:3:0 0,12,138:4:0 +X 3262 . A <*> 0 . DP=19;I16=10,9,0,0,712,27036,0,0,1140,68400,0,0,351,7989,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,123:4:0 0,12,148:4:0 +X 3263 . G <*> 0 . DP=19;I16=10,9,0,0,715,27317,0,0,1140,68400,0,0,356,8104,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,116:4:0 0,12,146:4:0 +X 3264 . G <*> 0 . DP=19;I16=10,9,0,0,676,24734,0,0,1140,68400,0,0,361,8237,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,93:4:0 0,12,143:4:0 +X 3265 . G <*> 0 . DP=19;I16=10,9,0,0,701,26199,0,0,1140,68400,0,0,365,8339,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,109:4:0 0,12,137:4:0 +X 3266 . T <*> 0 . DP=19;I16=9,9,0,0,597,20769,0,0,1080,64800,0,0,357,8229,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,82:4:0 0,9,113:3:0 +X 3267 . G <*> 0 . DP=19;I16=10,9,0,0,659,24285,0,0,1140,68400,0,0,367,8299,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,76:4:0 0,12,133:4:0 +X 3268 . G <*> 0 . DP=19;I16=10,9,0,0,668,24306,0,0,1140,68400,0,0,367,8255,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,92:4:0 0,12,142:4:0 +X 3269 . G <*> 0 . DP=19;I16=10,9,0,0,714,27122,0,0,1140,68400,0,0,367,8227,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,115:4:0 0,12,137:4:0 +X 3270 . T <*> 0 . DP=20;I16=10,9,0,0,606,20364,0,0,1140,68400,0,0,361,8141,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,251:11:0 0,12,83:4:0 0,12,136:4:0 +X 3271 . G <*> 0 . DP=19;I16=10,9,0,0,709,26993,0,0,1140,68400,0,0,362,8108,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,100:4:0 0,12,143:4:0 +X 3272 . G <*> 0 . DP=19;I16=10,9,0,0,672,24398,0,0,1140,68400,0,0,363,8093,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,97:4:0 0,12,140:4:0 +X 3273 . A <*> 0 . DP=20;I16=10,10,0,0,735,27355,0,0,1200,72000,0,0,363,8047,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,153:5:0 0,12,147:4:0 +X 3274 . T <*> 0 . DP=19;I16=9,10,0,0,699,26089,0,0,1140,68400,0,0,365,8021,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,142:5:0 0,12,149:4:0 +X 3275 . C <*> 0 . DP=19;I16=9,10,0,0,727,28197,0,0,1140,68400,0,0,367,8015,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,137:5:0 0,12,139:4:0 +X 3276 . A <*> 0 . DP=19;I16=9,10,0,0,681,25123,0,0,1140,68400,0,0,369,8029,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,253:10:0 0,15,150:5:0 0,12,141:4:0 +X 3277 . C <*> 0 . DP=19;I16=9,10,0,0,733,28485,0,0,1140,68400,0,0,371,8063,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,153:5:0 0,12,146:4:0 +X 3278 . T <*> 0 . DP=19;I16=9,10,0,0,737,28901,0,0,1140,68400,0,0,373,8117,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,168:5:0 0,12,153:4:0 +X 3279 . T <*> 0 . DP=19;I16=9,10,0,0,714,27132,0,0,1140,68400,0,0,375,8191,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,148:5:0 0,12,150:4:0 +X 3280 . G <*> 0 . DP=20;I16=9,11,0,0,758,29178,0,0,1200,72000,0,0,376,8234,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,143:5:0 0,12,146:4:0 +X 3281 . A <*> 0 . DP=21;I16=10,11,0,0,822,32654,0,0,1260,75600,0,0,378,8296,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,179:6:0 0,12,157:4:0 +X 3282 . G <*> 0 . DP=21;I16=10,11,0,0,815,32059,0,0,1260,75600,0,0,381,8379,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,173:6:0 0,12,150:4:0 +X 3283 . G <*> 0 . DP=21;I16=10,11,0,0,790,30110,0,0,1260,75600,0,0,384,8484,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,161:6:0 0,12,146:4:0 +X 3284 . T <*> 0 . DP=21;I16=10,11,0,0,748,27628,0,0,1260,75600,0,0,385,8511,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,155:6:0 0,12,146:4:0 +X 3285 . C <*> 0 . DP=21;I16=10,11,0,0,776,29442,0,0,1260,75600,0,0,386,8560,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,169:6:0 0,12,143:4:0 +X 3286 . A <*> 0 . DP=21;I16=10,11,0,0,826,32732,0,0,1260,75600,0,0,387,8631,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,187:6:0 0,12,153:4:0 +X 3287 . G <*> 0 . DP=21;I16=10,11,0,0,804,31448,0,0,1260,75600,0,0,387,8673,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,164:6:0 0,12,150:4:0 +X 3288 . G <*> 0 . DP=22;I16=10,11,0,0,754,27862,0,0,1260,75600,0,0,379,8635,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,141:5:0 0,15,164:5:0 +X 3289 . A <*> 0 . DP=24;I16=13,11,0,0,897,34439,0,0,1440,86400,0,0,386,8714,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,166:6:0 0,15,178:5:0 +X 3290 . G <*> 0 . DP=23;I16=12,10,0,0,832,31964,0,0,1320,79200,0,0,380,8684,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,112:4:0 0,15,168:5:0 +X 3291 . T <*> 0 . DP=22;I16=11,9,0,0,707,25481,0,0,1200,72000,0,0,358,8112,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,95:3:0 0,15,168:5:0 +X 3292 . T <*> 0 . DP=22;I16=13,9,0,0,783,28439,0,0,1320,79200,0,0,397,8929,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,127:5:0 0,15,164:5:0 +X 3293 . C <*> 0 . DP=22;I16=13,9,0,0,852,33430,0,0,1320,79200,0,0,400,8992,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,136:5:0 0,15,170:5:0 +X 3294 . A <*> 0 . DP=22;I16=13,9,0,0,818,30684,0,0,1320,79200,0,0,403,9077,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,145:5:0 0,15,162:5:0 +X 3295 . A <*> 0 . DP=22;I16=14,8,0,0,820,31004,0,0,1320,79200,0,0,407,9183,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,140:5:0 0,12,143:4:0 +X 3296 . G <*> 0 . DP=22;I16=14,8,0,0,837,32209,0,0,1320,79200,0,0,411,9259,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,133:5:0 0,12,140:4:0 +X 3297 . A <*> 0 . DP=22;I16=14,8,0,0,787,28771,0,0,1320,79200,0,0,415,9355,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,134:5:0 0,12,140:4:0 +X 3298 . C <*> 0 . DP=22;I16=13,9,0,0,826,31506,0,0,1320,79200,0,0,420,9470,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,113:4:0 0,12,135:4:0 +X 3299 . C <*> 0 . DP=22;I16=13,9,0,0,857,33829,0,0,1320,79200,0,0,425,9553,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,117:4:0 0,12,140:4:0 +X 3300 . A <*> 0 . DP=22;I16=13,9,0,0,861,33855,0,0,1320,79200,0,0,430,9654,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,134:4:0 0,12,144:4:0 +X 3301 . G <*> 0 . DP=22;I16=13,9,0,0,869,34495,0,0,1320,79200,0,0,433,9675,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,131:4:0 0,12,141:4:0 +X 3302 . C <*> 0 . DP=23;I16=14,9,0,0,863,32885,0,0,1380,82800,0,0,436,9718,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,115:4:0 0,15,155:5:0 +X 3303 . C <*> 0 . DP=23;I16=14,9,0,0,887,34451,0,0,1380,82800,0,0,440,9784,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,125:4:0 0,15,153:5:0 +X 3304 . T <*> 0 . DP=23;I16=14,9,0,0,886,34388,0,0,1380,82800,0,0,443,9825,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,134:4:0 0,15,167:5:0 +X 3305 . G <*> 0 . DP=23;I16=14,9,0,0,878,33846,0,0,1380,82800,0,0,446,9892,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,119:4:0 0,15,151:5:0 +X 3306 . G <*> 0 . DP=23;I16=14,9,0,0,886,34386,0,0,1380,82800,0,0,448,9934,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,127:4:0 0,15,150:5:0 +X 3307 . C <*> 0 . DP=23;I16=14,8,0,0,812,30814,0,0,1320,79200,0,0,428,9508,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,116:4:0 0,15,153:5:0 +X 3308 . C <*> 0 . DP=23;I16=14,9,0,0,835,31367,0,0,1380,82800,0,0,450,9986,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,118:4:0 0,15,151:5:0 +X 3309 . A <*> 0 . DP=23;I16=14,9,0,0,875,33541,0,0,1380,82800,0,0,451,9995,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,128:4:0 0,15,162:5:0 +X 3310 . A <*> 0 . DP=24;I16=15,9,0,0,882,32950,0,0,1440,86400,0,0,453,10027,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,152:5:0 0,15,164:5:0 +X 3311 . C <*> 0 . DP=24;I16=15,9,0,0,913,35161,0,0,1440,86400,0,0,456,10084,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,145:5:0 0,15,157:5:0 +X 3312 . A <*> 0 . DP=26;I16=16,9,0,0,950,36336,0,0,1500,90000,0,0,459,10167,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,153:5:0 0,15,160:5:0 +X 3313 . T <*> 0 . DP=26;I16=16,10,0,0,987,37617,0,0,1560,93600,0,0,488,10902,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,180:6:0 0,15,161:5:0 +X 3314 . G <*> 0 . DP=26;I16=16,10,0,0,1007,39401,0,0,1560,93600,0,0,491,10989,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,171:6:0 0,15,161:5:0 +X 3315 . G <*> 0 . DP=26;I16=15,10,0,0,945,36073,0,0,1500,90000,0,0,484,10866,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,172:6:0 0,15,159:5:0 +X 3316 . T <*> 0 . DP=26;I16=15,10,0,0,853,29881,0,0,1500,90000,0,0,464,10216,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,157:6:0 0,12,122:4:0 +X 3317 . G <*> 0 . DP=27;I16=16,11,0,0,997,37431,0,0,1620,97200,0,0,488,10806,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,164:6:0 0,18,167:6:0 +X 3318 . A <*> 0 . DP=26;I16=15,10,0,0,904,33212,0,0,1500,90000,0,0,481,10699,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,155:5:0 0,18,185:6:0 +X 3319 . A <*> 0 . DP=25;I16=15,10,0,0,912,34090,0,0,1500,90000,0,0,482,10682,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,139:5:0 0,18,188:6:0 +X 3320 . A <*> 0 . DP=25;I16=15,10,0,0,888,32722,0,0,1500,90000,0,0,483,10691,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,133:5:0 0,18,178:6:0 +X 3321 . C <*> 0 . DP=25;I16=14,10,0,0,900,34142,0,0,1440,86400,0,0,471,10531,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,157:5:0 0,18,186:6:0 +X 3322 . C <*> 0 . DP=25;I16=15,10,0,0,980,38582,0,0,1500,90000,0,0,483,10683,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,164:5:0 0,18,198:6:0 +X 3323 . C <*> 0 . DP=25;I16=15,10,0,0,922,34948,0,0,1500,90000,0,0,483,10715,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,146:5:0 0,18,201:6:0 +X 3324 . C <*> 0 . DP=25;I16=15,10,0,0,869,31271,0,0,1500,90000,0,0,482,10720,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,142:5:0 0,18,186:6:0 +X 3325 . G <*> 0 . DP=25;I16=15,10,0,0,827,28293,0,0,1500,90000,0,0,481,10747,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,134:5:0 0,18,163:6:0 +X 3326 . T <*> 0 . DP=24;I16=13,10,0,0,842,31362,0,0,1380,82800,0,0,464,10506,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,150:5:0 0,18,186:6:0 +X 3327 . C <*> 0 . DP=24;I16=14,10,0,0,938,37076,0,0,1440,86400,0,0,481,10863,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,154:5:0 0,18,190:6:0 +X 3328 . T <*> 0 . DP=25;I16=15,10,0,0,959,37033,0,0,1500,90000,0,0,480,10900,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,163:5:0 0,21,213:7:0 +X 3329 . A <*> 0 . DP=24;I16=15,9,0,0,888,33082,0,0,1440,86400,0,0,481,10955,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,149:5:0 0,21,207:7:0 +X 3330 . C <*> 0 . DP=25;I16=16,9,0,0,954,37064,0,0,1500,90000,0,0,481,10979,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,168:5:0 0,21,203:7:0 +X 3331 . T <*> 0 . DP=25;I16=16,9,0,0,960,37332,0,0,1500,90000,0,0,482,11024,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,165:5:0 0,21,224:7:0 +X 3332 . A <*> 0 . DP=25;I16=16,9,0,0,933,35065,0,0,1500,90000,0,0,483,11091,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,165:5:0 0,21,211:7:0 +X 3333 . A <*> 0 . DP=26;I16=16,10,0,0,976,37344,0,0,1560,93600,0,0,483,11131,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,166:5:0 0,24,241:8:0 +X 3334 . A <*> 0 . DP=25;I16=15,10,0,0,972,38210,0,0,1500,90000,0,0,485,11195,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,168:5:0 0,24,241:8:0 +X 3335 . A <*> 0 . DP=25;I16=15,10,0,0,970,38200,0,0,1500,90000,0,0,486,11232,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,170:5:0 0,24,239:8:0 +X 3336 . A <*> 0 . DP=25;I16=15,10,0,0,929,35277,0,0,1500,90000,0,0,485,11191,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,166:5:0 0,24,232:8:0 +X 3337 . T <*> 0 . DP=25;I16=15,10,0,0,902,32856,0,0,1500,90000,0,0,484,11172,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,157:5:0 0,24,224:8:0 +X 3338 . A <*> 0 . DP=25;I16=15,10,0,0,892,32056,0,0,1500,90000,0,0,481,11075,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,153:5:0 0,24,214:8:0 +X 3339 . C <*> 0 . DP=25;I16=15,10,0,0,964,37444,0,0,1500,90000,0,0,478,11000,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,167:5:0 0,24,232:8:0 +X 3340 . A <*> 0 . DP=23;I16=14,9,0,0,890,34616,0,0,1380,82800,0,0,477,10945,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,173:5:0 0,24,233:8:0 +X 3341 . A <*> 0 . DP=23;I16=14,9,0,0,885,34459,0,0,1380,82800,0,0,476,10908,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,167:5:0 0,24,238:8:0 +X 3342 . A <*> 0 . DP=23;I16=14,9,0,0,862,33262,0,0,1380,82800,0,0,475,10889,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,170:5:0 0,24,240:8:0 +X 3343 . A <*> 0 . DP=22;I16=13,9,0,0,866,34280,0,0,1320,79200,0,0,474,10836,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,173:5:0 0,21,231:7:0 +X 3344 . A <*> 0 . DP=22;I16=13,9,0,0,859,33731,0,0,1320,79200,0,0,473,10797,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,173:5:0 0,21,226:7:0 +X 3345 . T <*> 0 . DP=22;I16=13,9,0,0,822,31100,0,0,1320,79200,0,0,472,10772,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,254:10:0 0,15,159:5:0 0,21,220:7:0 +X 3346 . T <*> 0 . DP=22;I16=13,9,0,0,847,32679,0,0,1320,79200,0,0,470,10712,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,168:5:0 0,21,221:7:0 +X 3347 . A <*> 0 . DP=23;I16=14,9,0,0,888,34650,0,0,1380,82800,0,0,468,10668,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,185:6:0 0,21,227:7:0 +X 3348 . G <*> 0 . DP=23;I16=14,9,0,0,873,33609,0,0,1380,82800,0,0,467,10641,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,171:6:0 0,21,219:7:0 +X 3349 . C <*> 0 . DP=24;I16=14,9,0,0,815,29785,0,0,1380,82800,0,0,465,10583,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,166:6:0 0,21,205:7:0 +X 3350 . C <*> 0 . DP=24;I16=14,10,0,0,939,37249,0,0,1440,86400,0,0,464,10546,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,209:7:0 0,21,220:7:0 +X 3351 . T <*> 0 . DP=24;I16=14,10,0,0,943,37255,0,0,1440,86400,0,0,463,10531,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,210:7:0 0,21,228:7:0 +X 3352 . G <*> 0 . DP=24;I16=14,10,0,0,887,33267,0,0,1440,86400,0,0,462,10538,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,192:7:0 0,21,214:7:0 +X 3353 . G <*> 0 . DP=24;I16=14,10,0,0,864,32092,0,0,1440,86400,0,0,461,10567,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,190:7:0 0,21,214:7:0 +X 3354 . C <*> 0 . DP=24;I16=14,10,0,0,848,30714,0,0,1440,86400,0,0,459,10567,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,178:7:0 0,21,209:7:0 +X 3355 . G <*> 0 . DP=23;I16=14,9,0,0,738,24386,0,0,1380,82800,0,0,457,10537,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,232:10:0 0,21,170:7:0 0,18,166:6:0 +X 3356 . T <*> 0 . DP=23;I16=14,9,0,0,847,31689,0,0,1380,82800,0,0,454,10476,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,191:7:0 0,18,195:6:0 +X 3357 . G <*> 0 . DP=23;I16=14,9,0,0,863,32919,0,0,1380,82800,0,0,449,10335,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,193:7:0 0,18,192:6:0 +X 3358 . G <*> 0 . DP=22;I16=14,8,0,0,810,30184,0,0,1320,79200,0,0,445,10215,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,239:9:0 0,21,200:7:0 0,18,187:6:0 +X 3359 . T <*> 0 . DP=23;I16=13,8,0,0,743,26737,0,0,1260,75600,0,0,404,9318,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,228:9:0 0,21,194:7:0 0,15,162:5:0 +X 3360 . G <*> 0 . DP=23;I16=15,8,0,0,822,30058,0,0,1380,82800,0,0,436,9932,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,186:7:0 0,18,175:6:0 +X 3361 . G <*> 0 . DP=22;I16=15,7,0,0,751,26793,0,0,1320,79200,0,0,433,9819,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,218:9:0 0,21,187:7:0 0,18,175:6:0 +X 3362 . C <*> 0 . DP=22;I16=15,7,0,0,768,27462,0,0,1320,79200,0,0,430,9724,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,230:9:0 0,21,178:7:0 0,18,173:6:0 +X 3363 . G <*> 0 . DP=21;I16=14,7,0,0,662,21572,0,0,1260,75600,0,0,428,9646,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,194:9:0 0,18,155:6:0 0,18,161:6:0 +X 3364 . C <*> 0 . DP=21;I16=14,7,0,0,818,32184,0,0,1260,75600,0,0,423,9437,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,241:9:0 0,18,191:6:0 0,18,194:6:0 +X 3365 . A <*> 0 . DP=21;I16=14,7,0,0,791,29983,0,0,1260,75600,0,0,418,9250,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,226:9:0 0,18,186:6:0 0,18,190:6:0 +X 3366 . T <*> 0 . DP=21;I16=14,7,0,0,759,28053,0,0,1260,75600,0,0,413,9085,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,221:9:0 0,18,185:6:0 0,18,177:6:0 +X 3367 . G <*> 0 . DP=21;I16=14,7,0,0,767,28539,0,0,1260,75600,0,0,408,8942,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,235:9:0 0,18,185:6:0 0,18,169:6:0 +X 3368 . C <*> 0 . DP=21;I16=14,7,0,0,807,31329,0,0,1260,75600,0,0,403,8821,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,245:9:0 0,18,181:6:0 0,18,189:6:0 +X 3369 . C <*> 0 . DP=21;I16=14,7,0,0,789,30271,0,0,1260,75600,0,0,398,8722,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,228:9:0 0,18,186:6:0 0,18,193:6:0 +X 3370 . T <*> 0 . DP=21;I16=13,7,0,0,798,31960,0,0,1200,72000,0,0,392,8596,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,239:9:0 0,18,201:6:0 0,15,178:5:0 +X 3371 . G <*> 0 . DP=20;I16=13,7,0,0,739,27875,0,0,1200,72000,0,0,387,8493,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,233:9:0 0,18,173:6:0 0,15,169:5:0 +X 3372 . T <*> 0 . DP=20;I16=13,6,0,0,693,25677,0,0,1140,68400,0,0,359,7883,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,220:9:0 0,15,154:5:0 0,15,167:5:0 +X 3373 . A <*> 0 . DP=20;I16=13,7,0,0,729,27019,0,0,1200,72000,0,0,375,8253,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,226:9:0 0,18,162:6:0 0,15,174:5:0 +X 3374 . A <*> 0 . DP=19;I16=13,6,0,0,719,27437,0,0,1140,68400,0,0,369,8115,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,225:9:0 0,15,167:5:0 0,15,164:5:0 +X 3375 . T <*> 0 . DP=20;I16=12,6,0,0,683,26039,0,0,1080,64800,0,0,337,7321,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,221:8:0 0,15,155:5:0 0,15,172:5:0 +X 3376 . C <*> 0 . DP=20;I16=13,7,0,0,739,27867,0,0,1200,72000,0,0,356,7796,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,254:10:0 0,15,146:5:0 0,15,173:5:0 +X 3377 . C <*> 0 . DP=20;I16=13,7,0,0,741,27905,0,0,1200,72000,0,0,350,7666,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,252:10:0 0,15,149:5:0 0,15,173:5:0 +X 3378 . C <*> 0 . DP=20;I16=13,7,0,0,775,30179,0,0,1200,72000,0,0,343,7507,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,161:5:0 0,15,172:5:0 +X 3379 . A <*> 0 . DP=20;I16=13,7,0,0,736,27530,0,0,1200,72000,0,0,336,7370,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,245:10:0 0,15,157:5:0 0,15,169:5:0 +X 3380 . G <*> 0 . DP=19;I16=13,6,0,0,729,28249,0,0,1140,68400,0,0,330,7254,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,233:9:0 0,15,157:5:0 0,15,178:5:0 +X 3381 . C <*> 0 . DP=19;I16=13,6,0,0,742,29288,0,0,1140,68400,0,0,324,7158,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,241:9:0 0,15,155:5:0 0,15,178:5:0 +X 3382 . T <*> 0 . DP=17;I16=12,5,0,0,649,25245,0,0,1020,61200,0,0,320,7080,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,222:9:0 0,9,105:3:0 0,15,184:5:0 +X 3383 . A <*> 0 . DP=17;I16=12,4,0,0,556,19808,0,0,960,57600,0,0,291,6393,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,196:9:0 0,6,71:2:0 0,15,167:5:0 +X 3384 . C <*> 0 . DP=19;I16=14,5,0,0,701,26181,0,0,1140,68400,0,0,311,6923,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,235:10:0 0,9,98:3:0 0,18,187:6:0 +X 3385 . T <*> 0 . DP=19;I16=14,5,0,0,730,28456,0,0,1140,68400,0,0,307,6797,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,237:10:0 0,9,109:3:0 0,18,195:6:0 +X 3386 . T <*> 0 . DP=19;I16=14,5,0,0,642,22450,0,0,1140,68400,0,0,302,6642,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,197:10:0 0,9,104:3:0 0,18,188:6:0 +X 3387 . G <*> 0 . DP=20;I16=14,6,0,0,723,26761,0,0,1200,72000,0,0,296,6460,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,230:10:0 0,9,105:3:0 0,21,210:7:0 +X 3388 . G <*> 0 . DP=20;I16=14,6,0,0,705,25891,0,0,1200,72000,0,0,291,6303,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,225:10:0 0,9,109:3:0 0,21,202:7:0 +X 3389 . G <*> 0 . DP=18;I16=10,7,0,0,617,22635,0,0,1020,61200,0,0,270,5808,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,190:7:0 0,9,105:3:0 0,21,207:7:0 +X 3390 . A <*> 0 . DP=18;I16=11,7,0,0,631,22681,0,0,1080,64800,0,0,288,6056,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,200:8:0 0,9,105:3:0 0,21,198:7:0 +X 3391 . A <*> 0 . DP=18;I16=11,7,0,0,663,24951,0,0,1080,64800,0,0,287,5965,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,192:8:0 0,9,113:3:0 0,21,224:7:0 +X 3392 . G <*> 0 . DP=18;I16=11,7,0,0,666,25104,0,0,1080,64800,0,0,286,5896,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,211:8:0 0,9,103:3:0 0,21,216:7:0 +X 3393 . C <*> 0 . DP=18;I16=11,7,0,0,686,26472,0,0,1080,64800,0,0,284,5800,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,222:8:0 0,9,106:3:0 0,21,214:7:0 +X 3394 . T <*> 0 . DP=18;I16=11,7,0,0,699,27481,0,0,1080,64800,0,0,282,5728,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,219:8:0 0,9,114:3:0 0,21,222:7:0 +X 3395 . G <*> 0 . DP=17;I16=10,7,0,0,656,25512,0,0,1020,61200,0,0,281,5679,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,205:7:0 0,9,105:3:0 0,21,222:7:0 +X 3396 . A <*> 0 . DP=17;I16=10,7,0,0,644,25446,0,0,1020,61200,0,0,280,5652,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,182:7:0 0,9,119:3:0 0,21,232:7:0 +X 3397 . G <*> 0 . DP=17;I16=10,7,0,0,633,23895,0,0,1020,61200,0,0,279,5647,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,193:7:0 0,9,107:3:0 0,21,218:7:0 +X 3398 . G <*> 0 . DP=16;I16=10,6,0,0,610,23380,0,0,960,57600,0,0,279,5663,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,170:6:0 0,9,110:3:0 0,21,215:7:0 +X 3399 . G <*> 0 . DP=17;I16=10,6,0,0,585,21729,0,0,960,57600,0,0,270,5618,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,15,147:5:0 0,12,122:4:0 0,21,216:7:0 +X 3400 . A <*> 0 . DP=17;I16=10,6,0,0,576,21400,0,0,960,57600,0,0,264,5500,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,15,136:5:0 0,12,131:4:0 0,21,213:7:0 +X 3401 . T <*> 0 . DP=17;I16=11,6,0,0,605,22159,0,0,1020,61200,0,0,280,5784,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,146:6:0 0,12,131:4:0 0,21,216:7:0 +X 3402 . G <*> 0 . DP=17;I16=11,6,0,0,638,24150,0,0,1020,61200,0,0,280,5832,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,172:6:0 0,12,130:4:0 0,21,213:7:0 +X 3403 . A <*> 0 . DP=16;I16=9,6,0,0,579,22815,0,0,900,54000,0,0,276,5874,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,15,139:5:0 0,12,140:4:0 0,18,205:6:0 +X 3404 . G <*> 0 . DP=16;I16=10,6,0,0,564,20652,0,0,960,57600,0,0,281,5935,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,148:6:0 0,12,131:4:0 0,18,186:6:0 +X 3405 . A <*> 0 . DP=16;I16=10,6,0,0,560,20158,0,0,960,57600,0,0,281,5991,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,157:6:0 0,12,124:4:0 0,18,179:6:0 +X 3406 . A <*> 0 . DP=16;I16=10,6,0,0,568,20556,0,0,960,57600,0,0,281,6067,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,150:6:0 0,12,129:4:0 0,18,186:6:0 +X 3407 . C <*> 0 . DP=17;I16=11,6,0,0,591,21225,0,0,1020,61200,0,0,281,6163,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,178:7:0 0,12,106:4:0 0,18,183:6:0 +X 3408 . T <*> 0 . DP=17;I16=11,6,0,0,632,23754,0,0,1020,61200,0,0,282,6280,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,177:7:0 0,12,133:4:0 0,18,189:6:0 +X 3409 . G <*> 0 . DP=16;I16=10,6,0,0,599,22667,0,0,960,57600,0,0,283,6369,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,172:6:0 0,12,119:4:0 0,18,192:6:0 +X 3410 . C <*> 0 . DP=16;I16=10,6,0,0,585,21685,0,0,960,57600,0,0,282,6378,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,174:6:0 0,12,126:4:0 0,18,176:6:0 +X 3411 . T <*> 0 . DP=15;I16=9,6,0,0,578,22492,0,0,900,54000,0,0,282,6404,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,165:6:0 0,9,114:3:0 0,18,196:6:0 +X 3412 . T <*> 0 . DP=15;I16=9,6,0,0,546,20202,0,0,900,54000,0,0,283,6445,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,15,148:5:0 0,12,120:4:0 0,18,189:6:0 +X 3413 . G <*> 0 . DP=15;I16=9,6,0,0,559,21023,0,0,900,54000,0,0,283,6401,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,15,158:5:0 0,12,124:4:0 0,18,184:6:0 +X 3414 . A <*> 0 . DP=15;I16=9,6,0,0,512,17878,0,0,900,54000,0,0,283,6373,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,15,148:5:0 0,12,116:4:0 0,18,166:6:0 +X 3415 . A <*> 0 . DP=16;I16=9,7,0,0,544,19656,0,0,960,57600,0,0,282,6310,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,15,142:5:0 0,12,132:4:0 0,21,179:7:0 +X 3416 . C <*> 0 . DP=16;I16=9,7,0,0,562,20168,0,0,960,57600,0,0,282,6262,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,15,143:5:0 0,12,127:4:0 0,21,191:7:0 +X 3417 . C <*> 0 . DP=16;I16=9,7,0,0,566,20666,0,0,960,57600,0,0,282,6230,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,15,147:5:0 0,12,126:4:0 0,21,192:7:0 +X 3418 . T <*> 0 . DP=17;I16=10,5,0,0,557,21637,0,0,900,54000,0,0,268,5988,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,15,150:5:0 0,15,148:5:0 0,15,176:5:0 +X 3419 . G <*> 0 . DP=17;I16=10,7,0,0,594,21642,0,0,1020,61200,0,0,310,6836,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,161:6:0 0,15,140:5:0 0,18,190:6:0 +X 3420 . G <*> 0 . DP=17;I16=10,7,0,0,596,21580,0,0,1020,61200,0,0,312,6850,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,172:6:0 0,15,132:5:0 0,18,188:6:0 +X 3421 . G <*> 0 . DP=18;I16=10,8,0,0,633,22781,0,0,1049,62041,0,0,314,6880,0,0;QS=3,0;MQSB=0.906029;MQ0F=0 PL:DP:DV 0,21,184:7:0 0,15,138:5:0 0,18,191:6:0 +X 3422 . A <*> 0 . DP=18;I16=9,8,0,0,576,20954,0,0,989,58441,0,0,302,6702,0,0;QS=3,0;MQSB=0.91051;MQ0F=0 PL:DP:DV 0,18,167:6:0 0,15,130:5:0 0,18,188:6:0 +X 3423 . G <*> 0 . DP=18;I16=9,9,0,0,651,24391,0,0,1049,62041,0,0,305,6747,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,21,200:7:0 0,15,149:5:0 0,18,183:6:0 +X 3424 . G <*> 0 . DP=18;I16=8,8,0,0,555,20175,0,0,929,54841,0,0,275,6105,0,0;QS=3,0;MQSB=0.915545;MQ0F=0 PL:DP:DV 0,18,161:6:0 0,15,141:5:0 0,15,169:5:0 +X 3425 . C <*> 0 . DP=18;I16=9,8,0,0,594,21676,0,0,1020,61200,0,0,307,6779,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,168:6:0 0,15,142:5:0 0,18,186:6:0 +X 3426 . A <*> 0 . DP=18;I16=9,8,0,0,633,23967,0,0,1020,61200,0,0,308,6774,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,172:6:0 0,15,151:5:0 0,18,202:6:0 +X 3427 . G <*> 0 . DP=18;I16=9,9,0,0,655,24639,0,0,1049,62041,0,0,315,6823,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,21,209:7:0 0,15,144:5:0 0,18,184:6:0 +X 3428 . A <*> 0 . DP=18;I16=9,7,0,0,573,21235,0,0,960,57600,0,0,305,6793,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,15,158:5:0 0,15,147:5:0 0,18,178:6:0 +X 3429 . C <*> 0 . DP=17;I16=8,9,0,0,516,16610,0,0,989,58441,0,0,320,6930,0,0;QS=3,0;MQSB=0.928603;MQ0F=0 PL:DP:DV 0,21,176:7:0 0,15,125:5:0 0,15,124:5:0 +X 3430 . G <*> 0 . DP=18;I16=9,9,0,0,539,17155,0,0,1049,62041,0,0,323,7011,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,24,181:8:0 0,15,113:5:0 0,15,144:5:0 +X 3431 . T <*> 0 . DP=18;I16=9,9,0,0,651,24101,0,0,1049,62041,0,0,327,7111,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,24,210:8:0 0,15,139:5:0 0,15,166:5:0 +X 3432 . T <*> 0 . DP=18;I16=8,9,0,0,577,20601,0,0,989,58441,0,0,306,6606,0,0;QS=3,0;MQSB=0.928603;MQ0F=0 PL:DP:DV 0,21,162:7:0 0,15,144:5:0 0,15,165:5:0 +X 3433 . G <*> 0 . DP=18;I16=9,9,0,0,623,22589,0,0,1049,62041,0,0,334,7320,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,24,199:8:0 0,15,138:5:0 0,15,164:5:0 +X 3434 . C <*> 0 . DP=18;I16=10,7,0,0,582,20838,0,0,1020,61200,0,0,324,7208,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,208:8:0 0,15,130:5:0 0,12,137:4:0 +X 3435 . A <*> 0 . DP=18;I16=10,8,0,0,595,21619,0,0,1049,62041,0,0,341,7453,0,0;QS=3,0;MQSB=0.906029;MQ0F=0 PL:DP:DV 0,27,185:9:0 0,15,150:5:0 0,12,151:4:0 +X 3436 . G <*> 0 . DP=18;I16=10,8,0,0,617,22277,0,0,1049,62041,0,0,345,7549,0,0;QS=3,0;MQSB=0.906029;MQ0F=0 PL:DP:DV 0,27,218:9:0 0,15,146:5:0 0,12,133:4:0 +X 3437 . T G,<*> 0 . DP=18;I16=10,7,0,1,594,21168,16,256,1020,61200,29,841,333,7409,16,256;QS=2.94286,0.0571429,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.906029;BQB=1;MQ0F=0 PL:DP:DV 0,11,188,24,191,195:9:1 0,15,148,15,148,148:5:0 0,12,132,12,132,132:4:0 +X 3438 . G <*> 0 . DP=18;I16=10,7,0,0,622,23296,0,0,1020,61200,0,0,335,7461,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,215:8:0 0,15,152:5:0 0,12,140:4:0 +X 3439 . A <*> 0 . DP=18;I16=10,8,0,0,619,22965,0,0,1049,62041,0,0,355,7853,0,0;QS=3,0;MQSB=0.906029;MQ0F=0 PL:DP:DV 0,27,215:9:0 0,15,153:5:0 0,12,132:4:0 +X 3440 . G <*> 0 . DP=18;I16=10,7,0,0,610,22660,0,0,1020,61200,0,0,339,7613,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,221:8:0 0,15,143:5:0 0,12,131:4:0 +X 3441 . C <*> 0 . DP=18;I16=10,6,0,0,585,22165,0,0,960,57600,0,0,315,7037,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,226:8:0 0,15,140:5:0 0,9,115:3:0 +X 3442 . T <*> 0 . DP=20;I16=11,9,0,0,670,24716,0,0,1138,66482,0,0,362,8166,0,0;QS=3,0;MQSB=0.997118;MQ0F=0 PL:DP:DV 0,33,248:11:0 0,15,143:5:0 0,12,128:4:0 +X 3443 . G <*> 0 . DP=20;I16=11,9,0,0,708,26092,0,0,1138,66482,0,0,366,8288,0,0;QS=3,0;MQSB=0.997118;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,143:5:0 0,12,137:4:0 +X 3444 . A <*> 0 . DP=20;I16=11,9,0,0,698,25978,0,0,1138,66482,0,0,369,8379,0,0;QS=3,0;MQSB=0.997118;MQ0F=0 PL:DP:DV 0,33,244:11:0 0,15,161:5:0 0,12,131:4:0 +X 3445 . G <*> 0 . DP=20;I16=11,9,0,0,718,26590,0,0,1138,66482,0,0,372,8488,0,0;QS=3,0;MQSB=0.997118;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,153:5:0 0,12,132:4:0 +X 3446 . A <*> 0 . DP=20;I16=10,8,0,0,635,23323,0,0,1049,62041,0,0,325,7365,0,0;QS=3,0;MQSB=0.938795;MQ0F=0 PL:DP:DV 0,27,222:9:0 0,15,154:5:0 0,12,131:4:0 +X 3447 . T <*> 0 . DP=20;I16=11,8,0,0,669,24331,0,0,1109,65641,0,0,352,8084,0,0;QS=3,0;MQSB=0.946915;MQ0F=0 PL:DP:DV 0,30,230:10:0 0,15,150:5:0 0,12,137:4:0 +X 3448 . C <*> 0 . DP=19;I16=10,8,0,0,641,23693,0,0,1049,62041,0,0,355,8193,0,0;QS=3,0;MQSB=0.938795;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,113:4:0 0,12,128:4:0 +X 3449 . A <*> 0 . DP=19;I16=10,8,0,0,565,19185,0,0,1049,62041,0,0,357,8265,0,0;QS=3,0;MQSB=0.938795;MQ0F=0 PL:DP:DV 0,30,217:10:0 0,12,111:4:0 0,12,119:4:0 +X 3450 . C <*> 0 . DP=18;I16=8,8,0,0,520,17846,0,0,898,52082,0,0,334,7674,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,229:10:0 0,6,70:2:0 0,12,106:4:0 +X 3451 . G <*> 0 . DP=18;I16=10,7,0,0,528,17178,0,0,989,58441,0,0,361,8345,0,0;QS=3,0;MQSB=0.943335;MQ0F=0 PL:DP:DV 0,30,226:10:0 0,9,56:3:0 0,12,123:4:0 +X 3452 . C <*> 0 . DP=18;I16=10,8,0,0,657,24597,0,0,1018,59282,0,0,388,9028,0,0;QS=3,0;MQSB=0.99606;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,84:3:0 0,12,128:4:0 +X 3453 . C <*> 0 . DP=18;I16=10,8,0,0,663,24951,0,0,1018,59282,0,0,390,9098,0,0;QS=3,0;MQSB=0.99606;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,90:3:0 0,12,125:4:0 +X 3454 . A <*> 0 . DP=18;I16=10,8,0,0,614,21898,0,0,1018,59282,0,0,392,9180,0,0;QS=3,0;MQSB=0.99606;MQ0F=0 PL:DP:DV 0,33,251:11:0 0,9,90:3:0 0,12,128:4:0 +X 3455 . C <*> 0 . DP=18;I16=10,8,0,0,650,23968,0,0,1018,59282,0,0,394,9274,0,0;QS=3,0;MQSB=0.99606;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,90:3:0 0,12,127:4:0 +X 3456 . T <*> 0 . DP=18;I16=10,8,0,0,607,21961,0,0,1018,59282,0,0,395,9329,0,0;QS=3,0;MQSB=0.99606;MQ0F=0 PL:DP:DV 0,33,243:11:0 0,9,88:3:0 0,12,135:4:0 +X 3457 . G <*> 0 . DP=18;I16=9,7,0,0,549,19861,0,0,898,52082,0,0,346,8144,0,0;QS=3,0;MQSB=0.994413;MQ0F=0 PL:DP:DV 0,33,254:11:0 0,6,63:2:0 0,9,107:3:0 +X 3458 . C <*> 0 . DP=18;I16=10,8,0,0,638,23236,0,0,1018,59282,0,0,397,9469,0,0;QS=3,0;MQSB=0.99606;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,81:3:0 0,12,125:4:0 +X 3459 . A C,<*> 0 . DP=17;I16=9,7,0,1,520,18390,22,484,929,54841,29,841,372,8830,25,625;QS=2.92971,0.0702875,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.998843;BQB=1;MQ0F=0 PL:DP:DV 0,8,201,27,204,213:10:1 0,9,84,9,84,84:3:0 0,12,116,12,116,116:4:0 +X 3460 . C <*> 0 . DP=17;I16=8,7,0,0,554,20952,0,0,869,51241,0,0,345,8103,0,0;QS=3,0;MQSB=0.921243;MQ0F=0 PL:DP:DV 0,27,244:9:0 0,6,65:2:0 0,12,131:4:0 +X 3461 . T <*> 0 . DP=17;I16=9,7,0,0,591,22805,0,0,929,54841,0,0,368,8638,0,0;QS=3,0;MQSB=0.933674;MQ0F=0 PL:DP:DV 0,27,231:9:0 0,9,103:3:0 0,12,133:4:0 +X 3462 . C <*> 0 . DP=18;I16=9,9,0,0,672,25486,0,0,1018,59282,0,0,391,9185,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,90:3:0 0,12,130:4:0 +X 3463 . C <*> 0 . DP=18;I16=8,9,0,0,584,21458,0,0,958,55682,0,0,369,8671,0,0;QS=3,0;MQSB=0.998843;MQ0F=0 PL:DP:DV 0,30,244:10:0 0,9,86:3:0 0,12,132:4:0 +X 3464 . A <*> 0 . DP=18;I16=9,9,0,0,628,23490,0,0,1018,59282,0,0,387,8973,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,244:11:0 0,9,96:3:0 0,12,142:4:0 +X 3465 . G <*> 0 . DP=19;I16=9,9,0,0,642,24008,0,0,1018,59282,0,0,384,8842,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,91:3:0 0,12,135:4:0 +X 3466 . C <*> 0 . DP=20;I16=9,10,0,0,682,25218,0,0,1047,60123,0,0,378,8588,0,0;QS=3,0;MQSB=0.904084;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,101:3:0 0,15,147:5:0 +X 3467 . C <*> 0 . DP=20;I16=10,9,0,0,685,25919,0,0,1047,60123,0,0,397,9139,0,0;QS=3,0;MQSB=0.948064;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,115:4:0 0,15,154:5:0 +X 3468 . T <*> 0 . DP=20;I16=10,9,0,0,672,25426,0,0,1047,60123,0,0,374,8410,0,0;QS=3,0;MQSB=0.948064;MQ0F=0 PL:DP:DV 0,30,246:10:0 0,12,126:4:0 0,15,164:5:0 +X 3469 . G <*> 0 . DP=21;I16=10,11,0,0,788,30064,0,0,1167,67323,0,0,396,8924,0,0;QS=3,0;MQSB=0.914611;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,146:5:0 0,15,163:5:0 +X 3470 . G <*> 0 . DP=22;I16=11,11,0,0,796,29754,0,0,1196,68164,0,0,393,8781,0,0;QS=3,0;MQSB=0.770381;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,131:5:0 0,15,161:5:0 +X 3471 . G <*> 0 . DP=23;I16=12,11,0,0,801,29083,0,0,1256,71764,0,0,391,8657,0,0;QS=3,0;MQSB=0.811552;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,133:5:0 0,15,151:5:0 +X 3472 . C <*> 0 . DP=23;I16=12,11,0,0,757,26535,0,0,1256,71764,0,0,390,8554,0,0;QS=3,0;MQSB=0.811552;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,145:5:0 0,15,136:5:0 +X 3473 . A <*> 0 . DP=23;I16=11,11,0,0,777,28175,0,0,1196,68164,0,0,379,8373,0,0;QS=3,0;MQSB=0.770381;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,148:5:0 0,15,153:5:0 +X 3474 . A <*> 0 . DP=23;I16=12,11,0,0,807,29181,0,0,1256,71764,0,0,388,8414,0,0;QS=3,0;MQSB=0.811552;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,150:5:0 0,15,155:5:0 +X 3475 . C <*> 0 . DP=22;I16=12,10,0,0,737,25849,0,0,1196,68164,0,0,387,8327,0,0;QS=3,0;MQSB=0.838545;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,137:5:0 0,15,143:5:0 +X 3476 . A <*> 0 . DP=22;I16=12,10,0,0,790,29312,0,0,1196,68164,0,0,386,8262,0,0;QS=3,0;MQSB=0.838545;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,149:5:0 0,15,154:5:0 +X 3477 . G <*> 0 . DP=22;I16=11,10,0,0,755,28237,0,0,1136,64564,0,0,363,7735,0,0;QS=3,0;MQSB=0.799507;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,126:4:0 0,15,153:5:0 +X 3478 . A <*> 0 . DP=25;I16=13,11,0,0,857,31637,0,0,1316,75364,0,0,384,8198,0,0;QS=3,0;MQSB=0.845496;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,167:6:0 0,18,190:6:0 +X 3479 . G <*> 0 . DP=25;I16=12,10,0,0,783,28623,0,0,1227,70923,0,0,355,7701,0,0;QS=3,0;MQSB=0.613159;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,152:5:0 0,18,160:6:0 +X 3480 . T <*> 0 . DP=25;I16=13,11,0,0,788,27124,0,0,1316,75364,0,0,393,8531,0,0;QS=3,0;MQSB=0.845496;MQ0F=0 PL:DP:DV 0,33,249:11:0 0,21,182:7:0 0,18,155:6:0 +X 3481 . A <*> 0 . DP=25;I16=12,12,0,0,858,30884,0,0,1347,78123,0,0,397,8685,0,0;QS=3,0;MQSB=0.941765;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,194:7:0 0,15,148:5:0 +X 3482 . A <*> 0 . DP=25;I16=13,12,0,0,927,35013,0,0,1376,78964,0,0,412,8942,0,0;QS=3,0;MQSB=0.822311;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,202:7:0 0,18,182:6:0 +X 3483 . G <*> 0 . DP=25;I16=12,12,0,0,794,27410,0,0,1316,75364,0,0,412,9002,0,0;QS=3,0;MQSB=0.786628;MQ0F=0 PL:DP:DV 0,33,253:11:0 0,21,183:7:0 0,18,158:6:0 +X 3484 . A C,<*> 0 . DP=24;I16=12,9,0,1,710,25220,14,196,1198,70082,60,3600,346,7514,25,625;QS=2.93665,0.0633484,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.804615;BQB=1;MQ0F=0 PL:DP:DV 0,30,227,30,227,227:10:0 0,7,156,18,159,162:7:1 0,15,133,15,133,133:5:0 +X 3485 . C <*> 0 . DP=23;I16=11,11,0,0,766,27656,0,0,1196,68164,0,0,393,8573,0,0;QS=3,0;MQSB=0.770381;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,163:6:0 0,15,120:5:0 +X 3486 . T <*> 0 . DP=24;I16=12,10,0,0,799,30529,0,0,1196,68164,0,0,398,8756,0,0;QS=3,0;MQSB=0.838545;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,198:7:0 0,15,128:5:0 +X 3487 . C <*> 0 . DP=24;I16=10,11,0,0,724,27586,0,0,1167,67323,0,0,393,8905,0,0;QS=3,0;MQSB=0.914611;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,162:6:0 0,12,92:4:0 +X 3488 . T <*> 0 . DP=24;I16=12,10,0,0,742,27454,0,0,1196,68164,0,0,429,9571,0,0;QS=3,0;MQSB=0.838545;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,172:7:0 0,12,98:4:0 +X 3489 . G <*> 0 . DP=25;I16=13,11,0,0,778,28994,0,0,1285,72605,0,0,433,9675,0,0;QS=3,0;MQSB=0.97965;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,177:8:0 0,12,75:4:0 +X 3490 . T C,<*> 0 . DP=27;I16=14,10,1,0,806,28886,25,625,1254,69846,60,3600,427,9659,12,144;QS=2.90775,0.0922509,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.962269;BQB=1;MQ0F=0 PL:DP:DV 0,39,255,39,255,255:13:0 0,2,168,24,171,183:9:1 0,9,85,9,85,85:3:0 +X 3491 . C <*> 0 . DP=28;I16=15,11,0,0,864,31232,0,0,1405,79805,0,0,445,9903,0,0;QS=3,0;MQSB=0.753395;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,197:9:0 0,9,78:3:0 +X 3492 . T <*> 0 . DP=28;I16=15,11,0,0,852,31516,0,0,1405,79805,0,0,452,9986,0,0;QS=3,0;MQSB=0.753395;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,212:9:0 0,9,96:3:0 +X 3493 . C <*> 0 . DP=28;I16=15,12,0,0,891,32181,0,0,1434,80646,0,0,464,10124,0,0;QS=3,0;MQSB=0.908075;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,27,214:9:0 0,9,80:3:0 +X 3493 . CAAAAAAAAAAAAA CAAAAAAAAAAAA,CAAAAAAAAAAAAAA 0 . INDEL;IDV=2;IMF=0.125;DP=28;I16=9,9,0,2,443,11071,47,1129,1049,62041,89,4441,320,7120,30,650;QS=2.81818,0.0909091,0.0909091;VDB=0.504964;SGB=0.346553;MQSB=0.997118;MQ0F=0 PL:DP:DV 0,19,37,19,40,37:11:2 0,18,39,18,39,39:6:0 0,9,23,9,23,23:3:0 +X 3494 . A <*> 0 . DP=30;I16=15,12,0,0,970,37408,0,0,1465,83405,0,0,440,9568,0,0;QS=3,0;MQSB=0.723173;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,220:9:0 0,12,117:4:0 +X 3495 . A <*> 0 . DP=31;I16=15,13,0,0,966,36178,0,0,1525,87005,0,0,472,10270,0,0;QS=3,0;MQSB=0.695496;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,210:9:0 0,15,129:5:0 +X 3496 . A <*> 0 . DP=31;I16=15,13,0,0,974,36928,0,0,1525,87005,0,0,477,10281,0,0;QS=3,0;MQSB=0.695496;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,207:9:0 0,15,138:5:0 +X 3497 . A <*> 0 . DP=32;I16=14,14,0,0,1015,39525,0,0,1525,87005,0,0,460,9834,0,0;QS=3,0;MQSB=0.62781;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,208:8:0 0,18,148:6:0 +X 3498 . A <*> 0 . DP=32;I16=14,14,0,0,982,37264,0,0,1556,89764,0,0,460,9628,0,0;QS=3,0;MQSB=0.813104;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,220:9:0 0,15,115:5:0 +X 3499 . A <*> 0 . DP=32;I16=14,14,0,0,1024,40072,0,0,1525,87005,0,0,489,10267,0,0;QS=3,0;MQSB=0.62781;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,222:8:0 0,18,144:6:0 +X 3500 . A <*> 0 . DP=31;I16=14,14,0,0,995,38097,0,0,1525,87005,0,0,494,10316,0,0;QS=3,0;MQSB=0.62781;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,214:8:0 0,18,150:6:0 +X 3501 . A <*> 0 . DP=31;I16=14,14,0,0,1017,39845,0,0,1525,87005,0,0,499,10399,0,0;QS=3,0;MQSB=0.62781;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,221:8:0 0,18,149:6:0 +X 3502 . A <*> 0 . DP=31;I16=14,14,0,0,1051,41955,0,0,1525,87005,0,0,504,10516,0,0;QS=3,0;MQSB=0.62781;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,223:8:0 0,18,154:6:0 +X 3503 . A <*> 0 . DP=31;I16=14,14,0,0,1038,40832,0,0,1525,87005,0,0,509,10667,0,0;QS=3,0;MQSB=0.62781;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,229:8:0 0,18,155:6:0 +X 3504 . A <*> 0 . DP=31;I16=14,14,0,0,1037,41235,0,0,1525,87005,0,0,512,10750,0,0;QS=3,0;MQSB=0.62781;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,229:8:0 0,18,145:6:0 +X 3505 . A <*> 0 . DP=31;I16=14,14,0,0,1039,40959,0,0,1525,87005,0,0,514,10814,0,0;QS=3,0;MQSB=0.62781;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,233:8:0 0,18,156:6:0 +X 3506 . A <*> 0 . DP=32;I16=11,13,0,0,889,34265,0,0,1378,80882,0,0,427,9079,0,0;QS=3,0;MQSB=0.998323;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,201:6:0 0,18,158:6:0 +X 3507 . T <*> 0 . DP=31;I16=10,17,0,0,995,38431,0,0,1527,88923,0,0,493,10499,0,0;QS=3,0;MQSB=0.997168;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,187:6:0 0,18,153:6:0 +X 3508 . C <*> 0 . DP=31;I16=10,17,0,0,997,40091,0,0,1527,88923,0,0,499,10675,0,0;QS=3,0;MQSB=0.997168;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,160:6:0 0,15,119:5:0 +X 3509 . A <*> 0 . DP=30;I16=11,17,0,0,995,37147,0,0,1556,89764,0,0,529,11459,0,0;QS=3,0;MQSB=0.960952;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,175:6:0 0,15,125:5:0 +X 3510 . C A,<*> 0 . DP=29;I16=9,17,1,0,959,37997,40,1600,1498,88082,29,841,483,10351,25,625;QS=2.95246,0.047541,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.997168;BQB=1;MQ0F=0 PL:DP:DV 0,19,255,45,255,255:16:1 0,18,150,18,150,150:6:0 0,15,119,15,119,119:5:0 +X 3511 . A <*> 0 . DP=32;I16=11,17,0,0,923,33125,0,0,1587,92523,0,0,512,11150,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,169:6:0 0,15,115:5:0 +X 3512 . C <*> 0 . DP=32;I16=10,18,0,0,1058,42208,0,0,1618,95282,0,0,493,10733,0,0;QS=3,0;MQSB=0.891417;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,181:6:0 0,15,131:5:0 +X 3513 . C A,<*> 0 . DP=32;I16=10,18,1,0,1074,42406,13,169,1618,95282,29,841,498,10926,25,625;QS=2.98,0.02,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.995968;BQB=1;MQ0F=0 PL:DP:DV 0,39,255,51,255,255:18:1 0,18,190,18,190,190:6:0 0,15,136,15,136,136:5:0 +X 3514 . A <*> 0 . DP=33;I16=11,19,0,0,1101,42213,0,0,1707,99723,0,0,528,11778,0,0;QS=3,0;MQSB=0.997918;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,199:7:0 0,15,132:5:0 +X 3515 . T <*> 0 . DP=33;I16=12,19,0,0,1130,43380,0,0,1736,100564,0,0,557,12563,0,0;QS=3,0;MQSB=0.960505;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,192:7:0 0,15,126:5:0 +X 3516 . T <*> 0 . DP=34;I16=14,17,0,0,1147,44331,0,0,1767,103323,0,0,536,12078,0,0;QS=3,0;MQSB=0.924242;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,203:7:0 0,15,133:5:0 +X 3517 . T <*> 0 . DP=34;I16=14,18,0,0,1183,46549,0,0,1796,104164,0,0,565,12773,0,0;QS=3,0;MQSB=0.988522;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,21,210:7:0 0,15,153:5:0 +X 3518 . T <*> 0 . DP=34;I16=14,18,0,0,1165,44867,0,0,1796,104164,0,0,568,12826,0,0;QS=3,0;MQSB=0.988522;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,21,203:7:0 0,15,141:5:0 +X 3519 . G <*> 0 . DP=33;I16=13,18,0,0,1158,46678,0,0,1736,100564,0,0,572,12912,0,0;QS=3,0;MQSB=0.980167;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,18,189:6:0 0,15,154:5:0 +X 3520 . G <*> 0 . DP=33;I16=12,18,0,0,1111,42471,0,0,1707,99723,0,0,552,12438,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,183:6:0 0,15,151:5:0 +X 3521 . C <*> 0 . DP=32;I16=11,17,0,0,1077,43755,0,0,1649,98041,0,0,530,11850,0,0;QS=3,0;MQSB=0.967085;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,185:6:0 0,15,143:5:0 +X 3522 . T <*> 0 . DP=32;I16=12,17,0,0,1125,46329,0,0,1678,98882,0,0,552,12274,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,199:6:0 0,15,158:5:0 +X 3523 . T <*> 0 . DP=31;I16=11,16,0,0,996,38204,0,0,1558,91682,0,0,544,12286,0,0;QS=3,0;MQSB=0.992419;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,193:6:0 0,15,145:5:0 +X 3524 . C <*> 0 . DP=31;I16=11,16,0,0,1067,43883,0,0,1589,94441,0,0,538,11960,0,0;QS=3,0;MQSB=0.96384;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,192:6:0 0,15,152:5:0 +X 3525 . A <*> 0 . DP=31;I16=13,16,0,0,1132,46402,0,0,1678,98882,0,0,556,12250,0,0;QS=3,0;MQSB=0.997839;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,200:6:0 0,15,165:5:0 +X 3526 . G <*> 0 . DP=31;I16=12,16,0,0,1090,43912,0,0,1649,98041,0,0,543,12053,0,0;QS=3,0;MQSB=0.96195;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,181:6:0 0,15,147:5:0 +X 3527 . A <*> 0 . DP=31;I16=13,16,0,0,1068,41740,0,0,1678,98882,0,0,560,12334,0,0;QS=3,0;MQSB=0.997839;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,170:6:0 0,15,157:5:0 +X 3528 . T <*> 0 . DP=31;I16=13,16,0,0,1076,41782,0,0,1678,98882,0,0,561,12369,0,0;QS=3,0;MQSB=0.997839;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,193:6:0 0,15,152:5:0 +X 3529 . T <*> 0 . DP=31;I16=12,16,0,0,1016,38674,0,0,1649,98041,0,0,550,12290,0,0;QS=3,0;MQSB=0.96195;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,184:6:0 0,15,154:5:0 +X 3530 . G <*> 0 . DP=30;I16=12,17,0,0,1070,40570,0,0,1709,101641,0,0,578,13032,0,0;QS=3,0;MQSB=0.965321;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,176:6:0 0,18,175:6:0 +X 3531 . C A,<*> 0 . DP=31;I16=13,17,1,0,1080,40304,38,1444,1738,102482,29,841,607,13801,10,100;QS=2.95773,0.0422741,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.924242;BQB=1;MQ0F=0 PL:DP:DV 0,28,255,54,255,255:19:1 0,18,172,18,172,172:6:0 0,18,175,18,175,175:6:0 +X 3532 . A <*> 0 . DP=31;I16=14,17,0,0,1136,42380,0,0,1767,103323,0,0,619,14003,0,0;QS=3,0;MQSB=0.924242;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,180:6:0 0,18,184:6:0 +X 3533 . T <*> 0 . DP=31;I16=13,17,0,0,1074,39206,0,0,1738,102482,0,0,595,13457,0,0;QS=3,0;MQSB=0.996503;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,180:6:0 0,18,176:6:0 +X 3534 . A <*> 0 . DP=30;I16=12,17,0,0,1014,36168,0,0,1678,98882,0,0,597,13561,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,165:6:0 0,18,175:6:0 +X 3535 . T <*> 0 . DP=31;I16=14,17,0,0,1042,36456,0,0,1767,103323,0,0,624,14314,0,0;QS=3,0;MQSB=0.924242;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,162:6:0 0,18,164:6:0 +X 3536 . C <*> 0 . DP=31;I16=13,17,0,0,1102,41182,0,0,1738,102482,0,0,602,13842,0,0;QS=3,0;MQSB=0.996503;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,178:6:0 0,18,180:6:0 +X 3537 . C <*> 0 . DP=32;I16=13,17,0,0,1142,43828,0,0,1769,105241,0,0,598,13854,0,0;QS=3,0;MQSB=0.963674;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,194:7:0 0,18,185:6:0 +X 3538 . T <*> 0 . DP=32;I16=14,17,0,0,1151,43471,0,0,1798,106082,0,0,603,13923,0,0;QS=3,0;MQSB=0.998229;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,211:7:0 0,18,185:6:0 +X 3539 . C <*> 0 . DP=32;I16=12,17,0,0,1077,40959,0,0,1709,101641,0,0,600,13994,0,0;QS=3,0;MQSB=0.965321;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,170:6:0 0,18,173:6:0 +X 3540 . C <*> 0 . DP=31;I16=13,17,0,0,1134,43546,0,0,1769,105241,0,0,603,14055,0,0;QS=3,0;MQSB=0.963674;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,209:7:0 0,18,172:6:0 +X 3541 . T <*> 0 . DP=32;I16=13,18,0,0,1143,42901,0,0,1829,108841,0,0,604,14134,0,0;QS=3,0;MQSB=0.966712;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,224:8:0 0,18,187:6:0 +X 3542 . G <*> 0 . DP=32;I16=13,18,0,0,1152,43714,0,0,1829,108841,0,0,604,14134,0,0;QS=3,0;MQSB=0.966712;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,223:8:0 0,18,172:6:0 +X 3543 . C <*> 0 . DP=31;I16=13,17,0,0,1142,43818,0,0,1769,105241,0,0,605,14153,0,0;QS=3,0;MQSB=0.963674;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,221:8:0 0,18,188:6:0 +X 3544 . A <*> 0 . DP=31;I16=13,17,0,0,1089,40065,0,0,1769,105241,0,0,606,14190,0,0;QS=3,0;MQSB=0.963674;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,221:8:0 0,18,173:6:0 +X 3545 . A <*> 0 . DP=30;I16=13,16,0,0,1118,43688,0,0,1709,101641,0,0,607,14195,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,228:7:0 0,18,196:6:0 +X 3546 . G <*> 0 . DP=30;I16=14,16,0,0,1131,43425,0,0,1738,102482,0,0,630,14698,0,0;QS=3,0;MQSB=0.999136;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,206:7:0 0,18,179:6:0 +X 3547 . G <*> 0 . DP=31;I16=13,17,0,0,1076,39798,0,0,1769,105241,0,0,607,14163,0,0;QS=3,0;MQSB=0.963674;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,189:7:0 0,18,187:6:0 +X 3548 . A <*> 0 . DP=31;I16=13,17,0,0,1071,39059,0,0,1769,105241,0,0,608,14178,0,0;QS=3,0;MQSB=0.963674;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,208:7:0 0,18,179:6:0 +X 3549 . T <*> 0 . DP=30;I16=13,16,0,0,1008,35928,0,0,1678,98882,0,0,605,13989,0,0;QS=3,0;MQSB=0.997839;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,180:6:0 0,15,152:5:0 +X 3550 . A <*> 0 . DP=30;I16=13,16,0,0,1061,39371,0,0,1709,101641,0,0,612,14270,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,194:7:0 0,15,173:5:0 +X 3551 . T <*> 0 . DP=30;I16=13,16,0,0,1026,36844,0,0,1709,101641,0,0,613,14295,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,192:7:0 0,15,162:5:0 +X 3552 . A <*> 0 . DP=30;I16=14,16,0,0,1080,39588,0,0,1738,102482,0,0,631,14627,0,0;QS=3,0;MQSB=0.999136;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,202:7:0 0,15,158:5:0 +X 3553 . T A,<*> 0 . DP=30;I16=13,16,1,0,1047,38333,20,400,1709,101641,29,841,616,14398,16,256;QS=2.96795,0.0320513,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.999136;BQB=1;MQ0F=0 PL:DP:DV 0,34,255,51,255,255:18:1 0,18,178,18,178,178:6:0 0,18,183,18,183,183:6:0 +X 3554 . A <*> 0 . DP=30;I16=14,16,0,0,1063,38413,0,0,1738,102482,0,0,632,14602,0,0;QS=3,0;MQSB=0.999136;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,185:6:0 0,18,179:6:0 +X 3555 . C <*> 0 . DP=30;I16=14,16,0,0,1021,35781,0,0,1738,102482,0,0,632,14574,0,0;QS=3,0;MQSB=0.999136;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,169:6:0 0,18,163:6:0 +X 3556 . G <*> 0 . DP=30;I16=13,16,0,0,1014,36426,0,0,1709,101641,0,0,618,14350,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,168:6:0 0,18,173:6:0 +X 3557 . C <*> 0 . DP=31;I16=14,16,0,0,1001,34919,0,0,1769,105241,0,0,618,14342,0,0;QS=3,0;MQSB=0.958545;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,140:6:0 0,18,165:6:0 +X 3558 . G <*> 0 . DP=31;I16=15,16,0,0,1036,35974,0,0,1798,106082,0,0,630,14476,0,0;QS=3,0;MQSB=0.999805;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,159:6:0 0,18,171:6:0 +X 3559 . T <*> 0 . DP=30;I16=14,16,0,0,1086,40202,0,0,1769,105241,0,0,619,14341,0,0;QS=3,0;MQSB=0.958545;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,171:6:0 0,18,192:6:0 +X 3560 . G <*> 0 . DP=31;I16=14,16,0,0,1151,45035,0,0,1738,102482,0,0,611,14127,0,0;QS=3,0;MQSB=0.999136;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,165:5:0 0,18,194:6:0 +X 3561 . A <*> 0 . DP=31;I16=15,16,0,0,1147,43431,0,0,1798,106082,0,0,626,14366,0,0;QS=3,0;MQSB=0.999805;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,186:6:0 0,18,196:6:0 +X 3562 . A <*> 0 . DP=31;I16=16,15,0,0,1157,43859,0,0,1798,106082,0,0,623,14257,0,0;QS=3,0;MQSB=0.999805;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,192:6:0 0,21,213:7:0 +X 3563 . A <*> 0 . DP=31;I16=16,15,0,0,1162,44010,0,0,1798,106082,0,0,620,14124,0,0;QS=3,0;MQSB=0.999805;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,192:6:0 0,21,216:7:0 +X 3564 . T <*> 0 . DP=31;I16=15,15,0,0,1132,43298,0,0,1769,105241,0,0,610,13932,0,0;QS=3,0;MQSB=0.952765;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,192:6:0 0,21,214:7:0 +X 3565 . T <*> 0 . DP=32;I16=16,16,0,0,1163,42649,0,0,1858,109682,0,0,611,13791,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,189:6:0 0,21,212:7:0 +X 3566 . C <*> 0 . DP=32;I16=16,16,0,0,1162,43586,0,0,1858,109682,0,0,606,13596,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,181:6:0 0,21,209:7:0 +X 3567 . A <*> 0 . DP=32;I16=15,16,0,0,1181,45245,0,0,1829,108841,0,0,597,13375,0,0;QS=3,0;MQSB=0.957006;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,192:6:0 0,21,222:7:0 +X 3568 . A <*> 0 . DP=32;I16=15,16,0,0,1194,46670,0,0,1829,108841,0,0,592,13200,0,0;QS=3,0;MQSB=0.957006;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,204:6:0 0,21,228:7:0 +X 3569 . G <*> 0 . DP=31;I16=15,16,0,0,1164,44544,0,0,1829,108841,0,0,586,13006,0,0;QS=3,0;MQSB=0.957006;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,180:6:0 0,21,204:7:0 +X 3570 . T <*> 0 . DP=30;I16=14,15,0,0,1029,37527,0,0,1709,101641,0,0,572,12730,0,0;QS=3,0;MQSB=0.954405;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,12,136:4:0 0,21,213:7:0 +X 3571 . C <*> 0 . DP=28;I16=13,15,0,0,1066,41192,0,0,1649,98041,0,0,568,12564,0,0;QS=3,0;MQSB=0.956162;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,138:4:0 0,21,215:7:0 +X 3572 . A <*> 0 . DP=29;I16=13,16,0,0,1108,42566,0,0,1709,101641,0,0,564,12426,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,172:5:0 0,21,218:7:0 +X 3573 . A <*> 0 . DP=29;I16=13,16,0,0,1119,43403,0,0,1709,101641,0,0,558,12168,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,174:5:0 0,21,220:7:0 +X 3574 . T <*> 0 . DP=29;I16=13,16,0,0,1104,42220,0,0,1709,101641,0,0,552,11942,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,175:5:0 0,21,218:7:0 +X 3575 . G <*> 0 . DP=29;I16=13,16,0,0,1122,43748,0,0,1709,101641,0,0,546,11748,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,161:5:0 0,21,212:7:0 +X 3576 . A <*> 0 . DP=29;I16=13,16,0,0,1043,38405,0,0,1709,101641,0,0,540,11586,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,170:5:0 0,21,213:7:0 +X 3577 . C <*> 0 . DP=30;I16=13,17,0,0,1123,42529,0,0,1769,105241,0,0,534,11456,0,0;QS=3,0;MQSB=0.963674;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,161:5:0 0,21,211:7:0 +X 3578 . A <*> 0 . DP=30;I16=13,17,0,0,1148,44236,0,0,1769,105241,0,0,529,11359,0,0;QS=3,0;MQSB=0.963674;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,178:5:0 0,21,216:7:0 +X 3579 . A <*> 0 . DP=29;I16=13,16,0,0,1051,38961,0,0,1709,101641,0,0,524,11244,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,172:5:0 0,18,192:6:0 +X 3580 . A <*> 0 . DP=29;I16=13,16,0,0,1104,42344,0,0,1709,101641,0,0,519,11159,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,172:5:0 0,18,201:6:0 +X 3581 . T <*> 0 . DP=29;I16=13,16,0,0,1088,41226,0,0,1709,101641,0,0,513,11055,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,161:5:0 0,18,199:6:0 +X 3582 . C <*> 0 . DP=29;I16=13,16,0,0,1120,43616,0,0,1709,101641,0,0,506,10934,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,172:5:0 0,18,201:6:0 +X 3583 . A <*> 0 . DP=30;I16=14,16,0,0,1130,43606,0,0,1769,105241,0,0,498,10796,0,0;QS=3,0;MQSB=0.958545;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,183:5:0 0,21,213:7:0 +X 3584 . G <*> 0 . DP=29;I16=12,16,0,0,1027,38895,0,0,1649,98041,0,0,487,10665,0,0;QS=3,0;MQSB=0.96195;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,137:4:0 0,21,209:7:0 +X 3585 . A <*> 0 . DP=31;I16=14,17,0,0,1057,37719,0,0,1829,108841,0,0,486,10616,0,0;QS=3,0;MQSB=0.962133;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,168:5:0 0,24,209:8:0 +X 3586 . A <*> 0 . DP=30;I16=14,15,0,0,1053,40043,0,0,1709,101641,0,0,477,10461,0,0;QS=3,0;MQSB=0.954405;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,174:5:0 0,24,213:8:0 +X 3587 . G A,<*> 0 . DP=29;I16=4,7,10,6,426,16884,555,20381,660,39600,960,57600,192,4420,280,5942;QS=1.32665,1.67335,0;VDB=0.902044;SGB=-3.91326;RPB=0.800999;MQB=1;MQSB=1;BQB=0.156944;MQ0F=0 PL:DP:DV 161,0,184,182,205,255:14:7 22,0,118,34,121,148:5:1 212,24,0,212,24,212:8:8 +X 3588 . A <*> 0 . DP=29;I16=14,14,0,0,999,36973,0,0,1680,100800,0,0,470,10254,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,166:5:0 0,24,215:8:0 +X 3589 . A <*> 0 . DP=28;I16=14,13,0,0,967,35935,0,0,1620,97200,0,0,467,10173,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,166:5:0 0,24,206:8:0 +X 3590 . A <*> 0 . DP=27;I16=13,13,0,0,948,35860,0,0,1560,93600,0,0,464,10072,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,146:4:0 0,24,211:8:0 +X 3591 . A <*> 0 . DP=26;I16=13,13,0,0,913,33539,0,0,1560,93600,0,0,459,9901,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,144:4:0 0,24,212:8:0 +X 3592 . A <*> 0 . DP=26;I16=13,13,0,0,893,32087,0,0,1560,93600,0,0,453,9711,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,143:4:0 0,24,199:8:0 +X 3593 . A <*> 0 . DP=26;I16=13,13,0,0,891,31363,0,0,1560,93600,0,0,447,9553,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,137:4:0 0,24,198:8:0 +X 3594 . C <*> 0 . DP=25;I16=12,12,0,0,910,34868,0,0,1440,86400,0,0,426,9170,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,142:4:0 0,24,216:8:0 +X 3595 . A <*> 0 . DP=24;I16=13,11,0,0,918,35274,0,0,1440,86400,0,0,438,9328,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,143:4:0 0,21,199:7:0 +X 3596 . T <*> 0 . DP=24;I16=13,11,0,0,837,30077,0,0,1440,86400,0,0,434,9258,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,138:4:0 0,21,188:7:0 +X 3597 . A <*> 0 . DP=24;I16=13,11,0,0,893,33549,0,0,1440,86400,0,0,430,9216,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,132:4:0 0,21,204:7:0 +X 3598 . T <*> 0 . DP=23;I16=12,10,0,0,778,28226,0,0,1320,79200,0,0,415,9005,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,140:4:0 0,21,162:7:0 +X 3599 . A <*> 0 . DP=23;I16=13,10,0,0,859,32403,0,0,1380,82800,0,0,425,9105,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,142:4:0 0,21,182:7:0 +X 3600 . T <*> 0 . DP=24;I16=14,10,0,0,872,32086,0,0,1435,85825,0,0,422,9036,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,139:4:0 0,21,183:7:0 +X 3601 . A <*> 0 . DP=24;I16=14,10,0,0,862,31424,0,0,1435,85825,0,0,420,8994,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,132:4:0 0,21,186:7:0 +X 3602 . T <*> 0 . DP=25;I16=15,10,0,0,873,31323,0,0,1495,89425,0,0,418,8980,0,0;QS=3,0;MQSB=0.962269;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,161:5:0 0,21,174:7:0 +X 3603 . A <*> 0 . DP=26;I16=15,11,0,0,907,32447,0,0,1555,93025,0,0,416,8944,0,0;QS=3,0;MQSB=0.960078;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,151:5:0 0,24,216:8:0 +X 3604 . C <*> 0 . DP=27;I16=16,11,0,0,905,31199,0,0,1615,96625,0,0,415,8937,0,0;QS=3,0;MQSB=0.96384;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,147:6:0 0,24,201:8:0 +X 3605 . G <*> 0 . DP=27;I16=15,11,0,0,853,28887,0,0,1555,93025,0,0,393,8477,0,0;QS=3,0;MQSB=0.960078;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,171:6:0 0,21,174:7:0 +X 3606 . C <*> 0 . DP=27;I16=15,12,0,0,982,36756,0,0,1615,96625,0,0,415,8967,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,187:6:0 0,27,231:9:0 +X 3607 . A <*> 0 . DP=26;I16=15,11,0,0,927,33859,0,0,1555,93025,0,0,417,9005,0,0;QS=3,0;MQSB=0.960078;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,183:6:0 0,27,232:9:0 +X 3608 . A <*> 0 . DP=27;I16=14,12,0,0,930,34054,0,0,1555,93025,0,0,394,8450,0,0;QS=3,0;MQSB=0.953497;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,176:6:0 0,24,232:8:0 +X 3609 . A <*> 0 . DP=27;I16=15,12,0,0,955,34701,0,0,1615,96625,0,0,421,9127,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,186:6:0 0,27,238:9:0 +X 3610 . C <*> 0 . DP=27;I16=14,12,0,0,915,33071,0,0,1555,93025,0,0,397,8537,0,0;QS=3,0;MQSB=0.953497;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,172:6:0 0,24,221:8:0 +X 3611 . C <*> 0 . DP=25;I16=13,11,0,0,899,33995,0,0,1435,85825,0,0,398,8502,0,0;QS=3,0;MQSB=0.950498;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,173:6:0 0,24,234:8:0 +X 3612 . A <*> 0 . DP=25;I16=14,11,0,0,957,37723,0,0,1495,89425,0,0,424,9118,0,0;QS=3,0;MQSB=0.955682;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,194:6:0 0,27,251:9:0 +X 3613 . G <*> 0 . DP=26;I16=13,12,0,0,902,33110,0,0,1495,89425,0,0,399,8461,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,172:6:0 0,24,223:8:0 +X 3614 . T <*> 0 . DP=26;I16=14,12,0,0,912,33340,0,0,1555,93025,0,0,425,9083,0,0;QS=3,0;MQSB=0.953497;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,156:6:0 0,27,237:9:0 +X 3615 . A <*> 0 . DP=26;I16=15,11,0,0,946,35138,0,0,1555,93025,0,0,427,9109,0,0;QS=3,0;MQSB=0.960078;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,176:6:0 0,27,242:9:0 +X 3616 . T <*> 0 . DP=26;I16=15,11,0,0,965,36541,0,0,1555,93025,0,0,431,9163,0,0;QS=3,0;MQSB=0.960078;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,185:6:0 0,27,238:9:0 +X 3617 . C <*> 0 . DP=25;I16=14,11,0,0,907,33675,0,0,1495,89425,0,0,436,9196,0,0;QS=3,0;MQSB=0.955682;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,176:6:0 0,24,215:8:0 +X 3618 . C <*> 0 . DP=25;I16=14,11,0,0,964,37698,0,0,1495,89425,0,0,441,9259,0,0;QS=3,0;MQSB=0.955682;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,190:6:0 0,24,225:8:0 +X 3619 . T <*> 0 . DP=25;I16=14,11,0,0,961,37553,0,0,1495,89425,0,0,446,9352,0,0;QS=3,0;MQSB=0.955682;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,194:6:0 0,24,238:8:0 +X 3620 . A <*> 0 . DP=25;I16=14,11,0,0,880,31656,0,0,1495,89425,0,0,451,9475,0,0;QS=3,0;MQSB=0.955682;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,178:6:0 0,24,212:8:0 +X 3621 . C <*> 0 . DP=25;I16=14,11,0,0,949,36561,0,0,1495,89425,0,0,456,9628,0,0;QS=3,0;MQSB=0.955682;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,182:6:0 0,24,230:8:0 +X 3622 . T <*> 0 . DP=26;I16=15,11,0,0,983,38067,0,0,1555,93025,0,0,460,9762,0,0;QS=3,0;MQSB=0.960078;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,194:7:0 0,24,242:8:0 +X 3623 . G <*> 0 . DP=27;I16=16,11,0,0,969,35645,0,0,1615,96625,0,0,465,9929,0,0;QS=3,0;MQSB=0.96384;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,195:7:0 0,24,209:8:0 +X 3624 . T <*> 0 . DP=27;I16=15,11,0,0,948,35330,0,0,1555,93025,0,0,448,9596,0,0;QS=3,0;MQSB=0.960078;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,188:6:0 0,24,224:8:0 +X 3625 . G <*> 0 . DP=27;I16=14,12,0,0,983,37483,0,0,1555,93025,0,0,453,9735,0,0;QS=3,0;MQSB=0.953497;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,210:7:0 0,24,219:8:0 +X 3626 . T <*> 0 . DP=28;I16=15,12,0,0,998,37364,0,0,1615,96625,0,0,458,9854,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,214:7:0 0,27,229:9:0 +X 3627 . G <*> 0 . DP=29;I16=15,13,0,0,999,36375,0,0,1675,100225,0,0,464,10004,0,0;QS=3,0;MQSB=0.956162;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,199:7:0 0,27,224:9:0 +X 3628 . T <*> 0 . DP=29;I16=15,13,0,0,1033,38721,0,0,1675,100225,0,0,471,10187,0,0;QS=3,0;MQSB=0.956162;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,206:7:0 0,27,232:9:0 +X 3629 . G <*> 0 . DP=29;I16=15,13,0,0,1058,40226,0,0,1675,100225,0,0,476,10304,0,0;QS=3,0;MQSB=0.956162;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,207:7:0 0,27,235:9:0 +X 3630 . T <*> 0 . DP=30;I16=15,14,0,0,1052,39072,0,0,1735,103825,0,0,480,10404,0,0;QS=3,0;MQSB=0.954405;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,216:7:0 0,27,223:9:0 +X 3631 . C <*> 0 . DP=29;I16=13,14,0,0,884,29476,0,0,1615,96625,0,0,461,9911,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,186:7:0 0,21,179:7:0 +X 3632 . G <*> 0 . DP=29;I16=14,14,0,0,914,31068,0,0,1675,100225,0,0,491,10649,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,183:7:0 0,24,181:8:0 +X 3633 . T <*> 0 . DP=29;I16=14,14,0,0,1022,38214,0,0,1675,100225,0,0,496,10792,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,216:7:0 0,24,222:8:0 +X 3634 . T <*> 0 . DP=29;I16=14,14,0,0,1043,39891,0,0,1675,100225,0,0,500,10914,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,219:7:0 0,24,227:8:0 +X 3635 . T <*> 0 . DP=28;I16=13,14,0,0,1029,39507,0,0,1615,96625,0,0,505,11063,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,219:7:0 0,24,224:8:0 +X 3636 . G <*> 0 . DP=28;I16=13,14,0,0,1001,37681,0,0,1615,96625,0,0,510,11238,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,201:7:0 0,24,217:8:0 +X 3637 . T <*> 0 . DP=27;I16=13,14,0,0,1019,39331,0,0,1615,96625,0,0,515,11439,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,212:7:0 0,24,240:8:0 +X 3638 . T <*> 0 . DP=26;I16=12,14,0,0,967,36467,0,0,1555,93025,0,0,520,11616,0,0;QS=3,0;MQSB=0.937241;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,185:6:0 0,24,222:8:0 +X 3639 . G <*> 0 . DP=27;I16=13,14,0,0,997,37265,0,0,1615,96625,0,0,524,11768,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,183:6:0 0,27,221:9:0 +X 3640 . T <*> 0 . DP=27;I16=13,14,0,0,1001,37533,0,0,1615,96625,0,0,527,11847,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,191:6:0 0,27,229:9:0 +X 3641 . G <*> 0 . DP=27;I16=13,14,0,0,977,36379,0,0,1615,96625,0,0,529,11905,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,178:6:0 0,27,224:9:0 +X 3642 . T <*> 0 . DP=26;I16=12,13,0,0,931,35169,0,0,1495,89425,0,0,506,11314,0,0;QS=3,0;MQSB=0.939413;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,169:5:0 0,24,225:8:0 +X 3643 . T <*> 0 . DP=26;I16=13,13,0,0,968,36820,0,0,1555,93025,0,0,533,11997,0,0;QS=3,0;MQSB=0.945959;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,176:5:0 0,27,230:9:0 +X 3644 . T <*> 0 . DP=26;I16=12,13,0,0,961,37477,0,0,1495,89425,0,0,517,11755,0,0;QS=3,0;MQSB=0.939413;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,175:5:0 0,24,236:8:0 +X 3645 . T <*> 0 . DP=26;I16=13,13,0,0,980,37508,0,0,1555,93025,0,0,537,12185,0,0;QS=3,0;MQSB=0.945959;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,175:5:0 0,27,239:9:0 +X 3646 . C <*> 0 . DP=26;I16=12,13,0,0,766,25026,0,0,1495,89425,0,0,514,11690,0,0;QS=3,0;MQSB=0.939413;MQ0F=0 PL:DP:DV 0,33,234:11:0 0,15,136:5:0 0,27,188:9:0 +X 3647 . G <*> 0 . DP=26;I16=12,12,0,0,820,29600,0,0,1435,85825,0,0,492,11218,0,0;QS=3,0;MQSB=0.941765;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,151:5:0 0,21,173:7:0 +X 3648 . A <*> 0 . DP=26;I16=13,12,0,0,924,34680,0,0,1495,89425,0,0,519,11919,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,174:5:0 0,24,225:8:0 +X 3649 . C <*> 0 . DP=26;I16=14,12,0,0,955,36105,0,0,1555,93025,0,0,545,12593,0,0;QS=3,0;MQSB=0.953497;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,173:5:0 0,27,226:9:0 +X 3650 . A <*> 0 . DP=27;I16=15,12,0,0,1033,40511,0,0,1615,96625,0,0,546,12664,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,196:6:0 0,27,246:9:0 +X 3651 . G <*> 0 . DP=27;I16=15,12,0,0,1035,40351,0,0,1615,96625,0,0,547,12707,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,194:6:0 0,27,233:9:0 +X 3652 . C <*> 0 . DP=29;I16=15,13,0,0,1010,38264,0,0,1675,100225,0,0,521,12047,0,0;QS=3,0;MQSB=0.956162;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,198:6:0 0,27,225:9:0 +X 3653 . T <*> 0 . DP=29;I16=16,13,0,0,1109,42919,0,0,1735,103825,0,0,546,12610,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,202:6:0 0,27,239:9:0 +X 3654 . G <*> 0 . DP=28;I16=14,12,0,0,981,37447,0,0,1555,93025,0,0,514,11882,0,0;QS=3,0;MQSB=0.953497;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,184:6:0 0,18,180:6:0 +X 3655 . T <*> 0 . DP=28;I16=16,12,0,0,999,37029,0,0,1675,100225,0,0,541,12505,0,0;QS=3,0;MQSB=0.96195;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,190:6:0 0,21,179:7:0 +X 3656 . C <*> 0 . DP=28;I16=15,12,0,0,963,35883,0,0,1615,96625,0,0,518,11848,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,164:5:0 0,21,191:7:0 +X 3657 . C <*> 0 . DP=28;I16=15,12,0,0,923,32223,0,0,1615,96625,0,0,520,11836,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,154:5:0 0,21,192:7:0 +X 3658 . G <*> 0 . DP=28;I16=15,12,0,0,876,29960,0,0,1615,96625,0,0,539,12405,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,142:5:0 0,21,163:7:0 +X 3659 . T <*> 0 . DP=28;I16=16,12,0,0,996,36682,0,0,1675,100225,0,0,548,12448,0,0;QS=3,0;MQSB=0.96195;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,163:6:0 0,21,186:7:0 +X 3660 . G <*> 0 . DP=28;I16=15,12,0,0,997,37571,0,0,1615,96625,0,0,526,11920,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,172:6:0 0,18,171:6:0 +X 3661 . T <*> 0 . DP=28;I16=16,12,0,0,1013,37837,0,0,1675,100225,0,0,549,12423,0,0;QS=3,0;MQSB=0.96195;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,180:6:0 0,21,188:7:0 +X 3662 . T <*> 0 . DP=28;I16=15,12,0,0,987,36627,0,0,1615,96625,0,0,528,11980,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,182:6:0 0,18,184:6:0 +X 3663 . A <*> 0 . DP=29;I16=16,12,0,0,997,36233,0,0,1675,100225,0,0,527,11959,0,0;QS=3,0;MQSB=0.96195;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,170:6:0 0,18,180:6:0 +X 3664 . T <*> 0 . DP=29;I16=17,12,0,0,1044,38402,0,0,1735,103825,0,0,550,12490,0,0;QS=3,0;MQSB=0.965321;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,183:6:0 0,21,196:7:0 +X 3665 . A <*> 0 . DP=27;I16=16,11,0,0,1017,38535,0,0,1615,96625,0,0,552,12510,0,0;QS=3,0;MQSB=0.96384;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,182:6:0 0,21,208:7:0 +X 3666 . A <*> 0 . DP=27;I16=16,11,0,0,1036,40292,0,0,1615,96625,0,0,554,12550,0,0;QS=3,0;MQSB=0.96384;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,193:6:0 0,21,208:7:0 +X 3667 . T <*> 0 . DP=27;I16=15,11,0,0,955,35895,0,0,1555,93025,0,0,540,12354,0,0;QS=3,0;MQSB=0.960078;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,189:6:0 0,18,189:6:0 +X 3668 . A <*> 0 . DP=27;I16=16,11,0,0,981,36297,0,0,1615,96625,0,0,557,12641,0,0;QS=3,0;MQSB=0.96384;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,182:6:0 0,21,209:7:0 +X 3669 . A <*> 0 . DP=27;I16=16,11,0,0,1030,39666,0,0,1615,96625,0,0,558,12694,0,0;QS=3,0;MQSB=0.96384;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,194:6:0 0,21,209:7:0 +X 3670 . T <*> 0 . DP=28;I16=17,11,0,0,1057,40245,0,0,1675,100225,0,0,559,12769,0,0;QS=3,0;MQSB=0.967085;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,181:6:0 0,24,220:8:0 +X 3671 . T <*> 0 . DP=28;I16=17,11,0,0,1059,40427,0,0,1675,100225,0,0,561,12867,0,0;QS=3,0;MQSB=0.967085;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,193:6:0 0,24,223:8:0 +X 3672 . C <*> 0 . DP=28;I16=16,11,0,0,988,37264,0,0,1615,96625,0,0,550,12820,0,0;QS=3,0;MQSB=0.96384;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,169:6:0 0,21,205:7:0 +X 3673 . C <*> 0 . DP=27;I16=16,10,0,0,1016,40148,0,0,1555,93025,0,0,528,12314,0,0;QS=3,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,154:5:0 0,24,219:8:0 +X 3674 . T <*> 0 . DP=27;I16=17,10,0,0,1035,40645,0,0,1615,96625,0,0,556,13028,0,0;QS=3,0;MQSB=0.968979;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,155:5:0 0,24,228:8:0 +X 3675 . C <*> 0 . DP=27;I16=17,10,0,0,1049,41413,0,0,1615,96625,0,0,558,13090,0,0;QS=3,0;MQSB=0.968979;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,149:5:0 0,24,222:8:0 +X 3676 . T <*> 0 . DP=27;I16=17,10,0,0,1040,40640,0,0,1615,96625,0,0,559,13125,0,0;QS=3,0;MQSB=0.968979;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,159:5:0 0,24,231:8:0 +X 3677 . A <*> 0 . DP=27;I16=16,10,0,0,922,34182,0,0,1555,93025,0,0,537,12557,0,0;QS=3,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,136:5:0 0,24,217:8:0 +X 3678 . G <*> 0 . DP=27;I16=17,10,0,0,1009,38307,0,0,1615,96625,0,0,563,13159,0,0;QS=3,0;MQSB=0.968979;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,149:5:0 0,24,216:8:0 +X 3679 . T <*> 0 . DP=27;I16=17,10,0,0,1018,39274,0,0,1615,96625,0,0,563,13105,0,0;QS=3,0;MQSB=0.968979;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,156:5:0 0,24,227:8:0 +X 3680 . T <*> 0 . DP=27;I16=17,10,0,0,988,36872,0,0,1615,96625,0,0,562,13022,0,0;QS=3,0;MQSB=0.968979;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,157:5:0 0,24,202:8:0 +X 3681 . C <*> 0 . DP=27;I16=17,10,0,0,1012,39154,0,0,1615,96625,0,0,560,12910,0,0;QS=3,0;MQSB=0.968979;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,157:5:0 0,24,217:8:0 +X 3682 . A <*> 0 . DP=27;I16=17,10,0,0,1009,38221,0,0,1615,96625,0,0,557,12769,0,0;QS=3,0;MQSB=0.968979;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,156:5:0 0,24,220:8:0 +X 3683 . A <*> 0 . DP=27;I16=17,9,0,0,966,36748,0,0,1555,93025,0,0,546,12552,0,0;QS=3,0;MQSB=0.971017;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,153:5:0 0,24,225:8:0 +X 3684 . A <*> 0 . DP=26;I16=16,10,0,0,974,37440,0,0,1555,93025,0,0,550,12456,0,0;QS=3,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,155:5:0 0,21,215:7:0 +X 3685 . T <*> 0 . DP=26;I16=16,10,0,0,954,36330,0,0,1555,93025,0,0,547,12333,0,0;QS=3,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,148:5:0 0,21,207:7:0 +X 3686 . T <*> 0 . DP=26;I16=16,10,0,0,979,37645,0,0,1555,93025,0,0,544,12232,0,0;QS=3,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,162:5:0 0,21,216:7:0 +X 3687 . T <*> 0 . DP=27;I16=16,11,0,0,1028,39276,0,0,1592,94394,0,0,541,12153,0,0;QS=3,0;MQSB=0.989102;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,159:5:0 0,24,229:8:0 +X 3688 . A <*> 0 . DP=28;I16=17,10,0,0,1007,37883,0,0,1569,92163,0,0,526,11904,0,0;QS=3,0;MQSB=0.99874;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,148:5:0 0,24,232:8:0 +X 3689 . T <*> 0 . DP=28;I16=17,11,0,0,1042,39780,0,0,1629,95763,0,0,535,11919,0,0;QS=3,0;MQSB=0.995584;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,162:5:0 0,24,233:8:0 +X 3690 . T <*> 0 . DP=28;I16=17,11,0,0,1051,39981,0,0,1629,95763,0,0,532,11816,0,0;QS=3,0;MQSB=0.995584;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,160:5:0 0,24,225:8:0 +X 3691 . C <*> 0 . DP=28;I16=16,11,0,0,1037,40549,0,0,1569,92163,0,0,520,11592,0,0;QS=3,0;MQSB=0.992419;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,155:5:0 0,21,214:7:0 +X 3692 . A <*> 0 . DP=29;I16=18,11,0,0,1028,37574,0,0,1689,99363,0,0,522,11496,0,0;QS=3,0;MQSB=0.99773;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,156:5:0 0,24,209:8:0 +X 3693 . T <*> 0 . DP=28;I16=18,10,0,0,1067,40901,0,0,1629,95763,0,0,519,11381,0,0;QS=3,0;MQSB=0.999713;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,160:5:0 0,24,230:8:0 +X 3694 . T <*> 0 . DP=28;I16=18,10,0,0,1043,39659,0,0,1629,95763,0,0,516,11296,0,0;QS=3,0;MQSB=0.999713;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,159:5:0 0,24,234:8:0 +X 3695 . T <*> 0 . DP=28;I16=18,10,0,0,1046,39662,0,0,1629,95763,0,0,513,11241,0,0;QS=3,0;MQSB=0.999713;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,156:5:0 0,24,233:8:0 +X 3696 . T <*> 0 . DP=28;I16=18,10,0,0,1075,41567,0,0,1629,95763,0,0,509,11165,0,0;QS=3,0;MQSB=0.999713;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,162:5:0 0,24,235:8:0 +X 3697 . T <*> 0 . DP=28;I16=18,10,0,0,1031,38399,0,0,1629,95763,0,0,505,11117,0,0;QS=3,0;MQSB=0.999713;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,155:5:0 0,24,229:8:0 +X 3698 . A <*> 0 . DP=28;I16=18,9,0,0,983,36457,0,0,1569,92163,0,0,477,10515,0,0;QS=3,0;MQSB=0.999669;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,144:5:0 0,24,229:8:0 +X 3699 . A <*> 0 . DP=27;I16=17,10,0,0,1011,38455,0,0,1569,92163,0,0,493,10861,0,0;QS=3,0;MQSB=0.99874;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,150:5:0 0,21,226:7:0 +X 3700 . C <*> 0 . DP=28;I16=16,11,0,0,970,35910,0,0,1574,92738,0,0,473,10525,0,0;QS=3,0;MQSB=0.992419;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,168:6:0 0,24,212:8:0 +X 3701 . T <*> 0 . DP=28;I16=17,11,0,0,1071,41669,0,0,1634,96338,0,0,484,10618,0,0;QS=3,0;MQSB=0.990092;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,196:6:0 0,24,233:8:0 +X 3702 . T <*> 0 . DP=28;I16=17,10,0,0,1019,38653,0,0,1597,94969,0,0,462,10144,0,0;QS=3,0;MQSB=0.968979;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,184:6:0 0,21,207:7:0 +X 3703 . C <*> 0 . DP=28;I16=17,11,0,0,1059,40561,0,0,1634,96338,0,0,470,10154,0,0;QS=3,0;MQSB=0.990092;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,183:6:0 0,24,232:8:0 +X 3704 . A <*> 0 . DP=28;I16=17,10,0,0,1015,38483,0,0,1574,92738,0,0,439,9347,0,0;QS=3,0;MQSB=0.984677;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,182:6:0 0,21,211:7:0 +X 3705 . T <*> 0 . DP=27;I16=17,10,0,0,992,37112,0,0,1574,92738,0,0,459,9773,0,0;QS=3,0;MQSB=0.984677;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,180:6:0 0,21,209:7:0 +X 3706 . A <*> 0 . DP=27;I16=17,10,0,0,1040,40262,0,0,1574,92738,0,0,454,9608,0,0;QS=3,0;MQSB=0.984677;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,186:6:0 0,21,204:7:0 +X 3707 . G <*> 0 . DP=26;I16=17,9,0,0,974,37394,0,0,1514,89138,0,0,450,9476,0,0;QS=3,0;MQSB=0.977029;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,173:6:0 0,18,168:6:0 +X 3708 . T <*> 0 . DP=26;I16=18,7,0,0,911,33609,0,0,1454,85538,0,0,426,8934,0,0;QS=3,0;MQSB=0.914166;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,182:6:0 0,15,139:5:0 +X 3709 . A <*> 0 . DP=26;I16=18,8,0,0,905,32473,0,0,1491,86907,0,0,445,9305,0,0;QS=3,0;MQSB=0.998458;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,168:6:0 0,18,162:6:0 +X 3710 . C <*> 0 . DP=26;I16=18,8,0,0,924,33504,0,0,1491,86907,0,0,443,9267,0,0;QS=3,0;MQSB=0.998458;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,165:6:0 0,18,159:6:0 +X 3711 . C <*> 0 . DP=26;I16=18,8,0,0,953,35965,0,0,1491,86907,0,0,441,9261,0,0;QS=3,0;MQSB=0.998458;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,164:6:0 0,18,173:6:0 +X 3712 . A <*> 0 . DP=26;I16=18,8,0,0,893,31917,0,0,1491,86907,0,0,439,9287,0,0;QS=3,0;MQSB=0.998458;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,144:6:0 0,18,165:6:0 +X 3713 . C <*> 0 . DP=26;I16=19,7,0,0,908,32834,0,0,1491,86907,0,0,437,9293,0,0;QS=3,0;MQSB=0.989612;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,163:6:0 0,18,164:6:0 +X 3714 . A <*> 0 . DP=27;I16=19,6,0,0,920,34366,0,0,1408,81076,0,0,409,8651,0,0;QS=3,0;MQSB=0.999494;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,177:6:0 0,18,174:6:0 +X 3715 . T <*> 0 . DP=28;I16=21,6,0,0,982,36286,0,0,1505,86045,0,0,408,8616,0,0;QS=3,0;MQSB=0.996181;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,180:6:0 0,18,164:6:0 +X 3716 . T <*> 0 . DP=26;I16=19,7,0,0,927,33833,0,0,1445,82445,0,0,434,9236,0,0;QS=3,0;MQSB=0.966731;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,165:5:0 0,18,164:6:0 +X 3717 . C <*> 0 . DP=26;I16=19,7,0,0,979,37527,0,0,1445,82445,0,0,435,9261,0,0;QS=3,0;MQSB=0.966731;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,165:5:0 0,18,168:6:0 +X 3718 . T <*> 0 . DP=26;I16=19,7,0,0,994,39040,0,0,1445,82445,0,0,435,9265,0,0;QS=3,0;MQSB=0.966731;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,169:5:0 0,18,165:6:0 +X 3719 . A <*> 0 . DP=26;I16=19,6,0,0,889,32163,0,0,1408,81076,0,0,410,8672,0,0;QS=3,0;MQSB=0.747144;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,148:5:0 0,15,142:5:0 +X 3720 . C <*> 0 . DP=26;I16=19,7,0,0,934,34326,0,0,1445,82445,0,0,435,9357,0,0;QS=3,0;MQSB=0.966731;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,148:5:0 0,18,158:6:0 +X 3721 . A <*> 0 . DP=27;I16=20,5,0,0,910,33944,0,0,1405,80725,0,0,385,8195,0,0;QS=3,0;MQSB=0.697274;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,153:5:0 0,15,145:5:0 +X 3722 . C <*> 0 . DP=27;I16=20,7,0,0,964,35276,0,0,1502,85694,0,0,436,9562,0,0;QS=3,0;MQSB=0.927743;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,151:5:0 0,18,165:6:0 +X 3723 . A <*> 0 . DP=25;I16=18,6,0,0,888,33516,0,0,1345,77125,0,0,414,9082,0,0;QS=3,0;MQSB=0.606531;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,134:4:0 0,15,145:5:0 +X 3724 . C <*> 0 . DP=25;I16=18,7,0,0,944,35956,0,0,1382,78494,0,0,442,9878,0,0;QS=3,0;MQSB=0.889393;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,137:4:0 0,18,169:6:0 +X 3725 . T <*> 0 . DP=25;I16=18,7,0,0,973,38263,0,0,1382,78494,0,0,445,10075,0,0;QS=3,0;MQSB=0.889393;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,138:4:0 0,18,190:6:0 +X 3726 . G <*> 0 . DP=24;I16=18,6,0,0,865,32339,0,0,1322,74894,0,0,446,10146,0,0;QS=3,0;MQSB=0.934987;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,93:3:0 0,18,166:6:0 +X 3727 . C <*> 0 . DP=22;I16=17,5,0,0,762,27812,0,0,1202,67694,0,0,447,10139,0,0;QS=3,0;MQSB=0.963102;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,82:3:0 0,15,143:5:0 +X 3728 . C <*> 0 . DP=22;I16=17,5,0,0,792,29850,0,0,1202,67694,0,0,448,10154,0,0;QS=3,0;MQSB=0.963102;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,89:3:0 0,15,160:5:0 +X 3729 . C <*> 0 . DP=22;I16=17,5,0,0,838,32312,0,0,1202,67694,0,0,449,10191,0,0;QS=3,0;MQSB=0.963102;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,93:3:0 0,15,164:5:0 +X 3730 . A <*> 0 . DP=21;I16=17,4,0,0,749,27561,0,0,1142,64094,0,0,448,10100,0,0;QS=3,0;MQSB=0.995997;MQ0F=0 PL:DP:DV 0,39,241:13:0 0,9,98:3:0 0,15,159:5:0 +X 3731 . T <*> 0 . DP=22;I16=18,4,0,0,787,29489,0,0,1152,64194,0,0,447,10031,0,0;QS=3,0;MQSB=0.967917;MQ0F=0 PL:DP:DV 0,42,253:14:0 0,9,101:3:0 0,15,139:5:0 +X 3732 . G <*> 0 . DP=22;I16=18,4,0,0,811,30695,0,0,1152,64194,0,0,447,9985,0,0;QS=3,0;MQSB=0.967917;MQ0F=0 PL:DP:DV 0,42,252:14:0 0,9,101:3:0 0,15,149:5:0 +X 3733 . T <*> 0 . DP=23;I16=19,4,0,0,820,29616,0,0,1212,67794,0,0,447,9963,0,0;QS=3,0;MQSB=0.979651;MQ0F=0 PL:DP:DV 0,45,248:15:0 0,9,101:3:0 0,15,152:5:0 +X 3734 . C <*> 0 . DP=24;I16=20,4,0,0,863,32277,0,0,1272,71394,0,0,447,9915,0,0;QS=3,0;MQSB=0.988072;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,86:3:0 0,15,152:5:0 +X 3735 . C <*> 0 . DP=24;I16=20,4,0,0,826,30112,0,0,1272,71394,0,0,448,9892,0,0;QS=3,0;MQSB=0.988072;MQ0F=0 PL:DP:DV 0,48,254:16:0 0,9,83:3:0 0,15,152:5:0 +X 3736 . C <*> 0 . DP=25;I16=20,3,0,0,839,31471,0,0,1262,71294,0,0,419,9245,0,0;QS=3,0;MQSB=0.963194;MQ0F=0 PL:DP:DV 0,42,235:14:0 0,9,99:3:0 0,18,156:6:0 +X 3737 . C <*> 0 . DP=25;I16=21,4,0,0,894,33402,0,0,1332,74994,0,0,451,9925,0,0;QS=3,0;MQSB=0.993838;MQ0F=0 PL:DP:DV 0,48,251:16:0 0,9,95:3:0 0,18,175:6:0 +X 3738 . T <*> 0 . DP=25;I16=21,4,0,0,926,35484,0,0,1332,74994,0,0,452,9934,0,0;QS=3,0;MQSB=0.993838;MQ0F=0 PL:DP:DV 0,48,253:16:0 0,9,101:3:0 0,18,189:6:0 +X 3739 . C <*> 0 . DP=25;I16=21,4,0,0,958,37390,0,0,1332,74994,0,0,452,9922,0,0;QS=3,0;MQSB=0.993838;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,105:3:0 0,18,181:6:0 +X 3740 . A <*> 0 . DP=24;I16=20,4,0,0,848,31126,0,0,1272,71394,0,0,452,9886,0,0;QS=3,0;MQSB=0.988072;MQ0F=0 PL:DP:DV 0,48,247:16:0 0,9,109:3:0 0,15,163:5:0 +X 3741 . A <*> 0 . DP=24;I16=19,4,0,0,814,30176,0,0,1212,67794,0,0,442,9742,0,0;QS=3,0;MQSB=0.979651;MQ0F=0 PL:DP:DV 0,48,238:16:0 0,6,82:2:0 0,15,172:5:0 +X 3742 . G <*> 0 . DP=24;I16=20,4,0,0,893,34371,0,0,1272,71394,0,0,450,9782,0,0;QS=3,0;MQSB=0.988072;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,101:3:0 0,15,162:5:0 +X 3743 . C <*> 0 . DP=24;I16=19,4,0,0,839,31673,0,0,1262,71294,0,0,437,9619,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,254:15:0 0,9,103:3:0 0,15,158:5:0 +X 3744 . T <*> 0 . DP=24;I16=20,4,0,0,918,36126,0,0,1272,71394,0,0,448,9766,0,0;QS=3,0;MQSB=0.988072;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,118:3:0 0,15,164:5:0 +X 3745 . T <*> 0 . DP=24;I16=19,4,0,0,808,29490,0,0,1212,67794,0,0,422,9166,0,0;QS=3,0;MQSB=0.979651;MQ0F=0 PL:DP:DV 0,45,233:15:0 0,9,108:3:0 0,15,158:5:0 +X 3746 . C <*> 0 . DP=24;I16=20,4,0,0,886,33564,0,0,1272,71394,0,0,445,9789,0,0;QS=3,0;MQSB=0.988072;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,101:3:0 0,15,165:5:0 +X 3747 . C <*> 0 . DP=24;I16=19,4,0,0,833,31071,0,0,1262,71294,0,0,426,9504,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,249:15:0 0,9,103:3:0 0,15,162:5:0 +X 3748 . C <*> 0 . DP=24;I16=19,4,0,0,845,31753,0,0,1262,71294,0,0,422,9464,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,106:3:0 0,15,161:5:0 +X 3749 . C <*> 0 . DP=24;I16=19,4,0,0,844,31888,0,0,1262,71294,0,0,417,9395,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,250:15:0 0,9,111:3:0 0,15,154:5:0 +X 3750 . T <*> 0 . DP=25;I16=21,4,0,0,876,32880,0,0,1309,72763,0,0,431,9709,0,0;QS=3,0;MQSB=0.966906;MQ0F=0 PL:DP:DV 0,51,251:17:0 0,9,112:3:0 0,15,146:5:0 +X 3751 . G <*> 0 . DP=24;I16=19,4,0,0,836,31374,0,0,1239,69063,0,0,408,9274,0,0;QS=3,0;MQSB=0.986928;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,82:2:0 0,15,162:5:0 +X 3752 . G <*> 0 . DP=22;I16=19,2,0,0,728,26270,0,0,1069,58363,0,0,404,9134,0,0;QS=3,0;MQSB=0.868421;MQ0F=0 PL:DP:DV 0,42,182:14:0 0,6,74:2:0 0,15,159:5:0 +X 3753 . C <*> 0 . DP=22;I16=19,3,0,0,761,28017,0,0,1129,61963,0,0,426,9674,0,0;QS=3,0;MQSB=0.995434;MQ0F=0 PL:DP:DV 0,45,213:15:0 0,6,61:2:0 0,15,163:5:0 +X 3754 . T <*> 0 . DP=23;I16=19,3,0,0,767,28751,0,0,1129,61963,0,0,425,9707,0,0;QS=3,0;MQSB=0.995434;MQ0F=0 PL:DP:DV 0,45,218:15:0 0,6,69:2:0 0,15,157:5:0 +X 3755 . C <*> 0 . DP=21;I16=16,4,0,0,749,28747,0,0,1028,55504,0,0,404,9188,0,0;QS=3,0;MQSB=0.777932;MQ0F=0 PL:DP:DV 0,36,219:12:0 0,9,93:3:0 0,15,161:5:0 +X 3756 . C <*> 0 . DP=22;I16=17,4,0,0,782,29994,0,0,1038,55604,0,0,430,9840,0,0;QS=3,0;MQSB=0.885747;MQ0F=0 PL:DP:DV 0,39,229:13:0 0,9,93:3:0 0,15,159:5:0 +X 3757 . T <*> 0 . DP=23;I16=17,6,0,0,828,30942,0,0,1158,62804,0,0,456,10510,0,0;QS=3,0;MQSB=0.9945;MQ0F=0 PL:DP:DV 0,39,210:13:0 0,15,143:5:0 0,15,169:5:0 +X 3758 . G <*> 0 . DP=23;I16=17,6,0,0,832,30792,0,0,1158,62804,0,0,458,10574,0,0;QS=3,0;MQSB=0.9945;MQ0F=0 PL:DP:DV 0,39,220:13:0 0,15,135:5:0 0,15,147:5:0 +X 3759 . C <*> 0 . DP=23;I16=17,4,0,0,756,28338,0,0,1061,57835,0,0,409,9357,0,0;QS=3,0;MQSB=0.964547;MQ0F=0 PL:DP:DV 0,39,220:13:0 0,12,112:4:0 0,12,127:4:0 +X 3760 . A <*> 0 . DP=24;I16=17,7,0,0,792,27956,0,0,1218,66404,0,0,459,10607,0,0;QS=3,0;MQSB=0.95083;MQ0F=0 PL:DP:DV 0,39,203:13:0 0,15,127:5:0 0,18,180:6:0 +X 3761 . A <*> 0 . DP=24;I16=17,7,0,0,871,32185,0,0,1218,66404,0,0,460,10624,0,0;QS=3,0;MQSB=0.95083;MQ0F=0 PL:DP:DV 0,39,215:13:0 0,15,136:5:0 0,18,188:6:0 +X 3762 . C <*> 0 . DP=25;I16=17,7,0,0,831,29665,0,0,1241,68635,0,0,435,9983,0,0;QS=3,0;MQSB=0.69242;MQ0F=0 PL:DP:DV 0,39,209:13:0 0,18,149:6:0 0,15,159:5:0 +X 3763 . C <*> 0 . DP=24;I16=16,8,0,0,837,30619,0,0,1218,66404,0,0,460,10510,0,0;QS=3,0;MQSB=0.844324;MQ0F=0 PL:DP:DV 0,36,213:12:0 0,18,149:6:0 0,18,186:6:0 +X 3764 . A <*> 0 . DP=25;I16=17,7,0,0,856,31506,0,0,1241,68635,0,0,437,9903,0,0;QS=3,0;MQSB=0.69242;MQ0F=0 PL:DP:DV 0,39,212:13:0 0,18,139:6:0 0,15,167:5:0 +X 3765 . C <*> 0 . DP=25;I16=17,7,0,0,845,31099,0,0,1218,66404,0,0,436,9750,0,0;QS=3,0;MQSB=0.95083;MQ0F=0 PL:DP:DV 0,39,200:13:0 0,15,129:5:0 0,18,189:6:0 +X 3766 . A <*> 0 . DP=26;I16=17,9,0,0,953,35331,0,0,1338,73604,0,0,462,10340,0,0;QS=3,0;MQSB=0.811273;MQ0F=0 PL:DP:DV 0,42,248:14:0 0,18,158:6:0 0,18,191:6:0 +X 3767 . A <*> 0 . DP=26;I16=17,9,0,0,924,33656,0,0,1338,73604,0,0,464,10328,0,0;QS=3,0;MQSB=0.811273;MQ0F=0 PL:DP:DV 0,42,246:14:0 0,18,148:6:0 0,18,191:6:0 +X 3768 . A <*> 0 . DP=26;I16=17,9,0,0,922,33842,0,0,1338,73604,0,0,466,10340,0,0;QS=3,0;MQSB=0.811273;MQ0F=0 PL:DP:DV 0,42,237:14:0 0,18,146:6:0 0,18,195:6:0 +X 3769 . T <*> 0 . DP=26;I16=17,8,0,0,891,32735,0,0,1278,70004,0,0,461,10327,0,0;QS=3,0;MQSB=0.884621;MQ0F=0 PL:DP:DV 0,42,246:14:0 0,15,144:5:0 0,18,191:6:0 +X 3770 . C <*> 0 . DP=26;I16=17,9,0,0,923,34049,0,0,1338,73604,0,0,470,10436,0,0;QS=3,0;MQSB=0.811273;MQ0F=0 PL:DP:DV 0,42,252:14:0 0,18,142:6:0 0,18,180:6:0 +X 3771 . T <*> 0 . DP=25;I16=16,8,0,0,852,31694,0,0,1218,66404,0,0,464,10438,0,0;QS=3,0;MQSB=0.844324;MQ0F=0 PL:DP:DV 0,42,253:14:0 0,15,140:5:0 0,15,157:5:0 +X 3772 . A <*> 0 . DP=26;I16=16,10,0,0,836,28434,0,0,1338,73604,0,0,476,10624,0,0;QS=3,0;MQSB=0.685145;MQ0F=0 PL:DP:DV 0,42,236:14:0 0,18,122:6:0 0,18,160:6:0 +X 3773 . C <*> 0 . DP=26;I16=16,10,0,0,893,31801,0,0,1338,73604,0,0,480,10752,0,0;QS=3,0;MQSB=0.685145;MQ0F=0 PL:DP:DV 0,42,253:14:0 0,18,140:6:0 0,18,171:6:0 +X 3774 . T <*> 0 . DP=25;I16=15,10,0,0,895,33455,0,0,1278,70004,0,0,485,10903,0,0;QS=3,0;MQSB=0.624282;MQ0F=0 PL:DP:DV 0,42,253:14:0 0,18,129:6:0 0,15,178:5:0 +X 3775 . C <*> 0 . DP=25;I16=15,9,0,0,855,31825,0,0,1241,68635,0,0,477,10883,0,0;QS=3,0;MQSB=0.439649;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,147:6:0 0,12,143:4:0 +X 3776 . T <*> 0 . DP=24;I16=15,7,0,0,838,32738,0,0,1152,64194,0,0,457,10375,0,0;QS=3,0;MQSB=0.225079;MQ0F=0 PL:DP:DV 0,39,229:13:0 0,15,149:5:0 0,12,152:4:0 +X 3777 . C <*> 0 . DP=24;I16=15,9,0,0,864,32180,0,0,1218,66404,0,0,492,10998,0,0;QS=3,0;MQSB=0.705785;MQ0F=0 PL:DP:DV 0,39,220:13:0 0,18,160:6:0 0,15,168:5:0 +X 3778 . T <*> 0 . DP=24;I16=14,9,0,0,859,32957,0,0,1208,66304,0,0,468,10372,0,0;QS=3,0;MQSB=0.836049;MQ0F=0 PL:DP:DV 0,36,227:12:0 0,18,157:6:0 0,15,167:5:0 +X 3779 . G <*> 0 . DP=24;I16=15,9,0,0,844,31206,0,0,1218,66404,0,0,493,10971,0,0;QS=3,0;MQSB=0.705785;MQ0F=0 PL:DP:DV 0,39,220:13:0 0,18,152:6:0 0,15,167:5:0 +X 3780 . C <*> 0 . DP=25;I16=14,10,0,0,829,29949,0,0,1268,69904,0,0,467,10295,0,0;QS=3,0;MQSB=0.765017;MQ0F=0 PL:DP:DV 0,39,235:13:0 0,18,144:6:0 0,15,169:5:0 +X 3781 . C <*> 0 . DP=26;I16=16,10,0,0,939,34725,0,0,1315,71373,0,0,492,10896,0,0;QS=3,0;MQSB=0.541994;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,139:6:0 0,15,175:5:0 +X 3782 . T <*> 0 . DP=26;I16=16,10,0,0,989,38031,0,0,1315,71373,0,0,493,10901,0,0;QS=3,0;MQSB=0.541994;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,169:6:0 0,15,176:5:0 +X 3783 . C <*> 0 . DP=26;I16=16,10,0,0,941,34801,0,0,1315,71373,0,0,492,10836,0,0;QS=3,0;MQSB=0.541994;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,155:6:0 0,15,162:5:0 +X 3784 . T <*> 0 . DP=27;I16=16,11,0,0,1001,38035,0,0,1375,74973,0,0,491,10801,0,0;QS=3,0;MQSB=0.467219;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,155:6:0 0,15,178:5:0 +X 3785 . G <*> 0 . DP=28;I16=15,10,0,0,922,36426,0,0,1305,71273,0,0,450,9916,0,0;QS=3,0;MQSB=0.674458;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,125:5:0 0,15,179:5:0 +X 3786 . T <*> 0 . DP=28;I16=16,11,0,0,935,35697,0,0,1375,74973,0,0,490,10774,0,0;QS=3,0;MQSB=0.467219;MQ0F=0 PL:DP:DV 0,48,250:16:0 0,18,145:6:0 0,15,186:5:0 +X 3787 . G <*> 0 . DP=28;I16=16,11,0,0,963,37951,0,0,1375,74973,0,0,489,10781,0,0;QS=3,0;MQSB=0.467219;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,143:6:0 0,15,177:5:0 +X 3788 . G <*> 0 . DP=26;I16=14,9,0,0,849,33683,0,0,1184,65386,0,0,459,10075,0,0;QS=3,0;MQSB=0.525788;MQ0F=0 PL:DP:DV 0,39,239:13:0 0,18,144:6:0 0,12,161:4:0 +X 3789 . G <*> 0 . DP=26;I16=13,10,0,0,807,31019,0,0,1231,68535,0,0,438,9474,0,0;QS=3,0;MQSB=0.445672;MQ0F=0 PL:DP:DV 0,39,251:13:0 0,18,133:6:0 0,12,161:4:0 +X 3790 . T <*> 0 . DP=26;I16=13,10,0,0,829,32293,0,0,1231,68535,0,0,435,9359,0,0;QS=3,0;MQSB=0.445672;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,150:6:0 0,12,159:4:0 +X 3791 . T <*> 0 . DP=26;I16=15,10,0,0,887,34725,0,0,1301,72235,0,0,478,10336,0,0;QS=3,0;MQSB=0.382304;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,136:6:0 0,12,159:4:0 +X 3792 . G A,<*> 0 . DP=26;I16=14,8,1,0,809,32805,38,1444,1175,66425,37,1369,417,8991,22,484;QS=2.92629,0.0737052,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.195278;BQB=1;MQ0F=0 PL:DP:DV 0,8,238,42,241,255:15:1 0,12,109,12,109,109:4:0 0,12,157,12,157,157:4:0 +X 3793 . A <*> 0 . DP=26;I16=15,8,0,0,833,33775,0,0,1212,67794,0,0,435,9363,0,0;QS=3,0;MQSB=0.195278;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,93:4:0 0,12,159:4:0 +X 3794 . C <*> 0 . DP=26;I16=15,9,0,0,845,33023,0,0,1241,68635,0,0,438,9324,0,0;QS=3,0;MQSB=0.439649;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,120:5:0 0,12,157:4:0 +X 3795 . C <*> 0 . DP=26;I16=14,9,0,0,865,35649,0,0,1231,68535,0,0,408,8622,0,0;QS=3,0;MQSB=0.563599;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,132:5:0 0,12,161:4:0 +X 3796 . T <*> 0 . DP=27;I16=15,11,0,0,964,38998,0,0,1361,75835,0,0,453,9821,0,0;QS=3,0;MQSB=0.334895;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,149:7:0 0,12,164:4:0 +X 3797 . A <*> 0 . DP=27;I16=15,10,0,0,848,32392,0,0,1301,72235,0,0,424,9172,0,0;QS=3,0;MQSB=0.382304;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,124:6:0 0,12,159:4:0 +X 3798 . T <*> 0 . DP=27;I16=14,11,0,0,921,37161,0,0,1301,72235,0,0,430,9554,0,0;QS=3,0;MQSB=0.283586;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,21,148:7:0 0,12,165:4:0 +X 3799 . T <*> 0 . DP=27;I16=15,11,0,0,913,35929,0,0,1361,75835,0,0,439,9729,0,0;QS=3,0;MQSB=0.334895;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,150:7:0 0,12,161:4:0 +X 3800 . C <*> 0 . DP=26;I16=13,10,0,0,866,36182,0,0,1181,65035,0,0,406,9092,0,0;QS=3,0;MQSB=0.272532;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,104:5:0 0,12,161:4:0 +X 3801 . T <*> 0 . DP=23;I16=12,10,0,0,804,33600,0,0,1121,61435,0,0,430,9750,0,0;QS=3,0;MQSB=0.217267;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,99:5:0 0,9,133:3:0 +X 3802 . G <*> 0 . DP=22;I16=10,9,0,0,730,30516,0,0,994,54486,0,0,380,8550,0,0;QS=3,0;MQSB=0.472367;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,106:4:0 0,9,130:3:0 +X 3803 . G <*> 0 . DP=22;I16=11,9,0,0,703,27393,0,0,1051,57735,0,0,405,9241,0,0;QS=3,0;MQSB=0.372419;MQ0F=0 PL:DP:DV 0,39,249:13:0 0,12,92:4:0 0,9,129:3:0 +X 3804 . A <*> 0 . DP=22;I16=11,9,0,0,740,30360,0,0,1051,57735,0,0,404,9274,0,0;QS=3,0;MQSB=0.372419;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,98:4:0 0,9,132:3:0 +X 3805 . C <*> 0 . DP=22;I16=12,9,0,0,737,29243,0,0,1061,57835,0,0,428,9950,0,0;QS=3,0;MQSB=0.262932;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,81:4:0 0,9,130:3:0 +X 3806 . A <*> 0 . DP=22;I16=12,9,0,0,798,32550,0,0,1061,57835,0,0,426,9968,0,0;QS=3,0;MQSB=0.262932;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,105:4:0 0,9,128:3:0 +X 3807 . C <*> 0 . DP=22;I16=10,9,0,0,664,25304,0,0,994,54486,0,0,377,8885,0,0;QS=3,0;MQSB=0.472367;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,83:4:0 0,9,115:3:0 +X 3808 . G <*> 0 . DP=21;I16=9,9,0,0,653,25297,0,0,957,53117,0,0,375,8873,0,0;QS=3,0;MQSB=0.597145;MQ0F=0 PL:DP:DV 0,33,233:11:0 0,12,109:4:0 0,9,132:3:0 +X 3809 . T <*> 0 . DP=22;I16=11,10,0,0,779,32151,0,0,1084,60066,0,0,416,9810,0,0;QS=3,0;MQSB=0.285029;MQ0F=0 PL:DP:DV 0,39,249:13:0 0,12,115:4:0 0,12,161:4:0 +X 3810 . C <*> 0 . DP=23;I16=9,11,0,0,811,34815,0,0,1077,60317,0,0,369,8739,0,0;QS=3,0;MQSB=0.499893;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,112:4:0 0,12,153:4:0 +X 3811 . A C,<*> 0 . DP=23;I16=9,11,2,0,777,32631,39,785,1077,60317,67,3349,367,8669,42,914;QS=2.94104,0.0589569,0;VDB=0.18;SGB=0.346553;RPB=0.425;MQB=0.25;MQSB=0.246128;BQB=0.025;MQ0F=0 PL:DP:DV 0,15,248,36,254,255:14:2 0,12,116,12,116,116:4:0 0,12,158,12,158,158:4:0 +X 3812 . T <*> 0 . DP=23;I16=10,11,0,0,802,32860,0,0,1084,60066,0,0,405,9447,0,0;QS=3,0;MQSB=0.187115;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,114:4:0 0,12,160:4:0 +X 3813 . A <*> 0 . DP=22;I16=10,11,0,0,815,35077,0,0,1084,60066,0,0,402,9330,0,0;QS=3,0;MQSB=0.187115;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,119:4:0 0,12,170:4:0 +X 3814 . G <*> 0 . DP=21;I16=8,11,0,0,775,33731,0,0,1037,58597,0,0,375,8605,0,0;QS=3,0;MQSB=0.41781;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,113:4:0 0,12,163:4:0 +X 3815 . A <*> 0 . DP=20;I16=8,11,0,0,708,29130,0,0,1010,57328,0,0,397,9049,0,0;QS=3,0;MQSB=0.373354;MQ0F=0 PL:DP:DV 0,33,239:11:0 0,12,110:4:0 0,12,162:4:0 +X 3816 . A <*> 0 . DP=20;I16=8,11,0,0,729,31027,0,0,1010,57328,0,0,395,8933,0,0;QS=3,0;MQSB=0.373354;MQ0F=0 PL:DP:DV 0,33,248:11:0 0,12,104:4:0 0,12,160:4:0 +X 3817 . A <*> 0 . DP=20;I16=8,11,0,0,752,31580,0,0,1010,57328,0,0,393,8833,0,0;QS=3,0;MQSB=0.373354;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,110:4:0 0,12,161:4:0 +X 3818 . T <*> 0 . DP=20;I16=8,11,0,0,728,30466,0,0,1010,57328,0,0,391,8749,0,0;QS=3,0;MQSB=0.373354;MQ0F=0 PL:DP:DV 0,33,252:11:0 0,12,115:4:0 0,12,160:4:0 +X 3819 . A <*> 0 . DP=21;I16=9,11,0,0,790,34094,0,0,1039,58169,0,0,389,8681,0,0;QS=3,0;MQSB=0.247381;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,121:4:0 0,12,167:4:0 +X 3820 . G <*> 0 . DP=21;I16=9,11,0,0,788,33636,0,0,1039,58169,0,0,388,8630,0,0;QS=3,0;MQSB=0.247381;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,112:4:0 0,12,157:4:0 +X 3821 . A <*> 0 . DP=22;I16=10,11,0,0,832,35864,0,0,1099,61769,0,0,387,8597,0,0;QS=3,0;MQSB=0.317882;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,115:4:0 0,12,168:4:0 +X 3822 . G <*> 0 . DP=22;I16=10,11,0,0,810,33228,0,0,1099,61769,0,0,386,8532,0,0;QS=3,0;MQSB=0.317882;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,103:4:0 0,12,157:4:0 +X 3823 . T <*> 0 . DP=22;I16=9,11,0,0,753,30705,0,0,1042,58520,0,0,380,8460,0,0;QS=3,0;MQSB=0.434285;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,102:4:0 0,12,163:4:0 +X 3824 . C <*> 0 . DP=22;I16=10,11,0,0,802,32368,0,0,1099,61769,0,0,384,8456,0,0;QS=3,0;MQSB=0.317882;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,105:4:0 0,12,159:4:0 +X 3825 . C <*> 0 . DP=23;I16=10,11,0,0,813,33955,0,0,1079,59889,0,0,379,8387,0,0;QS=3,0;MQSB=0.317882;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,130:5:0 0,12,157:4:0 +X 3826 . T <*> 0 . DP=23;I16=11,11,0,0,827,34611,0,0,1136,63138,0,0,381,8357,0,0;QS=3,0;MQSB=0.232836;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,133:5:0 0,12,155:4:0 +X 3827 . G <*> 0 . DP=23;I16=11,10,0,0,820,34130,0,0,1076,59538,0,0,355,7715,0,0;QS=3,0;MQSB=0.269397;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,121:4:0 0,12,162:4:0 +X 3828 . C <*> 0 . DP=23;I16=11,10,0,0,805,33147,0,0,1076,59538,0,0,354,7720,0,0;QS=3,0;MQSB=0.269397;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,114:4:0 0,12,157:4:0 +X 3829 . A <*> 0 . DP=22;I16=9,11,0,0,763,31295,0,0,1069,59789,0,0,369,8241,0,0;QS=3,0;MQSB=0.477679;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,132:5:0 0,12,158:4:0 +X 3830 . A <*> 0 . DP=23;I16=11,11,0,0,825,32693,0,0,1136,63138,0,0,377,8321,0,0;QS=3,0;MQSB=0.232836;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,143:5:0 0,12,150:4:0 +X 3831 . C A,<*> 0 . DP=23;I16=10,11,1,0,802,32198,14,196,1126,63038,10,100,370,8294,7,49;QS=2.97758,0.0224215,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.232836;BQB=1;MQ0F=0 PL:DP:DV 0,27,255,36,255,255:13:1 0,15,134,15,134,134:5:0 0,12,149,12,149,149:4:0 +X 3832 . A <*> 0 . DP=24;I16=12,11,0,0,836,32436,0,0,1196,66738,0,0,377,8389,0,0;QS=3,0;MQSB=0.291845;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,136:5:0 0,12,139:4:0 +X 3833 . C <*> 0 . DP=23;I16=10,11,0,0,690,24938,0,0,1076,59538,0,0,377,8409,0,0;QS=3,0;MQSB=0.175325;MQ0F=0 PL:DP:DV 0,36,249:12:0 0,15,113:5:0 0,12,131:4:0 +X 3834 . G <*> 0 . DP=22;I16=9,10,0,0,684,26250,0,0,1037,58597,0,0,357,8079,0,0;QS=3,0;MQSB=0.124514;MQ0F=0 PL:DP:DV 0,33,242:11:0 0,12,122:4:0 0,12,156:4:0 +X 3835 . T <*> 0 . DP=22;I16=10,11,0,0,773,30373,0,0,1076,59538,0,0,381,8475,0,0;QS=3,0;MQSB=0.175325;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,140:5:0 0,12,153:4:0 +X 3836 . G C,<*> 0 . DP=24;I16=10,12,1,0,833,33183,14,196,1132,61648,10,100,378,8412,2,4;QS=2.97647,0.0235294,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.251407;BQB=1;MQ0F=0 PL:DP:DV 0,27,255,36,255,255:13:1 0,15,149,15,149,149:5:0 0,15,188,15,188,188:5:0 +X 3837 . G <*> 0 . DP=24;I16=8,14,0,0,759,26931,0,0,1135,61999,0,0,399,8955,0,0;QS=3,0;MQSB=0.291667;MQ0F=0 PL:DP:DV 0,33,245:11:0 0,18,149:6:0 0,15,157:5:0 +X 3838 . C <*> 0 . DP=24;I16=10,14,0,0,817,28975,0,0,1202,65348,0,0,409,8945,0,0;QS=3,0;MQSB=0.122456;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,143:6:0 0,15,148:5:0 +X 3839 . C <*> 0 . DP=23;I16=9,13,0,0,688,22248,0,0,1132,61648,0,0,386,8238,0,0;QS=3,0;MQSB=0.248197;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,123:6:0 0,12,112:4:0 +X 3840 . G <*> 0 . DP=23;I16=9,14,0,0,793,27941,0,0,1192,65248,0,0,413,8809,0,0;QS=3,0;MQSB=0.211072;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,160:6:0 0,15,146:5:0 +X 3841 . T <*> 0 . DP=23;I16=9,14,0,0,867,33103,0,0,1192,65248,0,0,414,8734,0,0;QS=3,0;MQSB=0.211072;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,167:6:0 0,15,162:5:0 +X 3842 . C <*> 0 . DP=23;I16=9,14,0,0,890,34728,0,0,1192,65248,0,0,415,8689,0,0;QS=3,0;MQSB=0.211072;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,167:6:0 0,15,159:5:0 +X 3843 . T <*> 0 . DP=24;I16=9,14,0,0,896,35122,0,0,1192,65248,0,0,416,8674,0,0;QS=3,0;MQSB=0.211072;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,164:6:0 0,15,159:5:0 +X 3844 . G <*> 0 . DP=26;I16=10,16,0,0,959,35715,0,0,1372,76048,0,0,442,9314,0,0;QS=3,0;MQSB=0.220358;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,177:7:0 0,18,172:6:0 +X 3845 . T <*> 0 . DP=26;I16=10,16,0,0,970,36442,0,0,1372,76048,0,0,444,9310,0,0;QS=3,0;MQSB=0.220358;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,186:7:0 0,18,166:6:0 +X 3846 . G <*> 0 . DP=27;I16=10,17,0,0,993,37297,0,0,1432,79648,0,0,446,9338,0,0;QS=3,0;MQSB=0.195223;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,175:7:0 0,21,172:7:0 +X 3847 . T <*> 0 . DP=27;I16=10,16,0,0,952,35268,0,0,1372,76048,0,0,423,8723,0,0;QS=3,0;MQSB=0.220358;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,170:6:0 0,21,189:7:0 +X 3848 . C <*> 0 . DP=27;I16=10,17,0,0,1025,39533,0,0,1432,79648,0,0,449,9341,0,0;QS=3,0;MQSB=0.195223;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,177:7:0 0,21,188:7:0 +X 3849 . T <*> 0 . DP=27;I16=9,17,0,0,987,37685,0,0,1395,78279,0,0,450,9368,0,0;QS=3,0;MQSB=0.282527;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,179:7:0 0,21,190:7:0 +X 3850 . G <*> 0 . DP=26;I16=9,17,0,0,957,35751,0,0,1395,78279,0,0,452,9428,0,0;QS=3,0;MQSB=0.282527;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,179:7:0 0,21,182:7:0 +X 3851 . G <*> 0 . DP=26;I16=9,17,0,0,965,36475,0,0,1395,78279,0,0,453,9469,0,0;QS=3,0;MQSB=0.282527;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,177:7:0 0,21,183:7:0 +X 3852 . C <*> 0 . DP=26;I16=9,16,0,0,921,34525,0,0,1335,74679,0,0,444,9440,0,0;QS=3,0;MQSB=0.310905;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,163:6:0 0,21,179:7:0 +X 3853 . T <*> 0 . DP=28;I16=10,18,0,0,1050,40222,0,0,1484,82720,0,0,455,9641,0,0;QS=3,0;MQSB=0.515783;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,21,185:7:0 0,21,192:7:0 +X 3854 . T <*> 0 . DP=28;I16=10,17,0,0,955,34605,0,0,1455,81879,0,0,451,9709,0,0;QS=3,0;MQSB=0.359211;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,171:6:0 0,18,178:6:0 +X 3855 . C <*> 0 . DP=29;I16=10,18,0,0,992,36040,0,0,1515,85479,0,0,438,9264,0,0;QS=3,0;MQSB=0.331344;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,139:5:0 0,21,175:7:0 +X 3856 . T <*> 0 . DP=30;I16=10,18,0,0,1033,38725,0,0,1546,88238,0,0,464,9982,0,0;QS=3,0;MQSB=0.190183;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,163:6:0 0,21,185:7:0 +X 3857 . C <*> 0 . DP=30;I16=10,19,0,0,1077,40979,0,0,1575,89079,0,0,447,9505,0,0;QS=3,0;MQSB=0.306875;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,154:5:0 0,24,194:8:0 +X 3858 . T <*> 0 . DP=31;I16=10,21,0,0,1141,42567,0,0,1695,96279,0,0,477,10255,0,0;QS=3,0;MQSB=0.266219;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,171:6:0 0,24,208:8:0 +X 3859 . C <*> 0 . DP=32;I16=10,21,0,0,950,30078,0,0,1695,96279,0,0,484,10416,0,0;QS=3,0;MQSB=0.266219;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,136:6:0 0,24,156:8:0 +X 3860 . G <*> 0 . DP=32;I16=10,22,0,0,1070,37794,0,0,1755,99879,0,0,516,11240,0,0;QS=3,0;MQSB=0.249261;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,154:6:0 0,27,209:9:0 +X 3861 . C <*> 0 . DP=33;I16=11,20,0,0,1133,42547,0,0,1672,94048,0,0,517,11391,0,0;QS=3,0;MQSB=0.19205;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,162:6:0 0,24,199:8:0 +X 3862 . T <*> 0 . DP=34;I16=11,22,0,0,1241,47443,0,0,1792,101248,0,0,526,11518,0,0;QS=3,0;MQSB=0.161533;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,185:7:0 0,27,221:9:0 +X 3863 . T <*> 0 . DP=34;I16=12,22,0,0,1200,43542,0,0,1852,104848,0,0,541,11685,0,0;QS=3,0;MQSB=0.210327;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,199:7:0 0,27,213:9:0 +X 3864 . A <*> 0 . DP=33;I16=11,22,0,0,1238,47448,0,0,1792,101248,0,0,550,11790,0,0;QS=3,0;MQSB=0.161533;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,210:7:0 0,27,230:9:0 +X 3865 . G <*> 0 . DP=34;I16=11,23,0,0,1251,47113,0,0,1852,104848,0,0,559,11933,0,0;QS=3,0;MQSB=0.149071;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,200:7:0 0,27,212:9:0 +X 3866 . C <*> 0 . DP=33;I16=11,21,0,0,1165,43545,0,0,1732,97648,0,0,545,11489,0,0;QS=3,0;MQSB=0.175751;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,189:7:0 0,24,197:8:0 +X 3867 . A <*> 0 . DP=33;I16=11,22,0,0,1152,41510,0,0,1792,101248,0,0,580,12284,0,0;QS=3,0;MQSB=0.161533;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,188:7:0 0,27,195:9:0 +X 3868 . T <*> 0 . DP=33;I16=11,22,0,0,1255,48141,0,0,1792,101248,0,0,590,12494,0,0;QS=3,0;MQSB=0.161533;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,202:7:0 0,27,221:9:0 +X 3869 . C <*> 0 . DP=33;I16=11,21,0,0,1169,43987,0,0,1732,97648,0,0,589,12623,0,0;QS=3,0;MQSB=0.175751;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,164:6:0 0,27,211:9:0 +X 3870 . T <*> 0 . DP=34;I16=11,23,0,0,1262,47808,0,0,1852,104848,0,0,608,12932,0,0;QS=3,0;MQSB=0.149071;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,215:8:0 0,27,211:9:0 +X 3871 . T <*> 0 . DP=36;I16=11,25,0,0,1341,50655,0,0,1972,112048,0,0,617,13157,0,0;QS=3,0;MQSB=0.128391;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,24,221:8:0 0,27,223:9:0 +X 3872 . G <*> 0 . DP=36;I16=11,25,0,0,1287,47095,0,0,1972,112048,0,0,626,13322,0,0;QS=3,0;MQSB=0.128391;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,24,211:8:0 0,27,200:9:0 +X 3873 . T <*> 0 . DP=35;I16=10,24,0,0,1242,46680,0,0,1852,104848,0,0,626,13428,0,0;QS=3,0;MQSB=0.0982034;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,194:7:0 0,24,212:8:0 +X 3874 . T <*> 0 . DP=36;I16=12,24,0,0,1290,47660,0,0,1972,112048,0,0,646,13774,0,0;QS=3,0;MQSB=0.182088;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,24,228:8:0 0,24,204:8:0 +X 3875 . T <*> 0 . DP=37;I16=13,24,0,0,1324,48418,0,0,2029,115297,0,0,657,14061,0,0;QS=3,0;MQSB=0.117872;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,24,231:8:0 0,24,197:8:0 +X 3876 . C <*> 0 . DP=37;I16=13,22,0,0,1248,45354,0,0,1909,108097,0,0,623,13325,0,0;QS=3,0;MQSB=0.140806;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,21,196:7:0 0,24,180:8:0 +X 3877 . C <*> 0 . DP=37;I16=13,24,0,0,1363,51201,0,0,2029,115297,0,0,681,14765,0,0;QS=3,0;MQSB=0.117872;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,24,217:8:0 0,24,196:8:0 +X 3878 . A <*> 0 . DP=37;I16=13,23,0,0,1309,48045,0,0,1969,111697,0,0,670,14654,0,0;QS=3,0;MQSB=0.128568;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,24,218:8:0 0,24,188:8:0 +X 3879 . A <*> 0 . DP=38;I16=14,24,0,0,1453,56567,0,0,2066,116666,0,0,703,15543,0,0;QS=3,0;MQSB=0.076112;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,24,226:8:0 0,24,206:8:0 +X 3880 . G <*> 0 . DP=37;I16=14,22,0,0,1311,48735,0,0,1946,109466,0,0,689,15267,0,0;QS=3,0;MQSB=0.094094;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,24,209:8:0 0,24,183:8:0 +X 3881 . G <*> 0 . DP=37;I16=14,21,0,0,1200,42778,0,0,1886,105866,0,0,690,15578,0,0;QS=3,0;MQSB=0.105399;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,18,178:6:0 0,24,174:8:0 +X 3882 . T <*> 0 . DP=37;I16=14,21,0,0,1192,42352,0,0,1886,105866,0,0,684,15348,0,0;QS=3,0;MQSB=0.105399;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,21,189:7:0 0,21,178:7:0 +X 3883 . C <*> 0 . DP=38;I16=15,22,0,0,1295,46659,0,0,2006,113066,0,0,717,16279,0,0;QS=3,0;MQSB=0.124405;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,24,205:8:0 0,24,171:8:0 +X 3884 . C <*> 0 . DP=39;I16=16,23,0,0,1363,49387,0,0,2103,118035,0,0,749,17141,0,0;QS=3,0;MQSB=0.0760633;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,24,202:8:0 0,27,212:9:0 +X 3885 . T <*> 0 . DP=40;I16=16,24,0,0,1445,53663,0,0,2163,121635,0,0,754,17262,0,0;QS=3,0;MQSB=0.0679472;MQ0F=0 PL:DP:DV 0,69,255:23:0 0,24,219:8:0 0,27,214:9:0 +X 3886 . C <*> 0 . DP=39;I16=16,23,0,0,1370,49762,0,0,2103,118035,0,0,761,17421,0,0;QS=3,0;MQSB=0.0760633;MQ0F=0 PL:DP:DV 0,69,255:23:0 0,24,199:8:0 0,24,191:8:0 +X 3887 . C <*> 0 . DP=39;I16=16,23,0,0,1364,49222,0,0,2103,118035,0,0,767,17567,0,0;QS=3,0;MQSB=0.0760633;MQ0F=0 PL:DP:DV 0,69,255:23:0 0,24,194:8:0 0,24,201:8:0 +X 3888 . C <*> 0 . DP=39;I16=15,23,0,0,1387,51885,0,0,2043,114435,0,0,747,17073,0,0;QS=3,0;MQSB=0.0555905;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,24,195:8:0 0,24,208:8:0 +X 3889 . A <*> 0 . DP=38;I16=15,23,0,0,1364,49918,0,0,2066,116666,0,0,777,17811,0,0;QS=3,0;MQSB=0.112471;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,24,202:8:0 0,24,218:8:0 +X 3890 . C <*> 0 . DP=38;I16=14,23,0,0,1362,51064,0,0,2006,113066,0,0,757,17329,0,0;QS=3,0;MQSB=0.0844255;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,24,203:8:0 0,24,216:8:0 +X 3891 . A <*> 0 . DP=39;I16=15,24,0,0,1466,56312,0,0,2126,120266,0,0,786,18076,0,0;QS=3,0;MQSB=0.102114;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,24,203:8:0 0,27,239:9:0 +X 3892 . G <*> 0 . DP=38;I16=15,23,0,0,1340,48838,0,0,2066,116666,0,0,792,18226,0,0;QS=3,0;MQSB=0.112471;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,24,186:8:0 0,27,208:9:0 +X 3893 . T <*> 0 . DP=39;I16=15,24,0,0,1348,48170,0,0,2126,120266,0,0,798,18404,0,0;QS=3,0;MQSB=0.102114;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,24,196:8:0 0,27,212:9:0 +X 3894 . G <*> 0 . DP=39;I16=15,23,0,0,1364,49900,0,0,2066,116666,0,0,779,17937,0,0;QS=3,0;MQSB=0.112471;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,24,202:8:0 0,27,208:9:0 +X 3895 . T <*> 0 . DP=39;I16=15,24,0,0,1375,49773,0,0,2126,120266,0,0,810,18752,0,0;QS=3,0;MQSB=0.102114;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,24,202:8:0 0,27,225:9:0 +X 3896 . A <*> 0 . DP=40;I16=15,24,0,0,1468,57326,0,0,2126,120266,0,0,815,18923,0,0;QS=3,0;MQSB=0.102114;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,24,224:8:0 0,27,233:9:0 +X 3897 . G <*> 0 . DP=40;I16=15,24,0,0,1468,56812,0,0,2126,120266,0,0,819,19021,0,0;QS=3,0;MQSB=0.102114;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,21,199:7:0 0,30,234:10:0 +X 3898 . C <*> 0 . DP=40;I16=15,23,0,0,1487,59351,0,0,2066,116666,0,0,813,19023,0,0;QS=3,0;MQSB=0.112471;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,18,186:6:0 0,30,238:10:0 +X 3899 . A <*> 0 . DP=40;I16=15,24,0,0,1449,55055,0,0,2126,120266,0,0,829,19293,0,0;QS=3,0;MQSB=0.102114;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,21,191:7:0 0,30,231:10:0 +X 3900 . T <*> 0 . DP=40;I16=15,24,0,0,1458,55516,0,0,2126,120266,0,0,833,19417,0,0;QS=3,0;MQSB=0.102114;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,21,197:7:0 0,30,240:10:0 +X 3901 . G <*> 0 . DP=40;I16=14,22,0,0,1303,48245,0,0,1969,111697,0,0,761,17639,0,0;QS=3,0;MQSB=0.180757;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,18,154:6:0 0,27,218:9:0 +X 3902 . C <*> 0 . DP=40;I16=15,24,0,0,1436,55412,0,0,2126,120266,0,0,837,19537,0,0;QS=3,0;MQSB=0.102114;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,21,166:7:0 0,30,217:10:0 +X 3903 . A <*> 0 . DP=42;I16=15,24,0,0,1299,45567,0,0,2089,117417,0,0,814,19008,0,0;QS=3,0;MQSB=0.0901152;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,24,175:8:0 0,30,204:10:0 +X 3904 . C <*> 0 . DP=42;I16=15,24,0,0,1439,54545,0,0,2086,117066,0,0,815,19113,0,0;QS=3,0;MQSB=0.0426917;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,24,191:8:0 0,30,244:10:0 +X 3905 . C <*> 0 . DP=42;I16=15,25,0,0,1572,63314,0,0,2146,120666,0,0,822,19192,0,0;QS=3,0;MQSB=0.0381122;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,24,212:8:0 0,33,255:11:0 +X 3906 . T <*> 0 . DP=42;I16=16,25,0,0,1593,63039,0,0,2206,124266,0,0,846,19758,0,0;QS=3,0;MQSB=0.0536599;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,24,210:8:0 0,33,253:11:0 +X 3907 . G <*> 0 . DP=42;I16=16,25,0,0,1558,60192,0,0,2206,124266,0,0,846,19776,0,0;QS=3,0;MQSB=0.0536599;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,24,203:8:0 0,33,249:11:0 +X 3908 . C <*> 0 . DP=42;I16=16,25,0,0,1514,58968,0,0,2206,124266,0,0,845,19777,0,0;QS=3,0;MQSB=0.0536599;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,24,193:8:0 0,33,244:11:0 +X 3909 . T <*> 0 . DP=43;I16=16,25,0,0,1491,55895,0,0,2201,123691,0,0,835,19697,0,0;QS=3,0;MQSB=0.0757469;MQ0F=0 PL:DP:DV 0,69,255:23:0 0,24,202:8:0 0,30,237:10:0 +X 3910 . A <*> 0 . DP=40;I16=16,23,0,0,1432,53926,0,0,2081,116491,0,0,844,19724,0,0;QS=3,0;MQSB=0.0949554;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,21,193:7:0 0,30,224:10:0 +X 3911 . C <*> 0 . DP=40;I16=16,23,0,0,1440,55290,0,0,2081,116491,0,0,843,19613,0,0;QS=3,0;MQSB=0.0949554;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,21,184:7:0 0,30,214:10:0 +X 3912 . A C,<*> 0 . DP=41;I16=17,22,0,1,1358,49508,16,256,2081,116491,60,3600,830,19358,11,121;QS=2.95181,0.0481928,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.125266;BQB=1;MQ0F=0 PL:DP:DV 0,69,255,69,255,255:23:0 0,21,166,21,166,166:7:0 0,14,202,27,205,208:10:1 +X 3913 . C <*> 0 . DP=40;I16=16,23,0,0,1494,59096,0,0,2081,116491,0,0,824,19100,0,0;QS=3,0;MQSB=0.0949554;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,21,183:7:0 0,30,234:10:0 +X 3914 . T <*> 0 . DP=42;I16=16,24,0,0,1512,59342,0,0,2141,120091,0,0,823,19007,0,0;QS=3,0;MQSB=0.0846181;MQ0F=0 PL:DP:DV 0,69,255:23:0 0,21,192:7:0 0,30,228:10:0 +X 3915 . C <*> 0 . DP=42;I16=16,24,0,0,1537,60953,0,0,2141,120091,0,0,799,18321,0,0;QS=3,0;MQSB=0.0846181;MQ0F=0 PL:DP:DV 0,72,255:24:0 0,18,176:6:0 0,30,229:10:0 +X 3916 . C <*> 0 . DP=42;I16=16,25,0,0,1618,66342,0,0,2201,123691,0,0,825,18919,0,0;QS=3,0;MQSB=0.0757469;MQ0F=0 PL:DP:DV 0,72,255:24:0 0,21,190:7:0 0,30,251:10:0 +X 3917 . T <*> 0 . DP=43;I16=16,25,0,0,1601,65219,0,0,2201,123691,0,0,825,18875,0,0;QS=3,0;MQSB=0.0757469;MQ0F=0 PL:DP:DV 0,72,255:24:0 0,21,191:7:0 0,30,254:10:0 +X 3918 . T <*> 0 . DP=43;I16=16,25,0,0,1541,60711,0,0,2201,123691,0,0,801,18239,0,0;QS=3,0;MQSB=0.0757469;MQ0F=0 PL:DP:DV 0,75,255:25:0 0,18,179:6:0 0,30,254:10:0 +X 3919 . C <*> 0 . DP=42;I16=15,26,0,0,1621,66337,0,0,2232,126450,0,0,826,18786,0,0;QS=3,0;MQSB=0.110793;MQ0F=0 PL:DP:DV 0,72,255:24:0 0,21,200:7:0 0,30,242:10:0 +X 3920 . T <*> 0 . DP=42;I16=15,26,0,0,1605,64327,0,0,2232,126450,0,0,825,18691,0,0;QS=3,0;MQSB=0.110793;MQ0F=0 PL:DP:DV 0,72,255:24:0 0,21,207:7:0 0,30,251:10:0 +X 3921 . T <*> 0 . DP=42;I16=15,26,0,0,1519,58507,0,0,2232,126450,0,0,824,18630,0,0;QS=3,0;MQSB=0.110793;MQ0F=0 PL:DP:DV 0,72,255:24:0 0,21,201:7:0 0,30,242:10:0 +X 3922 . A <*> 0 . DP=42;I16=14,26,0,0,1539,61289,0,0,2195,125081,0,0,819,18545,0,0;QS=3,0;MQSB=0.168991;MQ0F=0 PL:DP:DV 0,72,255:24:0 0,18,179:6:0 0,30,244:10:0 +X 3923 . G <*> 0 . DP=41;I16=14,25,0,0,1515,60945,0,0,2135,121481,0,0,792,17834,0,0;QS=3,0;MQSB=0.182501;MQ0F=0 PL:DP:DV 0,69,255:23:0 0,18,172:6:0 0,30,240:10:0 +X 3924 . G <*> 0 . DP=41;I16=13,26,0,0,1524,61106,0,0,2135,121481,0,0,808,18356,0,0;QS=3,0;MQSB=0.128469;MQ0F=0 PL:DP:DV 0,69,255:23:0 0,18,158:6:0 0,30,247:10:0 +X 3925 . G <*> 0 . DP=41;I16=14,25,0,0,1425,55687,0,0,2135,121481,0,0,788,17758,0,0;QS=3,0;MQSB=0.182501;MQ0F=0 PL:DP:DV 0,72,255:24:0 0,15,134:5:0 0,30,245:10:0 +X 3926 . C <*> 0 . DP=41;I16=14,26,0,0,1512,59674,0,0,2195,125081,0,0,811,18393,0,0;QS=3,0;MQSB=0.168991;MQ0F=0 PL:DP:DV 0,72,255:24:0 0,18,152:6:0 0,30,237:10:0 +X 3927 . T <*> 0 . DP=41;I16=14,26,0,0,1512,59566,0,0,2195,125081,0,0,808,18384,0,0;QS=3,0;MQSB=0.168991;MQ0F=0 PL:DP:DV 0,72,255:24:0 0,18,160:6:0 0,30,237:10:0 +X 3928 . G <*> 0 . DP=41;I16=14,25,0,0,1479,58495,0,0,2135,121481,0,0,779,17731,0,0;QS=3,0;MQSB=0.182501;MQ0F=0 PL:DP:DV 0,72,255:24:0 0,18,149:6:0 0,27,233:9:0 +X 3929 . A <*> 0 . DP=41;I16=13,26,0,0,1452,56436,0,0,2135,121481,0,0,796,18256,0,0;QS=3,0;MQSB=0.128469;MQ0F=0 PL:DP:DV 0,69,255:23:0 0,18,161:6:0 0,30,220:10:0 +X 3930 . T <*> 0 . DP=40;I16=13,25,0,0,1387,52929,0,0,2078,118232,0,0,767,17521,0,0;QS=3,0;MQSB=0.25797;MQ0F=0 PL:DP:DV 0,69,255:23:0 0,15,149:5:0 0,30,224:10:0 +X 3931 . A <*> 0 . DP=40;I16=13,25,0,0,1387,52877,0,0,2078,118232,0,0,761,17439,0,0;QS=3,0;MQSB=0.25797;MQ0F=0 PL:DP:DV 0,69,255:23:0 0,18,166:6:0 0,27,222:9:0 +X 3932 . T <*> 0 . DP=39;I16=12,26,0,0,1394,53644,0,0,2078,118232,0,0,780,17964,0,0;QS=3,0;MQSB=0.190372;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,18,161:6:0 0,30,231:10:0 +X 3933 . T <*> 0 . DP=38;I16=12,24,0,0,1389,54743,0,0,1958,111032,0,0,752,17366,0,0;QS=3,0;MQSB=0.218161;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,18,166:6:0 0,24,220:8:0 +X 3934 . C <*> 0 . DP=38;I16=12,25,0,0,1395,54915,0,0,2018,114632,0,0,768,17758,0,0;QS=3,0;MQSB=0.203497;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,18,152:6:0 0,27,209:9:0 +X 3935 . C <*> 0 . DP=38;I16=12,24,0,0,1239,44621,0,0,1958,111032,0,0,737,17075,0,0;QS=3,0;MQSB=0.218161;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,15,134:5:0 0,27,170:9:0 +X 3936 . A G,<*> 0 . DP=37;I16=5,6,6,17,424,16384,801,30271,609,34563,1314,77018,225,5325,511,11851;QS=0.87994,2.12006,0;VDB=0.0574114;SGB=-4.60123;RPB=0.741697;MQB=0.812605;MQSB=0.143788;BQB=0.883831;MQ0F=0 PL:DP:DV 233,0,206,255,239,255:20:11 77,0,58,83,70,141:6:4 196,24,0,196,24,196:8:8 +X 3937 . C <*> 0 . DP=36;I16=11,24,0,0,1155,39875,0,0,1952,112422,0,0,745,17291,0,0;QS=3,0;MQSB=0.219636;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,18,143:6:0 0,24,156:8:0 +X 3938 . G <*> 0 . DP=35;I16=11,23,0,0,1155,41761,0,0,1892,108822,0,0,737,17079,0,0;QS=3,0;MQSB=0.231054;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,15,119:5:0 0,24,176:8:0 +X 3939 . C <*> 0 . DP=35;I16=11,22,0,0,1273,50651,0,0,1832,105222,0,0,703,16221,0,0;QS=3,0;MQSB=0.243713;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,15,135:5:0 0,21,174:7:0 +X 3940 . A <*> 0 . DP=35;I16=11,22,0,0,1148,42754,0,0,1832,105222,0,0,691,15867,0,0;QS=3,0;MQSB=0.243713;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,15,117:5:0 0,21,163:7:0 +X 3941 . C <*> 0 . DP=35;I16=11,22,0,0,1216,47488,0,0,1832,105222,0,0,688,15892,0,0;QS=3,0;MQSB=0.243713;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,15,133:5:0 0,21,181:7:0 +X 3942 . C <*> 0 . DP=35;I16=11,23,0,0,1336,54166,0,0,1892,108822,0,0,690,15772,0,0;QS=3,0;MQSB=0.231054;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,15,140:5:0 0,24,195:8:0 +X 3943 . T <*> 0 . DP=35;I16=11,23,0,0,1296,51618,0,0,1892,108822,0,0,676,15406,0,0;QS=3,0;MQSB=0.231054;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,15,142:5:0 0,24,195:8:0 +X 3944 . G <*> 0 . DP=34;I16=10,22,0,0,1199,46445,0,0,1803,104381,0,0,654,14954,0,0;QS=3,0;MQSB=0.1117;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,149:5:0 0,24,195:8:0 +X 3945 . C <*> 0 . DP=33;I16=10,22,0,0,1256,51226,0,0,1772,101622,0,0,649,14657,0,0;QS=3,0;MQSB=0.187579;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,15,142:5:0 0,21,177:7:0 +X 3946 . T <*> 0 . DP=33;I16=10,21,0,0,1170,45884,0,0,1712,98022,0,0,609,13599,0,0;QS=3,0;MQSB=0.199344;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,15,144:5:0 0,18,158:6:0 +X 3947 . A <*> 0 . DP=32;I16=10,21,0,0,1094,41048,0,0,1712,98022,0,0,620,13820,0,0;QS=3,0;MQSB=0.199344;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,15,128:5:0 0,18,149:6:0 +X 3948 . C <*> 0 . DP=32;I16=10,20,0,0,1134,45104,0,0,1652,94422,0,0,596,13344,0,0;QS=3,0;MQSB=0.212591;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,12,105:4:0 0,18,155:6:0 +X 3949 . A C,<*> 0 . DP=32;I16=10,17,0,1,1027,39909,24,576,1472,83622,60,3600,541,12211,25,625;QS=2.85093,0.149068,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.244621;BQB=1;MQ0F=0 PL:DP:DV 0,60,255,60,255,255:20:0 0,9,89,9,89,89:3:0 9,0,107,21,110,124:5:1 +X 3950 . C <*> 0 . DP=33;I16=11,21,0,0,1191,46247,0,0,1772,101622,0,0,576,12680,0,0;QS=3,0;MQSB=0.257801;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,15,118:5:0 0,18,168:6:0 +X 3951 . T <*> 0 . DP=34;I16=12,19,0,0,1148,44272,0,0,1712,98022,0,0,530,11670,0,0;QS=3,0;MQSB=0.354733;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,15,146:5:0 0,15,152:5:0 +X 3952 . C <*> 0 . DP=35;I16=13,20,0,0,1176,43762,0,0,1832,105222,0,0,545,12025,0,0;QS=3,0;MQSB=0.394875;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,18,158:6:0 0,15,143:5:0 +X 3953 . C <*> 0 . DP=34;I16=13,20,0,0,1246,48436,0,0,1863,107981,0,0,538,11772,0,0;QS=3,0;MQSB=0.252983;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,18,163:6:0 0,18,168:6:0 +X 3954 . T <*> 0 . DP=33;I16=13,19,0,0,1195,45815,0,0,1803,104381,0,0,526,11438,0,0;QS=3,0;MQSB=0.264585;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,18,171:6:0 0,18,167:6:0 +X 3955 . T <*> 0 . DP=32;I16=13,18,0,0,1180,46092,0,0,1743,100781,0,0,515,11139,0,0;QS=3,0;MQSB=0.277468;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,173:6:0 0,18,174:6:0 +X 3956 . C <*> 0 . DP=32;I16=13,18,0,0,1181,47021,0,0,1743,100781,0,0,504,10874,0,0;QS=3,0;MQSB=0.277468;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,167:6:0 0,18,167:6:0 +X 3957 . T <*> 0 . DP=31;I16=13,17,0,0,1153,46051,0,0,1683,97181,0,0,494,10642,0,0;QS=3,0;MQSB=0.291833;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,161:6:0 0,15,162:5:0 +X 3958 . T <*> 0 . DP=31;I16=13,16,0,0,1070,40600,0,0,1623,93581,0,0,483,10393,0,0;QS=3,0;MQSB=0.307929;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,139:5:0 0,15,157:5:0 +X 3959 . A <*> 0 . DP=30;I16=14,15,0,0,1062,39758,0,0,1623,93581,0,0,474,10176,0,0;QS=3,0;MQSB=0.377103;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,12,118:4:0 0,15,154:5:0 +X 3960 . T <*> 0 . DP=30;I16=14,15,0,0,995,36027,0,0,1623,93581,0,0,464,9892,0,0;QS=3,0;MQSB=0.377103;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,12,105:4:0 0,15,142:5:0 +X 3961 . G <*> 0 . DP=29;I16=12,16,0,0,1067,40899,0,0,1586,92212,0,0,457,9739,0,0;QS=3,0;MQSB=0.455864;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,12,114:4:0 0,12,122:4:0 +X 3962 . G <*> 0 . DP=29;I16=13,16,0,0,1025,37125,0,0,1623,93581,0,0,471,10053,0,0;QS=3,0;MQSB=0.307929;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,12,108:4:0 0,15,144:5:0 +X 3963 . C <*> 0 . DP=28;I16=13,15,0,0,1040,39100,0,0,1563,89981,0,0,463,9871,0,0;QS=3,0;MQSB=0.326055;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,12,111:4:0 0,12,126:4:0 +X 3964 . T <*> 0 . DP=27;I16=12,15,0,0,1036,39928,0,0,1503,86381,0,0,456,9720,0,0;QS=3,0;MQSB=0.273507;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,9,94:3:0 0,12,133:4:0 +X 3965 . G <*> 0 . DP=26;I16=12,14,0,0,993,38165,0,0,1443,82781,0,0,450,9598,0,0;QS=3,0;MQSB=0.29215;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,9,92:3:0 0,12,134:4:0 +X 3966 . A <*> 0 . DP=26;I16=12,13,0,0,930,34834,0,0,1406,81412,0,0,432,9310,0,0;QS=3,0;MQSB=0.520812;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,9,90:3:0 0,12,140:4:0 +X 3967 . T <*> 0 . DP=26;I16=12,13,0,0,900,32830,0,0,1406,81412,0,0,421,9001,0,0;QS=3,0;MQSB=0.520812;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,9,90:3:0 0,9,100:3:0 +X 3968 . A <*> 0 . DP=25;I16=12,13,0,0,885,31773,0,0,1406,81412,0,0,415,8853,0,0;QS=3,0;MQSB=0.520812;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,9,90:3:0 0,9,99:3:0 +X 3969 . T <*> 0 . DP=24;I16=11,13,0,0,886,32972,0,0,1369,80043,0,0,410,8736,0,0;QS=3,0;MQSB=0.702671;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,9,85:3:0 0,9,108:3:0 +X 3970 . T <*> 0 . DP=24;I16=11,13,0,0,861,31313,0,0,1369,80043,0,0,405,8649,0,0;QS=3,0;MQSB=0.702671;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,9,83:3:0 0,9,104:3:0 +X 3971 . C <*> 0 . DP=22;I16=11,11,0,0,815,30625,0,0,1249,72843,0,0,402,8590,0,0;QS=3,0;MQSB=0.751921;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,57:2:0 0,9,103:3:0 +X 3972 . C <*> 0 . DP=22;I16=11,11,0,0,812,30486,0,0,1249,72843,0,0,399,8557,0,0;QS=3,0;MQSB=0.751921;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,55:2:0 0,9,96:3:0 +X 3973 . A <*> 0 . DP=22;I16=11,11,0,0,795,28873,0,0,1249,72843,0,0,395,8501,0,0;QS=3,0;MQSB=0.751921;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,52:2:0 0,9,97:3:0 +X 3974 . C <*> 0 . DP=22;I16=11,11,0,0,729,24447,0,0,1249,72843,0,0,392,8472,0,0;QS=3,0;MQSB=0.751921;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,55:2:0 0,9,78:3:0 +X 3975 . G <*> 0 . DP=22;I16=11,11,0,0,717,24525,0,0,1249,72843,0,0,390,8470,0,0;QS=3,0;MQSB=0.751921;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,46:2:0 0,9,96:3:0 +X 3976 . C <*> 0 . DP=22;I16=11,11,0,0,816,30652,0,0,1249,72843,0,0,387,8445,0,0;QS=3,0;MQSB=0.751921;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,55:2:0 0,9,97:3:0 +X 3977 . A <*> 0 . DP=23;I16=11,11,0,0,740,25384,0,0,1249,72843,0,0,382,8346,0,0;QS=3,0;MQSB=0.751921;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,48:2:0 0,9,90:3:0 +X 3978 . C <*> 0 . DP=23;I16=11,12,0,0,769,26631,0,0,1309,76443,0,0,377,8223,0,0;QS=3,0;MQSB=0.726094;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,47:2:0 0,9,103:3:0 +X 3979 . C <*> 0 . DP=21;I16=9,11,0,0,744,28160,0,0,1152,67874,0,0,361,7905,0,0;QS=3,0;MQSB=0.885207;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,51:2:0 0,9,104:3:0 +X 3980 . T <*> 0 . DP=21;I16=10,11,0,0,756,27872,0,0,1212,71474,0,0,367,7855,0,0;QS=3,0;MQSB=0.914611;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,51:2:0 0,9,98:3:0 +X 3981 . G <*> 0 . DP=21;I16=10,11,0,0,785,29641,0,0,1212,71474,0,0,362,7710,0,0;QS=3,0;MQSB=0.914611;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,50:2:0 0,9,93:3:0 +X 3982 . C <*> 0 . DP=21;I16=10,11,0,0,779,29495,0,0,1212,71474,0,0,357,7591,0,0;QS=3,0;MQSB=0.914611;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,55:2:0 0,9,97:3:0 +X 3983 . T <*> 0 . DP=20;I16=9,11,0,0,720,26274,0,0,1155,68225,0,0,353,7497,0,0;QS=3,0;MQSB=0.993528;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,57:2:0 0,9,93:3:0 +X 3984 . A <*> 0 . DP=21;I16=10,11,0,0,739,26279,0,0,1192,69594,0,0,348,7378,0,0;QS=3,0;MQSB=0.885602;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,53:2:0 0,9,80:3:0 +X 3985 . C <*> 0 . DP=20;I16=10,10,0,0,728,26998,0,0,1132,65994,0,0,344,7234,0,0;QS=3,0;MQSB=0.902256;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,55:2:0 0,9,91:3:0 +X 3986 . A <*> 0 . DP=20;I16=10,10,0,0,685,23815,0,0,1132,65994,0,0,340,7114,0,0;QS=3,0;MQSB=0.902256;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,56:2:0 0,9,84:3:0 +X 3987 . C <*> 0 . DP=20;I16=10,10,0,0,736,28118,0,0,1132,65994,0,0,336,7018,0,0;QS=3,0;MQSB=0.902256;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,55:2:0 0,9,94:3:0 +X 3988 . T <*> 0 . DP=21;I16=10,10,0,0,741,27797,0,0,1132,65994,0,0,332,6946,0,0;QS=3,0;MQSB=0.902256;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,58:2:0 0,9,91:3:0 +X 3989 . C <*> 0 . DP=21;I16=10,11,0,0,729,26185,0,0,1192,69594,0,0,327,6801,0,0;QS=3,0;MQSB=0.885602;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,55:2:0 0,9,88:3:0 +X 3990 . C <*> 0 . DP=21;I16=10,11,0,0,766,28674,0,0,1192,69594,0,0,322,6686,0,0;QS=3,0;MQSB=0.885602;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,55:2:0 0,9,95:3:0 +X 3991 . T <*> 0 . DP=20;I16=9,11,0,0,729,27311,0,0,1132,65994,0,0,318,6600,0,0;QS=3,0;MQSB=0.850154;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,55:2:0 0,9,89:3:0 +X 3992 . T <*> 0 . DP=19;I16=9,10,0,0,667,24173,0,0,1072,62394,0,0,313,6441,0,0;QS=3,0;MQSB=0.868634;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,56:2:0 0,6,72:2:0 +X 3993 . C <*> 0 . DP=18;I16=9,9,0,0,701,27529,0,0,1012,58794,0,0,309,6307,0,0;QS=3,0;MQSB=0.888755;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,59:2:0 0,6,70:2:0 +X 3994 . T <*> 0 . DP=19;I16=10,9,0,0,718,27520,0,0,1049,60163,0,0,305,6197,0,0;QS=3,0;MQSB=0.716531;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,58:2:0 0,6,72:2:0 +X 3995 . T <*> 0 . DP=19;I16=9,9,0,0,641,23025,0,0,989,56563,0,0,277,5487,0,0;QS=3,0;MQSB=0.650623;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,53:2:0 0,6,69:2:0 +X 3996 . A <*> 0 . DP=19;I16=9,9,0,0,665,24815,0,0,989,56563,0,0,274,5428,0,0;QS=3,0;MQSB=0.650623;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,54:2:0 0,6,73:2:0 +X 3997 . G C,<*> 0 . DP=19;I16=10,8,0,1,645,23703,21,441,989,56563,60,3600,287,5843,6,36;QS=2.96023,0.0397727,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.716531;BQB=1;MQ0F=0 PL:DP:DV 0,24,255,42,255,255:15:1 0,6,57,6,57,57:2:0 0,6,60,6,60,60:2:0 +X 3998 . G <*> 0 . DP=18;I16=9,8,0,0,626,23710,0,0,929,52963,0,0,265,5203,0,0;QS=3,0;MQSB=0.687289;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,58:2:0 0,3,36:1:0 +X 3999 . G A,<*> 0 . DP=18;I16=9,7,0,1,596,22974,37,1369,869,49363,60,3600,263,5387,4,16;QS=2.92871,0.0712909,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.687289;BQB=1;MQ0F=0 PL:DP:DV 0,5,255,39,255,255:14:1 0,6,56,6,56,56:2:0 0,3,38,3,38,38:1:0 +X 4000 . C <*> 0 . DP=18;I16=10,8,0,0,669,25389,0,0,989,56563,0,0,283,5753,0,0;QS=3,0;MQSB=0.751866;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,55:2:0 0,3,36:1:0 +X 4001 . T <*> 0 . DP=18;I16=10,8,0,0,680,26006,0,0,989,56563,0,0,279,5727,0,0;QS=3,0;MQSB=0.751866;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,56:2:0 0,3,33:1:0 +X 4002 . G <*> 0 . DP=17;I16=10,7,0,0,621,23281,0,0,929,52963,0,0,276,5724,0,0;QS=2,0;MQSB=0.79189;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,44:2:0 0,0,0:0:0 +X 4003 . A <*> 0 . DP=17;I16=10,7,0,0,597,21507,0,0,929,52963,0,0,272,5692,0,0;QS=2,0;MQSB=0.79189;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,55:2:0 0,0,0:0:0 +X 4004 . T <*> 0 . DP=15;I16=9,6,0,0,527,19031,0,0,849,48963,0,0,270,5678,0,0;QS=2,0;MQSB=0.957526;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,3,40:1:0 0,0,0:0:0 +X 4005 . A <*> 0 . DP=15;I16=8,5,0,0,479,17731,0,0,729,41763,0,0,237,5195,0,0;QS=2,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,35:1:0 0,0,0:0:0 +X 4006 . T <*> 0 . DP=15;I16=9,6,0,0,554,20776,0,0,849,48963,0,0,266,5698,0,0;QS=2,0;MQSB=0.957526;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,3,40:1:0 0,0,0:0:0 +X 4007 . T G,<*> 0 . DP=15;I16=9,5,0,1,490,17810,15,225,789,45363,60,3600,245,5371,19,361;QS=1.96746,0.032538,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.957526;BQB=1;MQ0F=0 PL:DP:DV 0,26,255,39,255,255:14:1 0,3,41,3,41,41:1:0 0,0,0,0,0,0:0:0 +X 4008 . C <*> 0 . DP=15;I16=9,6,0,0,488,16890,0,0,849,48963,0,0,262,5782,0,0;QS=2,0;MQSB=0.957526;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,3,30:1:0 0,0,0:0:0 +X 4009 . C <*> 0 . DP=14;I16=9,5,0,0,524,20150,0,0,794,45938,0,0,261,5847,0,0;QS=2,0;MQSB=0.800737;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,3,40:1:0 0,0,0:0:0 +X 4010 . A <*> 0 . DP=14;I16=9,5,0,0,523,19731,0,0,794,45938,0,0,259,5875,0,0;QS=2,0;MQSB=0.800737;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,3,41:1:0 0,0,0:0:0 +X 4011 . C <*> 0 . DP=14;I16=9,5,0,0,489,17613,0,0,794,45938,0,0,257,5915,0,0;QS=2,0;MQSB=0.800737;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,3,41:1:0 0,0,0:0:0 +X 4012 . A <*> 0 . DP=14;I16=7,5,0,0,365,11867,0,0,674,38738,0,0,223,5293,0,0;QS=2,0;MQSB=0.6821;MQ0F=0 PL:DP:DV 0,33,231:11:0 0,3,30:1:0 0,0,0:0:0 +X 4013 . C <*> 0 . DP=14;I16=8,5,0,0,451,15885,0,0,734,42338,0,0,247,5995,0,0;QS=2,0;MQSB=0.765017;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,37:1:0 0,0,0:0:0 +X 4014 . A <*> 0 . DP=12;I16=8,2,0,0,358,13372,0,0,554,31538,0,0,222,5404,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,213:9:0 0,3,34:1:0 0,0,0:0:0 +X 4015 . C <*> 0 . DP=12;I16=8,2,0,0,350,12812,0,0,554,31538,0,0,222,5442,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,222:9:0 0,3,21:1:0 0,0,0:0:0 +X 4016 . C <*> 0 . DP=12;I16=8,3,0,0,350,11956,0,0,614,35138,0,0,247,6109,0,0;QS=2,0;MQSB=0.829029;MQ0F=0 PL:DP:DV 0,30,215:10:0 0,3,32:1:0 0,0,0:0:0 +X 4017 . C <*> 0 . DP=11;I16=5,2,0,0,227,7765,0,0,374,20738,0,0,173,4279,0,0;QS=2,0;MQSB=0.6;MQ0F=0 PL:DP:DV 0,18,161:6:0 0,3,20:1:0 0,0,0:0:0 +X 4018 . G <*> 0 . DP=11;I16=8,2,0,0,284,8442,0,0,554,31538,0,0,249,6201,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,183:9:0 0,3,17:1:0 0,0,0:0:0 +X 4019 . C <*> 0 . DP=11;I16=9,2,0,0,383,14427,0,0,614,35138,0,0,250,6250,0,0;QS=2,0;MQSB=0.777778;MQ0F=0 PL:DP:DV 0,30,228:10:0 0,3,33:1:0 0,0,0:0:0 +X 4020 . T <*> 0 . DP=10;I16=8,2,0,0,362,13668,0,0,554,31538,0,0,250,6250,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,213:9:0 0,3,38:1:0 0,0,0:0:0 +X 4021 . A <*> 0 . DP=10;I16=8,1,0,0,304,10512,0,0,494,27938,0,0,225,5625,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,177:8:0 0,3,33:1:0 0,0,0:0:0 +X 4022 . C <*> 0 . DP=10;I16=7,2,0,0,310,11582,0,0,494,27938,0,0,225,5625,0,0;QS=2,0;MQSB=0.714286;MQ0F=0 PL:DP:DV 0,24,202:8:0 0,3,36:1:0 0,0,0:0:0 +X 4023 . A <*> 0 . DP=10;I16=8,2,0,0,354,13116,0,0,554,31538,0,0,250,6250,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,209:9:0 0,3,40:1:0 0,0,0:0:0 +X 4024 . C <*> 0 . DP=10;I16=8,2,0,0,361,13669,0,0,554,31538,0,0,250,6250,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,214:9:0 0,3,39:1:0 0,0,0:0:0 +X 4025 . T <*> 0 . DP=10;I16=8,1,0,0,360,14488,0,0,494,27938,0,0,224,5576,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,199:8:0 0,3,42:1:0 0,0,0:0:0 +X 4026 . C <*> 0 . DP=10;I16=8,2,0,0,329,11655,0,0,554,31538,0,0,248,6154,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,192:9:0 0,3,39:1:0 0,0,0:0:0 +X 4027 . C <*> 0 . DP=10;I16=8,2,0,0,380,14888,0,0,554,31538,0,0,246,6060,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,231:9:0 0,3,38:1:0 0,0,0:0:0 +X 4028 . T <*> 0 . DP=10;I16=8,2,0,0,333,12157,0,0,554,31538,0,0,244,5970,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,202:9:0 0,3,41:1:0 0,0,0:0:0 +X 4029 . T <*> 0 . DP=10;I16=8,2,0,0,377,14333,0,0,554,31538,0,0,242,5884,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,225:9:0 0,3,38:1:0 0,0,0:0:0 +X 4030 . C <*> 0 . DP=10;I16=8,2,0,0,348,12558,0,0,554,31538,0,0,240,5802,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,211:9:0 0,3,30:1:0 0,0,0:0:0 +X 4031 . T <*> 0 . DP=10;I16=8,2,0,0,388,15302,0,0,554,31538,0,0,238,5724,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,229:9:0 0,3,39:1:0 0,0,0:0:0 +X 4032 . T <*> 0 . DP=10;I16=8,2,0,0,341,11901,0,0,554,31538,0,0,236,5650,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,204:9:0 0,3,39:1:0 0,0,0:0:0 +X 4033 . A <*> 0 . DP=10;I16=7,2,0,0,299,10717,0,0,494,27938,0,0,218,5324,0,0;QS=2,0;MQSB=0.714286;MQ0F=0 PL:DP:DV 0,24,193:8:0 0,3,38:1:0 0,0,0:0:0 +X 4034 . G <*> 0 . DP=10;I16=8,2,0,0,347,12527,0,0,554,31538,0,0,231,5465,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,211:9:0 0,3,39:1:0 0,0,0:0:0 +X 4035 . G T,<*> 0 . DP=10;I16=7,2,1,0,316,11900,13,169,494,27938,60,3600,202,4682,25,625;QS=1.9547,0.0452962,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.75;BQB=1;MQ0F=0 PL:DP:DV 0,13,195,24,198,200:9:1 0,3,31,3,31,31:1:0 0,0,0,0,0,0:0:0 +X 4036 . G <*> 0 . DP=10;I16=8,1,0,0,269,8839,0,0,494,27938,0,0,198,4532,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,156:8:0 0,3,34:1:0 0,0,0:0:0 +X 4037 . C <*> 0 . DP=10;I16=8,2,0,0,342,12466,0,0,554,31538,0,0,219,5015,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,210:9:0 0,3,30:1:0 0,0,0:0:0 +X 4038 . T <*> 0 . DP=10;I16=8,2,0,0,335,12149,0,0,554,31538,0,0,215,4881,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,203:9:0 0,3,29:1:0 0,0,0:0:0 +X 4039 . G <*> 0 . DP=10;I16=8,1,0,0,302,10798,0,0,494,27938,0,0,186,4130,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,180:8:0 0,3,31:1:0 0,0,0:0:0 +X 4040 . A <*> 0 . DP=10;I16=8,2,0,0,380,14602,0,0,554,31538,0,0,207,4637,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,223:9:0 0,3,41:1:0 0,0,0:0:0 +X 4041 . T <*> 0 . DP=10;I16=8,2,0,0,367,13633,0,0,554,31538,0,0,202,4478,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,216:9:0 0,3,40:1:0 0,0,0:0:0 +X 4042 . A <*> 0 . DP=10;I16=8,2,0,0,337,11657,0,0,554,31538,0,0,197,4329,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,205:9:0 0,3,34:1:0 0,0,0:0:0 +X 4043 . T <*> 0 . DP=10;I16=8,2,0,0,314,10428,0,0,554,31538,0,0,192,4190,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,190:9:0 0,3,35:1:0 0,0,0:0:0 +X 4044 . T <*> 0 . DP=10;I16=8,2,0,0,333,11579,0,0,554,31538,0,0,187,4061,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,199:9:0 0,3,37:1:0 0,0,0:0:0 +X 4045 . C <*> 0 . DP=10;I16=7,2,0,0,291,10099,0,0,494,27938,0,0,176,3906,0,0;QS=1,0;MQSB=0.714286;MQ0F=0 PL:DP:DV 0,27,204:9:0 0,0,0:0:0 0,0,0:0:0 +X 4046 . C <*> 0 . DP=10;I16=8,2,0,0,356,13032,0,0,554,31538,0,0,177,3833,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,212:9:0 0,3,35:1:0 0,0,0:0:0 +X 4047 . A <*> 0 . DP=10;I16=8,2,0,0,347,12557,0,0,554,31538,0,0,172,3734,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,204:9:0 0,3,40:1:0 0,0,0:0:0 +X 4048 . C <*> 0 . DP=10;I16=8,2,0,0,342,12124,0,0,554,31538,0,0,167,3645,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,202:9:0 0,3,37:1:0 0,0,0:0:0 +X 4049 . G <*> 0 . DP=10;I16=7,2,0,0,260,7786,0,0,494,27938,0,0,146,3310,0,0;QS=2,0;MQSB=0.714286;MQ0F=0 PL:DP:DV 0,24,173:8:0 0,3,24:1:0 0,0,0:0:0 +X 4050 . C <*> 0 . DP=9;I16=6,2,0,0,291,10813,0,0,434,24338,0,0,157,3495,0,0;QS=1,0;MQSB=0.666667;MQ0F=0 PL:DP:DV 0,24,204:8:0 0,0,0:0:0 0,0,0:0:0 +X 4051 . A <*> 0 . DP=8;I16=5,2,0,0,259,9679,0,0,374,20738,0,0,146,3370,0,0;QS=1,0;MQSB=0.6;MQ0F=0 PL:DP:DV 0,21,192:7:0 0,0,0:0:0 0,0,0:0:0 +X 4052 . C <*> 0 . DP=8;I16=5,2,0,0,247,9025,0,0,374,20738,0,0,143,3281,0,0;QS=1,0;MQSB=0.6;MQ0F=0 PL:DP:DV 0,21,190:7:0 0,0,0:0:0 0,0,0:0:0 +X 4053 . C <*> 0 . DP=8;I16=6,2,0,0,254,9000,0,0,434,24338,0,0,146,3234,0,0;QS=1,0;MQSB=0.666667;MQ0F=0 PL:DP:DV 0,24,184:8:0 0,0,0:0:0 0,0,0:0:0 +X 4054 . C <*> 0 . DP=8;I16=3,2,0,0,160,5344,0,0,254,13538,0,0,122,2984,0,0;QS=1,0;MQSB=0.333333;MQ0F=0 PL:DP:DV 0,15,134:5:0 0,0,0:0:0 0,0,0:0:0 +X 4055 . G <*> 0 . DP=8;I16=6,2,0,0,230,6982,0,0,434,24338,0,0,138,3066,0,0;QS=1,0;MQSB=0.666667;MQ0F=0 PL:DP:DV 0,24,169:8:0 0,0,0:0:0 0,0,0:0:0 +X 4056 . C <*> 0 . DP=8;I16=6,2,0,0,275,10153,0,0,434,24338,0,0,134,2994,0,0;QS=1,0;MQSB=0.666667;MQ0F=0 PL:DP:DV 0,24,197:8:0 0,0,0:0:0 0,0,0:0:0 +X 4057 . T <*> 0 . DP=8;I16=5,2,0,0,243,8603,0,0,374,20738,0,0,127,2877,0,0;QS=1,0;MQSB=0.6;MQ0F=0 PL:DP:DV 0,21,182:7:0 0,0,0:0:0 0,0,0:0:0 +X 4058 . A <*> 0 . DP=7;I16=4,2,0,0,214,7742,0,0,314,17138,0,0,116,2728,0,0;QS=1,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,18,171:6:0 0,0,0:0:0 0,0,0:0:0 +X 4059 . C <*> 0 . DP=6;I16=4,2,0,0,204,7164,0,0,314,17138,0,0,119,2635,0,0;QS=1,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,18,168:6:0 0,0,0:0:0 0,0,0:0:0 +X 4060 . A <*> 0 . DP=6;I16=4,2,0,0,227,8683,0,0,314,17138,0,0,115,2501,0,0;QS=1,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,18,177:6:0 0,0,0:0:0 0,0,0:0:0 +X 4061 . C <*> 0 . DP=6;I16=4,2,0,0,193,6681,0,0,314,17138,0,0,111,2375,0,0;QS=1,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,18,157:6:0 0,0,0:0:0 0,0,0:0:0 +X 4062 . T <*> 0 . DP=6;I16=4,1,0,0,195,7621,0,0,254,13538,0,0,82,1632,0,0;QS=1,0;MQSB=1;MQ0F=0 PL:DP:DV 0,15,151:5:0 0,0,0:0:0 0,0,0:0:0 +X 4063 . C <*> 0 . DP=6;I16=4,2,0,0,216,7984,0,0,314,17138,0,0,102,2098,0,0;QS=1,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,18,170:6:0 0,0,0:0:0 0,0,0:0:0 +X 4064 . C <*> 0 . DP=6;I16=4,2,0,0,227,8747,0,0,314,17138,0,0,97,1949,0,0;QS=1,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,18,177:6:0 0,0,0:0:0 0,0,0:0:0 +X 4065 . T <*> 0 . DP=6;I16=4,2,0,0,202,6880,0,0,314,17138,0,0,92,1810,0,0;QS=1,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,18,161:6:0 0,0,0:0:0 0,0,0:0:0 +X 4066 . T <*> 0 . DP=5;I16=3,2,0,0,180,6554,0,0,254,13538,0,0,88,1680,0,0;QS=1,0;MQSB=0.333333;MQ0F=0 PL:DP:DV 0,15,153:5:0 0,0,0:0:0 0,0,0:0:0 +X 4067 . C <*> 0 . DP=5;I16=3,2,0,0,181,6637,0,0,254,13538,0,0,84,1558,0,0;QS=1,0;MQSB=0.333333;MQ0F=0 PL:DP:DV 0,15,153:5:0 0,0,0:0:0 0,0,0:0:0 +X 4068 . T <*> 0 . DP=5;I16=3,2,0,0,198,7868,0,0,254,13538,0,0,80,1444,0,0;QS=1,0;MQSB=0.333333;MQ0F=0 PL:DP:DV 0,15,164:5:0 0,0,0:0:0 0,0,0:0:0 +X 4069 . T <*> 0 . DP=5;I16=3,2,0,0,177,6325,0,0,254,13538,0,0,76,1338,0,0;QS=1,0;MQSB=0.333333;MQ0F=0 PL:DP:DV 0,15,154:5:0 0,0,0:0:0 0,0,0:0:0 +X 4070 . A <*> 0 . DP=5;I16=3,2,0,0,161,5263,0,0,254,13538,0,0,72,1240,0,0;QS=1,0;MQSB=0.333333;MQ0F=0 PL:DP:DV 0,15,140:5:0 0,0,0:0:0 0,0,0:0:0 +X 4071 . G <*> 0 . DP=5;I16=3,2,0,0,166,5658,0,0,254,13538,0,0,68,1150,0,0;QS=1,0;MQSB=0.333333;MQ0F=0 PL:DP:DV 0,15,142:5:0 0,0,0:0:0 0,0,0:0:0 +X 4072 . G <*> 0 . DP=5;I16=2,2,0,0,138,4974,0,0,194,9938,0,0,55,987,0,0;QS=1,0;MQSB=0;MQ0F=0 PL:DP:DV 0,12,122:4:0 0,0,0:0:0 0,0,0:0:0 +X 4073 . G <*> 0 . DP=5;I16=3,2,0,0,156,5082,0,0,254,13538,0,0,60,994,0,0;QS=1,0;MQSB=0.333333;MQ0F=0 PL:DP:DV 0,15,136:5:0 0,0,0:0:0 0,0,0:0:0 +X 4074 . C <*> 0 . DP=5;I16=3,2,0,0,160,5602,0,0,254,13538,0,0,56,928,0,0;QS=1,0;MQSB=0.333333;MQ0F=0 PL:DP:DV 0,15,142:5:0 0,0,0:0:0 0,0,0:0:0 +X 4075 . T <*> 0 . DP=5;I16=3,2,0,0,187,7069,0,0,254,13538,0,0,52,870,0,0;QS=1,0;MQSB=0.333333;MQ0F=0 PL:DP:DV 0,15,155:5:0 0,0,0:0:0 0,0,0:0:0 +X 4076 . G <*> 0 . DP=5;I16=3,2,0,0,174,6298,0,0,254,13538,0,0,48,820,0,0;QS=1,0;MQSB=0.333333;MQ0F=0 PL:DP:DV 0,15,149:5:0 0,0,0:0:0 0,0,0:0:0 +X 4077 . A <*> 0 . DP=4;I16=3,1,0,0,138,4810,0,0,194,9938,0,0,44,728,0,0;QS=1,0;MQSB=1;MQ0F=0 PL:DP:DV 0,12,121:4:0 0,0,0:0:0 0,0,0:0:0 +X 4078 . T <*> 0 . DP=4;I16=3,1,0,0,143,5173,0,0,194,9938,0,0,40,644,0,0;QS=1,0;MQSB=1;MQ0F=0 PL:DP:DV 0,12,124:4:0 0,0,0:0:0 0,0,0:0:0 +X 4079 . A <*> 0 . DP=4;I16=3,1,0,0,121,3847,0,0,194,9938,0,0,36,568,0,0;QS=1,0;MQSB=1;MQ0F=0 PL:DP:DV 0,12,107:4:0 0,0,0:0:0 0,0,0:0:0 +X 4080 . T <*> 0 . DP=4;I16=3,0,0,0,106,3778,0,0,134,6338,0,0,25,451,0,0;QS=1,0;MQ0F=0 PL:DP:DV 0,9,87:3:0 0,0,0:0:0 0,0,0:0:0 +X 4081 . T <*> 0 . DP=4;I16=3,1,0,0,106,2934,0,0,194,9938,0,0,28,440,0,0;QS=1,0;MQSB=1;MQ0F=0 PL:DP:DV 0,12,94:4:0 0,0,0:0:0 0,0,0:0:0 +X 4082 . C <*> 0 . DP=3;I16=2,1,0,0,110,4042,0,0,134,6338,0,0,25,387,0,0;QS=1,0;MQSB=1;MQ0F=0 PL:DP:DV 0,9,103:3:0 0,0,0:0:0 0,0,0:0:0 +X 4083 . C <*> 0 . DP=3;I16=2,1,0,0,104,3648,0,0,134,6338,0,0,22,340,0,0;QS=1,0;MQSB=1;MQ0F=0 PL:DP:DV 0,9,98:3:0 0,0,0:0:0 0,0,0:0:0 +X 4084 . A <*> 0 . DP=2;I16=1,1,0,0,78,3050,0,0,97,4969,0,0,20,298,0,0;QS=1,0;MQSB=1;MQ0F=0 PL:DP:DV 0,6,74:2:0 0,0,0:0:0 0,0,0:0:0 +X 4085 . C <*> 0 . DP=2;I16=1,1,0,0,62,1940,0,0,97,4969,0,0,18,260,0,0;QS=1,0;MQSB=1;MQ0F=0 PL:DP:DV 0,6,62:2:0 0,0,0:0:0 0,0,0:0:0 +X 4086 . G <*> 0 . DP=2;I16=1,1,0,0,56,1640,0,0,97,4969,0,0,16,226,0,0;QS=1,0;MQSB=1;MQ0F=0 PL:DP:DV 0,6,56:2:0 0,0,0:0:0 0,0,0:0:0 +X 4087 . C <*> 0 . DP=2;I16=1,1,0,0,69,2405,0,0,97,4969,0,0,14,196,0,0;QS=1,0;MQSB=1;MQ0F=0 PL:DP:DV 0,6,68:2:0 0,0,0:0:0 0,0,0:0:0 +X 4088 . A <*> 0 . DP=1;I16=1,0,0,0,39,1521,0,0,37,1369,0,0,13,169,0,0;QS=1,0;MQ0F=0 PL:DP:DV 0,3,37:1:0 0,0,0:0:0 0,0,0:0:0 +X 4089 . C <*> 0 . DP=1;I16=1,0,0,0,36,1296,0,0,37,1369,0,0,12,144,0,0;QS=1,0;MQ0F=0 PL:DP:DV 0,3,36:1:0 0,0,0:0:0 0,0,0:0:0 +X 4090 . C <*> 0 . DP=1;I16=1,0,0,0,33,1089,0,0,37,1369,0,0,11,121,0,0;QS=1,0;MQ0F=0 PL:DP:DV 0,3,33:1:0 0,0,0:0:0 0,0,0:0:0 +X 4091 . T <*> 0 . DP=1;I16=1,0,0,0,36,1296,0,0,37,1369,0,0,10,100,0,0;QS=1,0;MQ0F=0 PL:DP:DV 0,3,36:1:0 0,0,0:0:0 0,0,0:0:0 +X 4092 . G <*> 0 . DP=1;I16=1,0,0,0,37,1369,0,0,37,1369,0,0,9,81,0,0;QS=1,0;MQ0F=0 PL:DP:DV 0,3,37:1:0 0,0,0:0:0 0,0,0:0:0 +X 4093 . C <*> 0 . DP=1;I16=1,0,0,0,35,1225,0,0,37,1369,0,0,8,64,0,0;QS=1,0;MQ0F=0 PL:DP:DV 0,3,35:1:0 0,0,0:0:0 0,0,0:0:0 +X 4094 . T <*> 0 . DP=1;I16=1,0,0,0,40,1600,0,0,37,1369,0,0,7,49,0,0;QS=1,0;MQ0F=0 PL:DP:DV 0,3,37:1:0 0,0,0:0:0 0,0,0:0:0 +X 4095 . A <*> 0 . DP=1;I16=1,0,0,0,35,1225,0,0,37,1369,0,0,6,36,0,0;QS=1,0;MQ0F=0 PL:DP:DV 0,3,35:1:0 0,0,0:0:0 0,0,0:0:0 +X 4096 . C <*> 0 . DP=1;I16=1,0,0,0,32,1024,0,0,37,1369,0,0,5,25,0,0;QS=1,0;MQ0F=0 PL:DP:DV 0,3,32:1:0 0,0,0:0:0 0,0,0:0:0 +X 4097 . A <*> 0 . DP=1;I16=1,0,0,0,35,1225,0,0,37,1369,0,0,4,16,0,0;QS=1,0;MQ0F=0 PL:DP:DV 0,3,35:1:0 0,0,0:0:0 0,0,0:0:0 +X 4098 . C <*> 0 . DP=1;I16=1,0,0,0,31,961,0,0,37,1369,0,0,3,9,0,0;QS=1,0;MQ0F=0 PL:DP:DV 0,3,31:1:0 0,0,0:0:0 0,0,0:0:0 +X 4099 . T <*> 0 . DP=1;I16=1,0,0,0,32,1024,0,0,37,1369,0,0,2,4,0,0;QS=1,0;MQ0F=0 PL:DP:DV 0,3,32:1:0 0,0,0:0:0 0,0,0:0:0 +X 4100 . C <*> 0 . DP=1;I16=1,0,0,0,27,729,0,0,37,1369,0,0,1,1,0,0;QS=1,0;MQ0F=0 PL:DP:DV 0,3,27:1:0 0,0,0:0:0 0,0,0:0:0 +X 4101 . C <*> 0 . DP=1;I16=1,0,0,0,26,676,0,0,37,1369,0,0,0,0,0,0;QS=1,0;MQ0F=0 PL:DP:DV 0,3,26:1:0 0,0,0:0:0 0,0,0:0:0 diff --git a/test/mpileup.c.vcf b/test/mpileup.c.vcf new file mode 100644 index 000000000..13c013225 --- /dev/null +++ b/test/mpileup.c.vcf @@ -0,0 +1,4127 @@ +##fileformat=VCFv4.2 +##FILTER= +##samtoolsVersion=1.1-19-g6b249e2+htslib-1.1-74-g845c515 +##samtoolsCommand=samtools mpileup -uvDV -b xxx//mpileup.bam.list -f xxx//mpileup.ref.fa.gz +##reference=file://xxx//mpileup.ref.fa.gz +##contig= +##ALT= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##FORMAT= +##FORMAT= +##FORMAT= +#CHROM POS ID REF ALT QUAL FILTER INFO FORMAT HG00100 HG00101 HG00102 +17 1 . A 0 . DP=11;I16=11,0,0,0,452,18594,0,0,319,9251,0,0,223,4959,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 +17 2 . A 0 . DP=11;I16=11,0,0,0,439,17587,0,0,319,9251,0,0,226,5030,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 +17 3 . G 0 . DP=11;I16=11,0,0,0,431,16971,0,0,319,9251,0,0,229,5111,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 +17 4 . C 0 . DP=11;I16=11,0,0,0,423,16417,0,0,319,9251,0,0,232,5202,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,71:3:0 +17 5 . T 0 . DP=11;I16=11,0,0,0,450,18520,0,0,319,9251,0,0,234,5252,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 +17 6 . T 0 . DP=11;I16=11,0,0,0,403,14847,0,0,319,9251,0,0,236,5310,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 +17 7 . C 0 . DP=11;I16=11,0,0,0,446,18114,0,0,319,9251,0,0,237,5327,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 +17 8 . T 0 . DP=11;I16=11,0,0,0,465,19677,0,0,319,9251,0,0,238,5354,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 +17 9 . C 0 . DP=11;I16=11,0,0,0,447,18205,0,0,319,9251,0,0,239,5391,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 +17 10 . A 0 . DP=11;I16=11,0,0,0,426,16756,0,0,319,9251,0,0,240,5438,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,69:3:0 +17 11 . C 0 . DP=11;I16=11,0,0,0,413,15603,0,0,319,9251,0,0,241,5495,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 +17 12 . C 0 . DP=11;I16=11,0,0,0,438,17506,0,0,319,9251,0,0,242,5562,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 +17 13 . C 0 . DP=11;I16=11,0,0,0,437,17463,0,0,319,9251,0,0,243,5639,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 +17 14 . T 0 . DP=11;I16=11,0,0,0,453,18715,0,0,319,9251,0,0,242,5628,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 +17 15 . G 0 . DP=11;I16=11,0,0,0,439,17599,0,0,319,9251,0,0,240,5580,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 +17 16 . T 0 . DP=11;I16=11,0,0,0,426,16546,0,0,319,9251,0,0,238,5544,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 +17 17 . T 0 . DP=11;I16=11,0,0,0,407,15195,0,0,319,9251,0,0,235,5469,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 +17 18 . C 0 . DP=12;I16=12,0,0,0,450,17136,0,0,379,12851,0,0,231,5353,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,18,113:6:0 0,9,72:3:0 0,9,72:3:0 +17 19 . C 0 . DP=13;I16=13,0,0,0,502,19652,0,0,439,16451,0,0,228,5246,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,18,112:6:0 0,12,89:4:0 0,9,72:3:0 +17 20 . T 0 . DP=13;I16=13,0,0,0,532,21878,0,0,439,16451,0,0,226,5150,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,18,116:6:0 0,12,98:4:0 0,9,72:3:0 +17 21 . G 0 . DP=13;I16=13,0,0,0,498,19254,0,0,439,16451,0,0,224,5066,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,18,117:6:0 0,12,94:4:0 0,9,72:3:0 +17 22 . C 0 . DP=13;I16=13,0,0,0,511,20289,0,0,470,19210,0,0,223,4993,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,18,115:6:0 0,12,91:4:0 0,9,76:3:0 +17 23 . A 0 . DP=14;I16=14,0,0,0,513,19399,0,0,530,22810,0,0,223,4931,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,133:7:0 0,12,82:4:0 0,9,82:3:0 +17 24 . T 0 . DP=14;I16=14,0,0,0,534,20540,0,0,530,22810,0,0,224,4882,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,131:7:0 0,12,96:4:0 0,9,80:3:0 +17 25 . A 0 . DP=15;I16=15,0,0,0,561,21133,0,0,590,26410,0,0,225,4847,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,140:8:0 0,12,96:4:0 0,9,81:3:0 +17 26 . G 0 . DP=15;I16=15,0,0,0,591,23429,0,0,590,26410,0,0,227,4827,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,151:8:0 0,12,96:4:0 0,9,81:3:0 +17 27 . A 0 . DP=15;I16=15,0,0,0,588,23120,0,0,590,26410,0,0,229,4823,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,146:8:0 0,12,98:4:0 0,9,83:3:0 +17 28 . T 0 . DP=16;I16=16,0,0,0,605,23001,0,0,650,30010,0,0,231,4835,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,147:8:0 0,12,97:4:0 0,12,101:4:0 +17 29 . A 0 . DP=17;I16=17,0,0,0,615,22533,0,0,710,33610,0,0,234,4864,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,146:8:0 0,15,102:5:0 0,12,104:4:0 +17 30 . A 0 . DP=17;I16=17,0,0,0,660,25914,0,0,710,33610,0,0,238,4912,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,149:8:0 0,15,115:5:0 0,12,108:4:0 +17 31 . T 0 . DP=17;I16=17,0,0,0,656,25392,0,0,710,33610,0,0,242,4980,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,150:8:0 0,15,113:5:0 0,12,105:4:0 +17 32 . T 0 . DP=17;I16=17,0,0,0,605,21789,0,0,741,36369,0,0,247,5067,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,143:8:0 0,15,104:5:0 0,12,104:4:0 +17 33 . G 0 . DP=17;I16=17,0,0,0,659,25757,0,0,741,36369,0,0,252,5124,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,158:8:0 0,15,118:5:0 0,12,105:4:0 +17 34 . C 0 . DP=17;I16=17,0,0,0,658,25704,0,0,741,36369,0,0,257,5203,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,151:8:0 0,15,121:5:0 0,12,106:4:0 +17 35 . A 0 . DP=18;I16=18,0,0,0,677,25881,0,0,801,39969,0,0,262,5304,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,152:8:0 0,15,109:5:0 0,15,121:5:0 +17 36 . T 0 . DP=18;I16=18,0,0,0,678,25796,0,0,801,39969,0,0,268,5428,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,151:8:0 0,15,114:5:0 0,15,125:5:0 +17 37 . G 0 . DP=18;I16=18,0,0,0,685,26291,0,0,801,39969,0,0,274,5576,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,157:8:0 0,15,116:5:0 0,15,126:5:0 +17 38 . A 0 . DP=18;I16=18,0,0,0,697,27245,0,0,801,39969,0,0,280,5748,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,152:8:0 0,15,116:5:0 0,15,129:5:0 +17 39 . C 0 . DP=16;I16=16,0,0,0,591,22311,0,0,743,38287,0,0,288,5942,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,148:7:0 0,12,94:4:0 0,15,123:5:0 +17 40 . A 0 . DP=16;I16=16,0,0,0,630,24896,0,0,743,38287,0,0,295,6107,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,146:7:0 0,12,104:4:0 0,15,127:5:0 +17 41 . A 0 . DP=17;I16=17,0,0,0,645,24685,0,0,803,41887,0,0,302,6294,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,151:8:0 0,12,104:4:0 0,15,131:5:0 +17 42 . T 0 . DP=17;I16=17,0,0,0,618,23118,0,0,803,41887,0,0,310,6504,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,155:8:0 0,12,82:4:0 0,15,127:5:0 +17 43 . T 0 . DP=17;I16=17,0,0,0,631,23689,0,0,803,41887,0,0,318,6738,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,151:8:0 0,12,101:4:0 0,15,129:5:0 +17 44 . G 0 . DP=17;I16=17,0,0,0,664,26162,0,0,803,41887,0,0,324,6896,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,164:8:0 0,12,100:4:0 0,15,129:5:0 +17 45 . C 0 . DP=17;I16=17,0,0,0,657,25525,0,0,803,41887,0,0,329,7027,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,163:8:0 0,12,108:4:0 0,15,125:5:0 +17 46 . C 0 . DP=17;I16=17,0,0,0,646,25244,0,0,803,41887,0,0,334,7180,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,161:8:0 0,12,98:4:0 0,15,131:5:0 +17 47 . T 0 . DP=17;I16=17,0,0,0,700,28998,0,0,803,41887,0,0,339,7355,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,165:8:0 0,12,110:4:0 0,15,136:5:0 +17 48 . T 0 . DP=17;I16=17,0,0,0,648,25020,0,0,803,41887,0,0,343,7501,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,155:8:0 0,12,105:4:0 0,15,131:5:0 +17 49 . G 0 . DP=18;I16=18,0,0,0,686,26674,0,0,832,42728,0,0,346,7616,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,158:8:0 0,15,119:5:0 0,15,128:5:0 +17 50 . T 0 . DP=18;I16=17,0,0,0,650,24972,0,0,772,39128,0,0,332,7426,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,155:8:0 0,12,101:4:0 0,15,128:5:0 +17 51 . C 0 . DP=18;I16=18,0,0,0,681,26529,0,0,832,42728,0,0,353,7853,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,167:8:0 0,15,99:5:0 0,15,127:5:0 +17 52 . C 0 . DP=18;I16=17,0,0,0,645,24983,0,0,803,41887,0,0,353,7965,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,164:8:0 0,12,99:4:0 0,15,128:5:0 +17 53 . C 0 . DP=18;I16=18,0,0,0,687,26735,0,0,832,42728,0,0,359,8113,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,164:8:0 0,15,113:5:0 0,15,132:5:0 +17 54 . T 0 . DP=18;I16=18,0,0,0,736,30194,0,0,832,42728,0,0,361,8219,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,163:8:0 0,15,128:5:0 0,15,136:5:0 +17 55 . G 0 . DP=18;I16=18,0,0,0,674,26082,0,0,832,42728,0,0,362,8290,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,168:8:0 0,15,112:5:0 0,15,122:5:0 +17 56 . C 0 . DP=18;I16=18,0,0,0,701,27645,0,0,832,42728,0,0,363,8375,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,162:8:0 0,15,121:5:0 0,15,131:5:0 +17 57 . T 0 . DP=18;I16=17,0,0,0,694,29118,0,0,803,41887,0,0,356,8410,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,163:8:0 0,12,117:4:0 0,15,138:5:0 +17 58 . G 0 . DP=17;I16=16,0,0,0,616,24356,0,0,774,41046,0,0,356,8454,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,159:7:0 0,12,95:4:0 0,15,131:5:0 +17 59 . A 0 . DP=17;I16=17,0,0,0,656,26038,0,0,803,41887,0,0,366,8606,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,155:7:0 0,15,116:5:0 0,15,134:5:0 +17 60 . A 0 . DP=17;I16=17,0,0,0,663,26463,0,0,803,41887,0,0,367,8687,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,151:7:0 0,15,127:5:0 0,15,138:5:0 +17 61 . T 0 . DP=17;I16=16,0,0,0,605,23215,0,0,774,41046,0,0,355,8583,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,152:7:0 0,12,101:4:0 0,15,131:5:0 +17 62 . G 0 . DP=18;I16=17,0,0,0,646,24868,0,0,834,44646,0,0,353,8557,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,158:7:0 0,12,103:4:0 0,18,141:6:0 +17 63 . T 0 . DP=18;I16=17,0,0,0,590,21682,0,0,803,41887,0,0,341,8111,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,148:7:0 0,12,80:4:0 0,18,144:6:0 +17 64 . G 0 . DP=19;I16=19,0,0,0,696,26416,0,0,923,49087,0,0,366,8758,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,169:8:0 0,15,103:5:0 0,18,142:6:0 +17 65 . C 0 . DP=18;I16=18,0,0,0,686,26512,0,0,894,48246,0,0,367,8743,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,163:7:0 0,15,116:5:0 0,18,147:6:0 +17 66 . T 0 . DP=18;I16=17,0,0,0,691,28315,0,0,834,44646,0,0,342,8068,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,164:7:0 0,12,110:4:0 0,18,153:6:0 +17 67 . C 0 . DP=17;I16=17,0,0,0,645,25313,0,0,834,44646,0,0,341,7983,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,163:7:0 0,12,94:4:0 0,18,147:6:0 +17 68 . T 0 . DP=17;I16=17,0,0,0,691,28307,0,0,834,44646,0,0,339,7863,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,165:7:0 0,12,108:4:0 0,18,151:6:0 +17 69 . G 0 . DP=17;I16=17,0,0,0,657,25721,0,0,865,47405,0,0,338,7758,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,172:8:0 0,9,93:3:0 0,18,142:6:0 +17 70 . G 0 . DP=17;I16=16,0,0,0,575,21391,0,0,836,46564,0,0,317,7227,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,162:8:0 0,6,64:2:0 0,18,141:6:0 +17 71 . G 0 . DP=17;I16=15,0,0,0,571,21975,0,0,776,42964,0,0,307,7029,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,170:8:0 0,6,72:2:0 0,15,130:5:0 +17 72 . G 0 . DP=17;I16=15,0,0,0,572,22002,0,0,776,42964,0,0,305,6907,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,171:8:0 0,6,65:2:0 0,15,131:5:0 +17 73 . T 0 . DP=18;I16=16,0,0,0,623,25301,0,0,836,46564,0,0,314,6918,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,158:8:0 0,6,94:2:0 0,18,143:6:0 +17 74 . C 0 . DP=18;I16=17,0,0,0,674,28110,0,0,865,47405,0,0,338,7468,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,176:8:0 0,9,106:3:0 0,18,141:6:0 +17 75 . T 0 . DP=18;I16=16,0,0,0,685,30675,0,0,836,46564,0,0,312,6782,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,175:8:0 0,6,90:2:0 0,18,150:6:0 +17 76 . C 0 . DP=18;I16=17,0,0,0,683,29481,0,0,865,47405,0,0,336,7360,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,174:8:0 0,9,98:3:0 0,18,148:6:0 +17 77 . T 0 . DP=18;I16=16,0,0,0,710,33072,0,0,836,46564,0,0,310,6702,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,179:8:0 0,6,92:2:0 0,18,154:6:0 +17 78 . G 0 . DP=18;I16=16,0,0,0,692,31158,0,0,836,46564,0,0,309,6683,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,180:8:0 0,6,94:2:0 0,18,149:6:0 +17 79 . G 0 . DP=18;I16=15,0,0,0,605,26629,0,0,776,42964,0,0,283,6053,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,168:8:0 0,3,60:1:0 0,18,149:6:0 +17 80 . G 0 . DP=18;I16=17,0,0,0,688,30128,0,0,865,47405,0,0,332,7312,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,173:8:0 0,9,106:3:0 0,18,151:6:0 +17 81 . G 0 . DP=18;I16=16,0,0,0,631,27429,0,0,836,46564,0,0,326,7310,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,165:7:0 0,9,97:3:0 0,18,145:6:0 +17 82 . T 0 . DP=18;I16=15,0,0,0,559,22735,0,0,776,42964,0,0,280,6122,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,154:8:0 0,3,60:1:0 0,18,131:6:0 +17 83 . C 0 . DP=18;I16=16,0,0,0,622,27146,0,0,836,46564,0,0,304,6798,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,170:8:0 0,6,75:2:0 0,18,145:6:0 +17 84 . T 0 . DP=18;I16=17,0,0,0,705,32445,0,0,865,47405,0,0,328,7488,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,181:8:0 0,9,85:3:0 0,18,154:6:0 +17 85 . C 0 . DP=18;I16=17,0,0,0,708,31222,0,0,865,47405,0,0,327,7567,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,181:8:0 0,9,108:3:0 0,18,153:6:0 +17 86 . A 0 . DP=18;I16=17,0,0,0,692,29540,0,0,865,47405,0,0,326,7660,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,169:8:0 0,9,111:3:0 0,18,149:6:0 +17 87 . C 0 . DP=18;I16=17,0,0,0,683,29493,0,0,896,50164,0,0,326,7766,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,174:8:0 0,9,103:3:0 0,18,148:6:0 +17 88 . C 0 . DP=18;I16=17,0,0,0,703,31005,0,0,896,50164,0,0,326,7834,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,174:8:0 0,9,113:3:0 0,18,153:6:0 +17 89 . C 0 . DP=18;I16=17,0,0,0,697,30875,0,0,896,50164,0,0,326,7914,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,176:8:0 0,9,103:3:0 0,18,154:6:0 +17 90 . A 0 . DP=17;I16=16,0,0,0,668,29732,0,0,867,49323,0,0,326,7954,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,173:8:0 0,9,114:3:0 0,15,138:5:0 +17 91 . C 0 . DP=16;I16=15,0,0,0,613,26409,0,0,838,48482,0,0,327,8001,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,170:7:0 0,9,113:3:0 0,15,133:5:0 +17 92 . G 0 . DP=16;I16=15,0,0,0,499,18731,0,0,838,48482,0,0,328,8054,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,143:7:0 0,9,100:3:0 0,15,96:5:0 +17 93 . A 0 . DP=16;I16=15,0,0,0,635,28655,0,0,869,51241,0,0,329,8063,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,167:7:0 0,9,108:3:0 0,15,145:5:0 +17 94 . C 0 . DP=16;I16=15,0,0,0,607,25893,0,0,869,51241,0,0,331,8079,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,21,166:7:0 0,9,105:3:0 0,15,135:5:0 +17 95 . C 0 . DP=17;I16=15,0,0,0,615,26761,0,0,900,54000,0,0,306,7378,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,178:8:0 0,6,91:2:0 0,15,135:5:0 +17 96 . A 0 . DP=17;I16=16,0,0,0,625,26705,0,0,929,54841,0,0,332,7936,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,172:8:0 0,9,99:3:0 0,15,134:5:0 +17 97 . A 0 . DP=18;I16=17,0,0,0,675,29017,0,0,958,55682,0,0,333,7879,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,179:9:0 0,9,104:3:0 0,15,145:5:0 +17 98 . C 0 . DP=18;I16=17,0,0,0,655,27231,0,0,958,55682,0,0,333,7735,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,179:9:0 0,9,105:3:0 0,15,131:5:0 +17 99 . T 0 . DP=18;I16=17,0,0,0,720,32840,0,0,958,55682,0,0,333,7607,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,186:9:0 0,9,115:3:0 0,15,153:5:0 +17 100 . C 0 . DP=18;I16=17,0,0,0,688,29762,0,0,958,55682,0,0,332,7446,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,189:9:0 0,9,108:3:0 0,15,134:5:0 +17 101 . C 0 . DP=18;I16=17,0,0,0,650,27530,0,0,958,55682,0,0,331,7303,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,182:9:0 0,9,99:3:0 0,15,132:5:0 +17 102 . C 0 . DP=18;I16=17,0,0,0,695,30453,0,0,958,55682,0,0,330,7178,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,188:9:0 0,9,111:3:0 0,15,139:5:0 +17 103 . T 0 . DP=18;I16=16,0,0,0,692,31998,0,0,929,54841,0,0,323,7035,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,189:8:0 0,9,108:3:0 0,15,147:5:0 +17 104 . G 0 . DP=18;I16=15,0,0,0,611,26723,0,0,900,54000,0,0,295,6259,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,178:8:0 0,6,89:2:0 0,15,133:5:0 +17 105 . G 0 . DP=19;I16=17,0,0,0,604,23936,0,0,989,58441,0,0,317,6751,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,170:9:0 0,9,97:3:0 0,15,125:5:0 +17 106 . G 0 . DP=19;I16=17,0,0,0,644,26574,0,0,989,58441,0,0,299,6093,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,30,190:10:0 0,6,85:2:0 0,15,124:5:0 +17 107 . C 0 . DP=19;I16=17,0,0,0,694,30064,0,0,989,58441,0,0,313,6543,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,192:9:0 0,9,108:3:0 0,15,136:5:0 +17 108 . C 0 . DP=19;I16=17,0,0,0,692,30148,0,0,989,58441,0,0,310,6420,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,190:9:0 0,9,108:3:0 0,15,135:5:0 +17 109 . T 0 . DP=19;I16=17,0,0,0,741,34273,0,0,989,58441,0,0,307,6319,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,195:9:0 0,9,110:3:0 0,15,150:5:0 +17 110 . G 0 . DP=19;I16=17,0,0,0,704,31276,0,0,989,58441,0,0,304,6240,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,194:9:0 0,9,104:3:0 0,15,136:5:0 +17 111 . G 0 . DP=19;I16=16,0,0,0,584,24362,0,0,929,54841,0,0,272,5416,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,30,167:10:0 0,6,88:2:0 0,12,118:4:0 +17 112 . C 0 . DP=19;I16=17,0,0,0,680,29854,0,0,989,58441,0,0,296,6052,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,191:9:0 0,9,95:3:0 0,15,135:5:0 +17 113 . A 0 . DP=19;I16=16,0,0,0,645,28035,0,0,960,57600,0,0,266,5318,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,176:9:0 0,6,87:2:0 0,15,139:5:0 +17 114 . C 0 . DP=19;I16=17,0,0,0,674,28788,0,0,989,58441,0,0,286,5856,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,182:9:0 0,9,103:3:0 0,15,133:5:0 +17 115 . C 0 . DP=21;I16=18,0,0,0,708,30546,0,0,1049,62041,0,0,274,5490,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,30,189:10:0 0,6,89:2:0 0,18,147:6:0 +17 116 . A 0 . DP=21;I16=17,1,0,0,727,31755,0,0,1049,62041,0,0,253,5079,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,183:9:0 0,6,90:2:0 0,21,175:7:0 +17 117 . G 0 . DP=21;I16=17,1,0,0,723,31221,0,0,1049,62041,0,0,249,5019,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,186:9:0 0,6,86:2:0 0,21,177:7:0 +17 118 . G 0 . DP=20;I16=16,1,0,0,636,26574,0,0,958,55682,0,0,266,5426,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,175:9:0 0,3,60:1:0 0,21,162:7:0 +17 119 . G 0 . DP=19;I16=16,1,0,0,629,26439,0,0,958,55682,0,0,267,5553,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,175:8:0 0,6,73:2:0 0,21,160:7:0 +17 120 . A 0 . DP=19;I16=16,1,0,0,672,29188,0,0,958,55682,0,0,264,5518,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,175:8:0 0,6,83:2:0 0,21,171:7:0 +17 121 . G 0 . DP=19;I16=16,1,0,0,662,28460,0,0,958,55682,0,0,260,5454,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,181:8:0 0,6,80:2:0 0,21,168:7:0 +17 122 . C 0 . DP=20;I16=17,1,0,0,716,31224,0,0,1018,59282,0,0,256,5410,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,181:8:0 0,9,99:3:0 0,21,178:7:0 +17 123 . T 0 . DP=18;I16=15,1,0,0,661,29997,0,0,898,52082,0,0,255,5385,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,167:7:0 0,9,112:3:0 0,18,166:6:0 +17 124 . T 0 . DP=19;I16=17,1,0,0,626,24802,0,0,987,56523,0,0,279,6003,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,154:9:0 0,9,104:3:0 0,18,154:6:0 +17 125 . A 0 . DP=18;I16=15,1,0,0,611,25689,0,0,898,52082,0,0,254,5340,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,154:7:0 0,9,104:3:0 0,18,162:6:0 +17 126 . A 0 . DP=18;I16=16,1,0,0,648,27366,0,0,927,52923,0,0,279,5947,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,162:8:0 0,9,107:3:0 0,18,174:6:0 +17 127 . C 0 . DP=18;I16=16,1,0,0,646,26972,0,0,927,52923,0,0,279,5949,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,163:8:0 0,9,109:3:0 0,18,160:6:0 +17 128 . A 0 . DP=18;I16=16,1,0,0,673,28797,0,0,927,52923,0,0,279,5971,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,169:8:0 0,9,111:3:0 0,18,162:6:0 +17 129 . A 0 . DP=17;I16=15,1,0,0,645,27891,0,0,867,49323,0,0,280,6012,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,168:8:0 0,9,113:3:0 0,15,159:5:0 +17 130 . A 0 . DP=17;I16=15,1,0,0,641,27295,0,0,867,49323,0,0,281,6071,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,169:8:0 0,9,113:3:0 0,15,152:5:0 +17 131 . C 0 . DP=16;I16=14,1,0,0,606,25732,0,0,838,48482,0,0,256,5472,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,167:7:0 0,9,110:3:0 0,15,147:5:0 +17 132 . A 0 . DP=16;I16=14,1,0,0,627,27579,0,0,838,48482,0,0,256,5514,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,169:7:0 0,9,110:3:0 0,15,151:5:0 +17 133 . T 0 . DP=15;I16=13,2,0,0,584,22816,0,0,838,48482,0,0,282,6196,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL:DP:DV 0,21,163:7:0 0,9,105:3:0 0,15,150:5:0 +17 134 . C 0 . DP=15;I16=13,2,0,0,607,24653,0,0,838,48482,0,0,283,6267,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL:DP:DV 0,21,177:7:0 0,9,105:3:0 0,15,152:5:0 +17 135 . T 0 . DP=15;I16=13,2,0,0,600,24178,0,0,838,48482,0,0,284,6352,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL:DP:DV 0,21,173:7:0 0,9,106:3:0 0,15,156:5:0 +17 136 . G 0 . DP=15;I16=13,2,0,0,574,22258,0,0,838,48482,0,0,286,6450,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL:DP:DV 0,21,172:7:0 0,9,105:3:0 0,15,134:5:0 +17 137 . T 0 . DP=15;I16=13,2,0,0,563,21377,0,0,838,48482,0,0,289,6561,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL:DP:DV 0,21,160:7:0 0,9,104:3:0 0,15,139:5:0 +17 138 . C 0 . DP=15;I16=13,2,0,0,584,23088,0,0,838,48482,0,0,291,6637,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL:DP:DV 0,21,172:7:0 0,9,108:3:0 0,15,142:5:0 +17 139 . C 0 . DP=15;I16=13,2,0,0,554,20790,0,0,838,48482,0,0,292,6680,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL:DP:DV 0,21,161:7:0 0,9,106:3:0 0,15,143:5:0 +17 140 . A 0 . DP=15;I16=13,2,0,0,583,22789,0,0,838,48482,0,0,292,6690,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL:DP:DV 0,21,163:7:0 0,9,107:3:0 0,15,153:5:0 +17 141 . G 0 . DP=14;I16=12,2,0,0,534,20750,0,0,778,44882,0,0,292,6664,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL:DP:DV 0,18,158:6:0 0,9,108:3:0 0,15,142:5:0 +17 142 . C 0 . DP=14;I16=12,2,0,0,503,18593,0,0,778,44882,0,0,292,6650,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL:DP:DV 0,18,157:6:0 0,9,97:3:0 0,15,129:5:0 +17 143 . G 0 . DP=14;I16=11,2,0,0,415,13657,0,0,718,41282,0,0,285,6599,0,0;QS=3,0;MQSB=0.590909;MQ0F=0 PL:DP:DV 0,18,128:6:0 0,9,95:3:0 0,12,97:4:0 +17 144 . A 0 . DP=14;I16=12,2,0,0,519,19725,0,0,778,44882,0,0,291,6609,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL:DP:DV 0,18,152:6:0 0,9,105:3:0 0,15,129:5:0 +17 145 . A 0 . DP=14;I16=12,2,0,0,527,20289,0,0,778,44882,0,0,290,6584,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL:DP:DV 0,18,153:6:0 0,9,106:3:0 0,15,138:5:0 +17 146 . T 0 . DP=14;I16=12,2,0,0,514,19484,0,0,778,44882,0,0,289,6573,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL:DP:DV 0,18,152:6:0 0,9,103:3:0 0,15,128:5:0 +17 147 . A 0 . DP=14;I16=12,2,0,0,515,19213,0,0,778,44882,0,0,288,6576,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL:DP:DV 0,18,150:6:0 0,9,99:3:0 0,15,140:5:0 +17 148 . C 0 . DP=14;I16=12,2,0,0,541,21019,0,0,778,44882,0,0,286,6542,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL:DP:DV 0,18,157:6:0 0,9,106:3:0 0,15,146:5:0 +17 149 . C 0 . DP=14;I16=12,2,0,0,512,19326,0,0,778,44882,0,0,283,6471,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL:DP:DV 0,18,148:6:0 0,9,109:3:0 0,15,140:5:0 +17 150 . T 0 . DP=13;I16=11,2,0,0,511,20251,0,0,749,44041,0,0,280,6362,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,18,153:6:0 0,6,84:2:0 0,15,152:5:0 +17 151 . G 0 . DP=13;I16=11,2,0,0,506,19826,0,0,749,44041,0,0,277,6263,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,18,157:6:0 0,6,84:2:0 0,15,144:5:0 +17 152 . C 0 . DP=14;I16=12,2,0,0,543,21283,0,0,809,47641,0,0,274,6174,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,21,168:7:0 0,6,84:2:0 0,15,146:5:0 +17 153 . A 0 . DP=14;I16=12,2,0,0,536,20594,0,0,809,47641,0,0,272,6096,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,21,156:7:0 0,6,81:2:0 0,15,153:5:0 +17 154 . T 0 . DP=14;I16=12,2,0,0,523,20051,0,0,809,47641,0,0,270,6030,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,21,159:7:0 0,6,83:2:0 0,15,139:5:0 +17 155 . C 0 . DP=14;I16=12,2,0,0,542,21254,0,0,809,47641,0,0,268,5976,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,21,172:7:0 0,6,85:2:0 0,15,139:5:0 +17 156 . C 0 . DP=14;I16=12,2,0,0,536,20884,0,0,809,47641,0,0,266,5934,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,21,163:7:0 0,6,84:2:0 0,15,150:5:0 +17 157 . C 0 . DP=14;I16=12,2,0,0,555,22081,0,0,809,47641,0,0,264,5904,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,21,169:7:0 0,6,85:2:0 0,15,149:5:0 +17 158 . T 0 . DP=14;I16=12,2,0,0,568,23154,0,0,809,47641,0,0,262,5886,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,21,170:7:0 0,6,84:2:0 0,15,159:5:0 +17 159 . A 0 . DP=15;I16=12,2,0,0,519,19467,0,0,809,47641,0,0,260,5880,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,21,157:7:0 0,6,83:2:0 0,15,135:5:0 +17 160 . G 0 . DP=15;I16=13,2,0,0,547,20633,0,0,869,51241,0,0,259,5887,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,21,165:7:0 0,6,85:2:0 0,18,139:6:0 +17 161 . A 0 . DP=15;I16=13,2,0,0,568,21610,0,0,869,51241,0,0,258,5908,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,21,157:7:0 0,6,83:2:0 0,18,162:6:0 +17 162 . A 0 . DP=15;I16=13,2,0,0,557,21139,0,0,869,51241,0,0,255,5843,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,21,147:7:0 0,6,87:2:0 0,18,167:6:0 +17 163 . G 0 . DP=14;I16=12,2,0,0,503,18645,0,0,809,47641,0,0,253,5791,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,21,153:7:0 0,6,79:2:0 0,15,138:5:0 +17 164 . T 0 . DP=14;I16=12,2,0,0,460,15968,0,0,809,47641,0,0,252,5750,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,18,131:6:0 0,6,79:2:0 0,18,136:6:0 +17 165 . G 0 . DP=14;I16=10,2,0,0,456,17460,0,0,689,40441,0,0,226,5094,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,18,149:6:0 0,6,80:2:0 0,12,122:4:0 +17 166 . A 0 . DP=14;I16=11,2,0,0,496,19138,0,0,749,44041,0,0,227,5077,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,18,145:6:0 0,6,82:2:0 0,15,148:5:0 +17 167 . A 0 . DP=14;I16=11,2,0,0,477,17851,0,0,749,44041,0,0,227,5071,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,18,132:6:0 0,6,86:2:0 0,15,147:5:0 +17 168 . G 0 . DP=14;I16=12,2,0,0,481,18015,0,0,809,47641,0,0,252,5702,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,18,145:6:0 0,6,82:2:0 0,18,140:6:0 +17 169 . C 0 . DP=13;I16=10,2,0,0,402,14224,0,0,689,40441,0,0,227,5045,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,15,106:5:0 0,6,76:2:0 0,15,145:5:0 +17 170 . C 0 . DP=13;I16=11,2,0,0,447,16383,0,0,749,44041,0,0,251,5601,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,15,128:5:0 0,6,80:2:0 0,18,143:6:0 +17 171 . A 0 . DP=13;I16=11,2,0,0,500,19366,0,0,749,44041,0,0,250,5546,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,15,134:5:0 0,6,81:2:0 0,18,166:6:0 +17 172 . C 0 . DP=13;I16=10,2,0,0,439,16395,0,0,689,40441,0,0,241,5441,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,15,138:5:0 0,6,75:2:0 0,15,129:5:0 +17 173 . C 0 . DP=13;I16=11,2,0,0,435,15225,0,0,749,44041,0,0,248,5478,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,15,121:5:0 0,6,76:2:0 0,18,146:6:0 +17 174 . G 0 . DP=13;I16=11,1,0,0,351,10685,0,0,689,40441,0,0,238,5364,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,15,111:5:0 0,3,27:1:0 0,18,117:6:0 +17 175 . C 0 . DP=14;I16=13,1,0,0,511,19161,0,0,809,47641,0,0,249,5463,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,143:6:0 0,3,41:1:0 0,21,175:7:0 +17 176 . C 0 . DP=14;I16=13,1,0,0,489,17733,0,0,809,47641,0,0,251,5477,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,146:6:0 0,3,44:1:0 0,21,152:7:0 +17 177 . C 0 . DP=14;I16=13,1,0,0,488,17328,0,0,809,47641,0,0,253,5507,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,138:6:0 0,3,44:1:0 0,21,158:7:0 +17 178 . A 0 . DP=14;I16=13,1,0,0,519,19485,0,0,809,47641,0,0,254,5502,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,147:6:0 0,3,42:1:0 0,21,172:7:0 +17 179 . A 0 . DP=14;I16=13,1,0,0,478,17278,0,0,809,47641,0,0,255,5511,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,134:6:0 0,3,44:1:0 0,21,170:7:0 +17 180 . A 0 . DP=14;I16=12,1,0,0,425,14653,0,0,749,44041,0,0,250,5498,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,126:6:0 0,3,43:1:0 0,18,148:6:0 +17 181 . G 0 . DP=14;I16=11,1,0,0,450,17152,0,0,689,40441,0,0,233,5233,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,156:6:0 0,3,41:1:0 0,15,138:5:0 +17 182 . A 0 . DP=15;I16=14,1,0,0,515,18235,0,0,869,51241,0,0,258,5622,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,150:7:0 0,3,43:1:0 0,21,159:7:0 +17 183 . C 0 . DP=15;I16=13,1,0,0,483,17419,0,0,809,47641,0,0,235,5063,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,159:7:0 0,3,40:1:0 0,18,139:6:0 +17 184 . A 0 . DP=15;I16=14,1,0,0,535,19667,0,0,869,51241,0,0,262,5770,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,158:7:0 0,3,41:1:0 0,21,163:7:0 +17 185 . C 0 . DP=15;I16=13,1,0,0,487,17295,0,0,809,47641,0,0,238,5192,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,150:7:0 0,3,38:1:0 0,18,160:6:0 +17 186 . G 0 . DP=15;I16=12,1,0,0,381,11429,0,0,749,44041,0,0,239,5253,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,117:6:0 0,3,32:1:0 0,18,124:6:0 +17 187 . C 0 . DP=14;I16=13,1,0,0,511,18979,0,0,809,47641,0,0,266,5952,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,147:6:0 0,3,38:1:0 0,21,172:7:0 +17 188 . C 0 . DP=14;I16=13,1,0,0,496,18042,0,0,809,47641,0,0,267,5989,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,147:6:0 0,3,37:1:0 0,21,162:7:0 +17 189 . C 0 . DP=15;I16=13,2,0,0,552,20504,0,0,838,48482,0,0,268,6040,0,0;QS=3,0;MQSB=0;MQ0F=0 PL:DP:DV 0,18,152:6:0 0,6,67:2:0 0,21,167:7:0 +17 190 . A 0 . DP=15;I16=12,2,0,0,500,18230,0,0,778,44882,0,0,243,5381,0,0;QS=3,0;MQSB=0;MQ0F=0 PL:DP:DV 0,18,138:6:0 0,6,68:2:0 0,18,159:6:0 +17 191 . T 0 . DP=15;I16=13,2,0,0,534,19276,0,0,838,48482,0,0,267,5939,0,0;QS=3,0;MQSB=0;MQ0F=0 PL:DP:DV 0,18,143:6:0 0,6,67:2:0 0,21,169:7:0 +17 192 . G 0 . DP=15;I16=13,2,0,0,499,17439,0,0,838,48482,0,0,266,5890,0,0;QS=3,0;MQSB=0;MQ0F=0 PL:DP:DV 0,18,143:6:0 0,6,67:2:0 0,21,151:7:0 +17 193 . T 0 . DP=15;I16=13,2,0,0,505,17811,0,0,838,48482,0,0,265,5859,0,0;QS=3,0;MQSB=0;MQ0F=0 PL:DP:DV 0,18,140:6:0 0,6,63:2:0 0,21,157:7:0 +17 194 . C 0 . DP=14;I16=12,2,0,0,467,16569,0,0,778,44882,0,0,265,5845,0,0;QS=3,0;MQSB=0;MQ0F=0 PL:DP:DV 0,18,142:6:0 0,6,67:2:0 0,18,145:6:0 +17 195 . C 0 . DP=14;I16=11,3,0,0,503,18647,0,0,747,42123,0,0,266,5846,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:DV 0,18,159:6:0 0,6,71:2:0 0,18,160:6:0 +17 196 . A 0 . DP=14;I16=11,3,0,0,482,17400,0,0,747,42123,0,0,268,5862,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:DV 0,18,166:6:0 0,6,69:2:0 0,18,138:6:0 +17 197 . G 0 . DP=14;I16=11,3,0,0,481,17391,0,0,747,42123,0,0,270,5894,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:DV 0,18,164:6:0 0,6,68:2:0 0,18,134:6:0 +17 198 . C 0 . DP=14;I16=11,3,0,0,539,20957,0,0,747,42123,0,0,271,5893,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:DV 0,18,172:6:0 0,6,70:2:0 0,18,164:6:0 +17 199 . T 0 . DP=14;I16=11,3,0,0,505,19197,0,0,747,42123,0,0,271,5861,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:DV 0,18,162:6:0 0,6,73:2:0 0,18,154:6:0 +17 200 . T 0 . DP=15;I16=11,4,0,0,544,19918,0,0,776,42964,0,0,270,5798,0,0;QS=3,0;MQSB=0.0161635;MQ0F=0 PL:DP:DV 0,18,161:6:0 0,9,89:3:0 0,18,154:6:0 +17 201 . A 0 . DP=16;I16=12,4,0,0,568,20416,0,0,836,46564,0,0,269,5703,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,171:7:0 0,9,89:3:0 0,18,157:6:0 +17 202 . A 0 . DP=16;I16=12,4,0,0,566,20590,0,0,836,46564,0,0,269,5627,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,178:7:0 0,9,84:3:0 0,18,163:6:0 +17 203 . C 0 . DP=16;I16=12,4,0,0,557,20119,0,0,836,46564,0,0,269,5571,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,166:7:0 0,9,90:3:0 0,18,153:6:0 +17 204 . C 0 . DP=16;I16=12,4,0,0,591,22379,0,0,836,46564,0,0,269,5535,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,173:7:0 0,9,91:3:0 0,18,163:6:0 +17 205 . T 0 . DP=16;I16=12,4,0,0,635,25281,0,0,836,46564,0,0,269,5519,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,188:7:0 0,9,95:3:0 0,18,173:6:0 +17 206 . G 0 . DP=16;I16=12,4,0,0,577,21337,0,0,836,46564,0,0,269,5523,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,180:7:0 0,9,89:3:0 0,18,143:6:0 +17 207 . C 0 . DP=16;I16=12,4,0,0,574,21076,0,0,836,46564,0,0,269,5547,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,179:7:0 0,9,93:3:0 0,18,151:6:0 +17 208 . A 0 . DP=16;I16=12,4,0,0,576,21486,0,0,836,46564,0,0,268,5540,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,184:7:0 0,9,93:3:0 0,18,154:6:0 +17 209 . T 0 . DP=16;I16=12,4,0,0,567,20475,0,0,836,46564,0,0,267,5551,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,173:7:0 0,9,91:3:0 0,18,146:6:0 +17 210 . C 0 . DP=16;I16=12,4,0,0,577,21109,0,0,836,46564,0,0,266,5580,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,185:7:0 0,9,92:3:0 0,18,151:6:0 +17 211 . C 0 . DP=16;I16=12,4,0,0,563,20227,0,0,836,46564,0,0,265,5627,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,172:7:0 0,9,92:3:0 0,18,153:6:0 +17 212 . C 0 . DP=16;I16=12,4,0,0,589,22179,0,0,836,46564,0,0,263,5643,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,181:7:0 0,9,92:3:0 0,18,152:6:0 +17 213 . T 0 . DP=16;I16=12,4,0,0,598,22838,0,0,836,46564,0,0,262,5678,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,181:7:0 0,9,95:3:0 0,18,165:6:0 +17 214 . A 0 . DP=16;I16=11,4,0,0,529,19401,0,0,776,42964,0,0,240,5248,0,0;QS=3,0;MQSB=0.0161635;MQ0F=0 PL:DP:DV 0,21,176:7:0 0,9,92:3:0 0,15,118:5:0 +17 215 . G 0 . DP=15;I16=12,3,0,0,521,19073,0,0,807,45723,0,0,262,5754,0,0;QS=3,0;MQSB=0.0342181;MQ0F=0 PL:DP:DV 0,21,185:7:0 0,9,90:3:0 0,15,105:5:0 +17 216 . A 0 . DP=14;I16=10,3,0,0,464,16900,0,0,687,38523,0,0,238,5166,0,0;QS=3,0;MQSB=0.040184;MQ0F=0 PL:DP:DV 0,21,173:7:0 0,9,92:3:0 0,9,81:3:0 +17 217 . A 0 . DP=14;I16=11,3,0,0,515,19433,0,0,747,42123,0,0,264,5842,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:DV 0,21,181:7:0 0,9,90:3:0 0,12,97:4:0 +17 218 . G 0 . DP=14;I16=11,3,0,0,507,18957,0,0,747,42123,0,0,265,5907,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:DV 0,21,178:7:0 0,9,90:3:0 0,12,110:4:0 +17 219 . T 0 . DP=14;I16=11,3,0,0,470,16286,0,0,747,42123,0,0,266,5986,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:DV 0,21,173:7:0 0,9,88:3:0 0,12,89:4:0 +17 220 . G 0 . DP=14;I16=10,3,0,0,485,18307,0,0,687,38523,0,0,242,5454,0,0;QS=3,0;MQSB=0.040184;MQ0F=0 PL:DP:DV 0,21,188:7:0 0,9,88:3:0 0,9,80:3:0 +17 221 . A 0 . DP=14;I16=11,3,0,0,487,17615,0,0,747,42123,0,0,267,6135,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:DV 0,21,176:7:0 0,9,88:3:0 0,12,101:4:0 +17 222 . A 0 . DP=14;I16=10,3,0,0,465,17367,0,0,687,38523,0,0,242,5578,0,0;QS=3,0;MQSB=0.040184;MQ0F=0 PL:DP:DV 0,21,186:7:0 0,9,85:3:0 0,9,69:3:0 +17 223 . G 0 . DP=13;I16=9,3,0,0,405,14327,0,0,627,34923,0,0,243,5657,0,0;QS=3,0;MQSB=0.0443614;MQ0F=0 PL:DP:DV 0,18,168:6:0 0,6,53:2:0 0,12,81:4:0 +17 224 . G 0 . DP=12;I16=9,3,0,0,379,12759,0,0,627,34923,0,0,270,6370,0,0;QS=3,0;MQSB=0.0443614;MQ0F=0 PL:DP:DV 0,18,168:6:0 0,6,50:2:0 0,12,70:4:0 +17 225 . C 0 . DP=12;I16=8,3,0,0,382,13896,0,0,567,31323,0,0,261,6345,0,0;QS=3,0;MQSB=0.0497871;MQ0F=0 PL:DP:DV 0,18,165:6:0 0,6,48:2:0 0,9,83:3:0 +17 226 . A 0 . DP=13;I16=8,3,0,0,381,13669,0,0,567,31323,0,0,248,5894,0,0;QS=3,0;MQSB=0.0497871;MQ0F=0 PL:DP:DV 0,18,166:6:0 0,6,53:2:0 0,9,84:3:0 +17 227 . C 0 . DP=13;I16=8,4,0,0,406,14306,0,0,596,32164,0,0,267,6253,0,0;QS=3,0;MQSB=0.0249144;MQ0F=0 PL:DP:DV 0,21,190:7:0 0,6,53:2:0 0,9,73:3:0 +17 228 . C 0 . DP=13;I16=9,4,0,0,417,14381,0,0,656,35764,0,0,292,6884,0,0;QS=3,0;MQSB=0.0211283;MQ0F=0 PL:DP:DV 0,21,187:7:0 0,6,45:2:0 0,12,96:4:0 +17 229 . G 0 . DP=13;I16=9,3,0,0,358,11424,0,0,627,34923,0,0,270,6414,0,0;QS=3,0;MQSB=0.0443614;MQ0F=0 PL:DP:DV 0,18,136:6:0 0,6,53:2:0 0,12,70:4:0 +17 230 . C 0 . DP=13;I16=9,4,0,0,461,16861,0,0,656,35764,0,0,292,6920,0,0;QS=3,0;MQSB=0.0211283;MQ0F=0 PL:DP:DV 0,21,186:7:0 0,6,53:2:0 0,12,100:4:0 +17 231 . C 0 . DP=13;I16=7,4,0,0,414,15832,0,0,536,28564,0,0,247,5925,0,0;QS=3,0;MQSB=0.0401934;MQ0F=0 PL:DP:DV 0,18,184:6:0 0,6,53:2:0 0,9,82:3:0 +17 232 . C 0 . DP=14;I16=9,4,0,0,471,17371,0,0,656,35764,0,0,267,6363,0,0;QS=3,0;MQSB=0.0211283;MQ0F=0 PL:DP:DV 0,21,198:7:0 0,6,53:2:0 0,12,101:4:0 +17 233 . A 0 . DP=14;I16=10,4,0,0,496,18142,0,0,716,39364,0,0,292,6984,0,0;QS=3,0;MQSB=0.0183156;MQ0F=0 PL:DP:DV 0,21,192:7:0 0,6,53:2:0 0,15,119:5:0 +17 234 . A 0 . DP=14;I16=10,4,0,0,502,18390,0,0,716,39364,0,0,292,6988,0,0;QS=3,0;MQSB=0.0183156;MQ0F=0 PL:DP:DV 0,21,185:7:0 0,6,53:2:0 0,15,123:5:0 +17 235 . A 0 . DP=14;I16=9,4,0,0,476,17652,0,0,656,35764,0,0,267,6375,0,0;QS=3,0;MQSB=0.0211283;MQ0F=0 PL:DP:DV 0,21,186:7:0 0,6,53:2:0 0,12,111:4:0 +17 236 . G 0 . DP=15;I16=11,4,0,0,501,17481,0,0,776,42964,0,0,290,6924,0,0;QS=3,0;MQSB=0.0161635;MQ0F=0 PL:DP:DV 0,24,206:8:0 0,6,53:2:0 0,15,103:5:0 +17 237 . A 0 . DP=14;I16=9,4,0,0,465,16877,0,0,656,35764,0,0,266,6282,0,0;QS=3,0;MQSB=0.0211283;MQ0F=0 PL:DP:DV 0,24,206:8:0 0,6,53:2:0 0,9,92:3:0 +17 238 . C 0 . DP=14;I16=10,4,0,0,482,17238,0,0,716,39364,0,0,292,6900,0,0;QS=3,0;MQSB=0.0183156;MQ0F=0 PL:DP:DV 0,24,211:8:0 0,6,53:2:0 0,12,82:4:0 +17 239 . A 0 . DP=15;I16=10,5,0,0,525,19155,0,0,776,42964,0,0,292,6852,0,0;QS=3,0;MQSB=0.0497871;MQ0F=0 PL:DP:DV 0,27,223:9:0 0,6,50:2:0 0,12,108:4:0 +17 240 . C 0 . DP=15;I16=10,5,0,0,512,17930,0,0,776,42964,0,0,292,6764,0,0;QS=3,0;MQSB=0.0497871;MQ0F=0 PL:DP:DV 0,27,220:9:0 0,6,53:2:0 0,12,106:4:0 +17 241 . G 0 . DP=15;I16=9,5,0,0,444,14636,0,0,716,39364,0,0,269,6159,0,0;QS=3,0;MQSB=0.0561348;MQ0F=0 PL:DP:DV 0,27,203:9:0 0,6,53:2:0 0,9,59:3:0 +17 242 . C 0 . DP=15;I16=10,5,0,0,555,21177,0,0,776,42964,0,0,292,6624,0,0;QS=3,0;MQSB=0.0497871;MQ0F=0 PL:DP:DV 0,27,242:9:0 0,6,53:2:0 0,12,94:4:0 +17 243 . C 0 . DP=16;I16=9,5,0,0,523,19737,0,0,716,39364,0,0,284,6508,0,0;QS=3,0;MQSB=0.0561348;MQ0F=0 PL:DP:DV 0,24,220:8:0 0,6,53:2:0 0,12,104:4:0 +17 244 . C 0 . DP=16;I16=10,6,0,0,620,24272,0,0,805,43805,0,0,298,6568,0,0;QS=3,0;MQSB=0.0253122;MQ0F=0 PL:DP:DV 0,27,245:9:0 0,9,72:3:0 0,12,106:4:0 +17 245 . A 0 . DP=17;I16=10,7,0,0,649,24843,0,0,865,47405,0,0,299,6553,0,0;QS=3,0;MQSB=0.0509867;MQ0F=0 PL:DP:DV 0,27,236:9:0 0,12,93:4:0 0,12,115:4:0 +17 246 . T 0 . DP=18;I16=10,8,0,0,649,23833,0,0,894,48246,0,0,301,6553,0,0;QS=3,0;MQSB=0.0286491;MQ0F=0 PL:DP:DV 0,30,247:10:0 0,12,94:4:0 0,12,98:4:0 +17 247 . G 0 . DP=18;I16=10,8,0,0,642,23610,0,0,894,48246,0,0,304,6570,0,0;QS=3,0;MQSB=0.0286491;MQ0F=0 PL:DP:DV 0,30,252:10:0 0,12,83:4:0 0,12,103:4:0 +17 248 . T 0 . DP=18;I16=10,8,0,0,636,22944,0,0,894,48246,0,0,307,6605,0,0;QS=3,0;MQSB=0.0286491;MQ0F=0 PL:DP:DV 0,30,234:10:0 0,12,86:4:0 0,12,114:4:0 +17 249 . C 0 . DP=18;I16=10,8,0,0,656,24846,0,0,894,48246,0,0,310,6658,0,0;QS=3,0;MQSB=0.0286491;MQ0F=0 PL:DP:DV 0,30,253:10:0 0,12,79:4:0 0,12,112:4:0 +17 250 . C 0 . DP=19;I16=10,9,0,0,694,26160,0,0,923,49087,0,0,311,6631,0,0;QS=3,0;MQSB=0.0168512;MQ0F=0 PL:DP:DV 0,30,248:10:0 0,12,89:4:0 0,15,142:5:0 +17 251 . A 0 . DP=19;I16=9,9,0,0,688,26506,0,0,863,45487,0,0,313,6627,0,0;QS=3,0;MQSB=0.0208913;MQ0F=0 PL:DP:DV 0,27,233:9:0 0,12,97:4:0 0,15,148:5:0 +17 252 . G 0 . DP=18;I16=8,9,0,0,641,24631,0,0,803,41887,0,0,304,6502,0,0;QS=3,0;MQSB=0.026526;MQ0F=0 PL:DP:DV 0,27,243:9:0 0,12,91:4:0 0,12,121:4:0 +17 253 . C 0 . DP=19;I16=9,10,0,0,705,26921,0,0,892,46328,0,0,319,6687,0,0;QS=3,0;MQSB=0.0132999;MQ0F=0 PL:DP:DV 0,27,247:9:0 0,12,86:4:0 0,18,155:6:0 +17 254 . T 0 . DP=20;I16=10,9,0,0,719,27517,0,0,892,46328,0,0,314,6670,0,0;QS=3,0;MQSB=0.00482795;MQ0F=0 PL:DP:DV 0,30,254:10:0 0,9,72:3:0 0,18,164:6:0 +17 255 . T 0 . DP=21;I16=11,10,0,0,750,27076,0,0,1012,53528,0,0,328,6840,0,0;QS=3,0;MQSB=0.00822975;MQ0F=0 PL:DP:DV 0,33,241:11:0 0,12,95:4:0 0,18,161:6:0 +17 256 . A 0 . DP=22;I16=11,11,0,0,811,30063,0,0,1049,54897,0,0,334,6956,0,0;QS=3,0;MQSB=0.00507916;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,110:5:0 0,18,166:6:0 +17 257 . T 0 . DP=22;I16=11,11,0,0,814,30420,0,0,1049,54897,0,0,341,7101,0,0;QS=3,0;MQSB=0.00507916;MQ0F=0 PL:DP:DV 0,33,247:11:0 0,15,113:5:0 0,18,168:6:0 +17 258 . T 0 . DP=22;I16=11,11,0,0,791,28943,0,0,1049,54897,0,0,347,7225,0,0;QS=3,0;MQSB=0.00507916;MQ0F=0 PL:DP:DV 0,33,254:11:0 0,15,116:5:0 0,18,155:6:0 +17 259 . C 0 . DP=22;I16=11,10,0,0,785,29809,0,0,1020,54056,0,0,332,6936,0,0;QS=3,0;MQSB=0.00822975;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,90:4:0 0,18,170:6:0 +17 260 . T 0 . DP=21;I16=10,11,0,0,829,32899,0,0,989,51297,0,0,360,7556,0,0;QS=3,0;MQSB=0.00660016;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,118:5:0 0,15,156:5:0 +17 261 . G 0 . DP=21;I16=10,11,0,0,735,27379,0,0,989,51297,0,0,367,7761,0,0;QS=3,0;MQSB=0.00660016;MQ0F=0 PL:DP:DV 0,33,254:11:0 0,15,111:5:0 0,15,122:5:0 +17 262 . C 0 . DP=22;I16=10,12,0,0,806,30278,0,0,1049,54897,0,0,373,7941,0,0;QS=3,0;MQSB=0.0122507;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,99:5:0 0,18,164:6:0 +17 263 . C 0 . DP=22;I16=10,12,0,0,799,29717,0,0,1049,54897,0,0,380,8146,0,0;QS=3,0;MQSB=0.0122507;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,98:5:0 0,18,168:6:0 +17 264 . C 0 . DP=22;I16=10,12,0,0,821,31325,0,0,1049,54897,0,0,386,8326,0,0;QS=3,0;MQSB=0.0122507;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,104:5:0 0,18,172:6:0 +17 265 . A 0 . DP=21;I16=9,12,0,0,800,31906,0,0,989,51297,0,0,390,8380,0,0;QS=3,0;MQSB=0.0158903;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,114:5:0 0,15,129:5:0 +17 266 . G 0 . DP=21;I16=9,11,0,0,747,28155,0,0,960,50456,0,0,369,7833,0,0;QS=3,0;MQSB=0.0237479;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,97:4:0 0,15,138:5:0 +17 267 . T 0 . DP=21;I16=9,11,0,0,739,27465,0,0,960,50456,0,0,373,7935,0,0;QS=3,0;MQSB=0.0237479;MQ0F=0 PL:DP:DV 0,33,254:11:0 0,12,101:4:0 0,15,149:5:0 +17 268 . T 0 . DP=21;I16=9,12,0,0,748,27708,0,0,989,51297,0,0,402,8686,0,0;QS=3,0;MQSB=0.0158903;MQ0F=0 PL:DP:DV 0,33,238:11:0 0,15,110:5:0 0,15,156:5:0 +17 269 . C 0 . DP=22;I16=9,12,0,0,764,28632,0,0,989,51297,0,0,381,8211,0,0;QS=3,0;MQSB=0.0158903;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,91:4:0 0,15,154:5:0 +17 270 . C 0 . DP=22;I16=9,12,0,0,758,28146,0,0,989,51297,0,0,385,8337,0,0;QS=3,0;MQSB=0.0158903;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,96:4:0 0,15,143:5:0 +17 271 . T 0 . DP=22;I16=9,13,0,0,847,32935,0,0,1018,52138,0,0,413,9065,0,0;QS=3,0;MQSB=0.0109431;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,113:5:0 0,15,152:5:0 +17 272 . C 0 . DP=22;I16=9,12,0,0,809,31413,0,0,989,51297,0,0,390,8518,0,0;QS=3,0;MQSB=0.0158903;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,96:4:0 0,15,149:5:0 +17 273 . T 0 . DP=22;I16=9,12,0,0,798,30664,0,0,989,51297,0,0,392,8620,0,0;QS=3,0;MQSB=0.0158903;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,95:4:0 0,15,161:5:0 +17 274 . C 0 . DP=22;I16=9,12,0,0,763,28177,0,0,989,51297,0,0,394,8746,0,0;QS=3,0;MQSB=0.0158903;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,101:4:0 0,15,144:5:0 +17 275 . C 0 . DP=20;I16=7,13,0,0,768,29994,0,0,898,44938,0,0,423,9519,0,0;QS=3,0;MQSB=0.0213617;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,114:5:0 0,12,122:4:0 +17 276 . A 0 . DP=20;I16=7,13,0,0,805,32931,0,0,898,44938,0,0,424,9538,0,0;QS=3,0;MQSB=0.0213617;MQ0F=0 PL:DP:DV 0,33,253:11:0 0,15,122:5:0 0,12,124:4:0 +17 277 . G 0 . DP=20;I16=7,13,0,0,764,29732,0,0,898,44938,0,0,425,9579,0,0;QS=3,0;MQSB=0.0213617;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,114:5:0 0,12,121:4:0 +17 278 . A 0 . DP=21;I16=6,14,0,0,722,26452,0,0,867,42179,0,0,415,9521,0,0;QS=3,0;MQSB=0.0246228;MQ0F=0 PL:DP:DV 0,30,238:10:0 0,18,123:6:0 0,12,121:4:0 +17 279 . A 0 . DP=22;I16=7,15,0,0,786,28694,0,0,956,46620,0,0,427,9677,0,0;QS=3,0;MQSB=0.0124927;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,123:6:0 0,12,122:4:0 +17 280 . A 0 . DP=22;I16=7,15,0,0,815,31561,0,0,956,46620,0,0,428,9684,0,0;QS=3,0;MQSB=0.0124927;MQ0F=0 PL:DP:DV 0,36,253:12:0 0,18,130:6:0 0,12,129:4:0 +17 281 . G 0 . DP=22;I16=7,15,0,0,820,31416,0,0,956,46620,0,0,428,9662,0,0;QS=3,0;MQSB=0.0124927;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,122:6:0 0,12,123:4:0 +17 282 . G 0 . DP=22;I16=7,15,0,0,806,30420,0,0,956,46620,0,0,427,9609,0,0;QS=3,0;MQSB=0.0124927;MQ0F=0 PL:DP:DV 0,36,253:12:0 0,18,124:6:0 0,12,119:4:0 +17 283 . C 0 . DP=23;I16=7,15,0,0,827,31785,0,0,956,46620,0,0,426,9574,0,0;QS=3,0;MQSB=0.0124927;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,125:6:0 0,12,122:4:0 +17 284 . T 0 . DP=23;I16=7,16,0,0,901,35479,0,0,1016,50220,0,0,431,9593,0,0;QS=3,0;MQSB=0.0194969;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,126:6:0 0,15,144:5:0 +17 285 . G 0 . DP=23;I16=7,16,0,0,860,32856,0,0,1016,50220,0,0,431,9607,0,0;QS=3,0;MQSB=0.0194969;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,119:6:0 0,15,132:5:0 +17 286 . C 0 . DP=24;I16=8,16,0,0,875,32883,0,0,1076,53820,0,0,431,9641,0,0;QS=3,0;MQSB=0.0132999;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,150:7:0 0,15,134:5:0 +17 287 . A 0 . DP=25;I16=9,16,0,0,895,32957,0,0,1136,57420,0,0,432,9696,0,0;QS=3,0;MQSB=0.00934348;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,178:8:0 0,15,133:5:0 +17 288 . T 0 . DP=25;I16=9,16,0,0,931,35011,0,0,1136,57420,0,0,432,9674,0,0;QS=3,0;MQSB=0.00934348;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,184:8:0 0,15,146:5:0 +17 289 . G 0 . DP=25;I16=9,16,0,0,939,36117,0,0,1136,57420,0,0,432,9676,0,0;QS=3,0;MQSB=0.00934348;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,185:8:0 0,15,136:5:0 +17 290 . G 0 . DP=23;I16=8,15,0,0,805,29157,0,0,1047,52979,0,0,433,9651,0,0;QS=3,0;MQSB=0.0177152;MQ0F=0 PL:DP:DV 0,33,240:11:0 0,21,164:7:0 0,15,126:5:0 +17 291 . T 0 . DP=24;I16=8,15,0,0,840,31616,0,0,1047,52979,0,0,421,9479,0,0;QS=3,0;MQSB=0.0177152;MQ0F=0 PL:DP:DV 0,33,244:11:0 0,21,168:7:0 0,15,136:5:0 +17 292 . T 0 . DP=25;I16=9,16,0,0,888,32274,0,0,1167,60179,0,0,436,9668,0,0;QS=3,0;MQSB=0.0197089;MQ0F=0 PL:DP:DV 0,33,253:11:0 0,24,181:8:0 0,18,156:6:0 +17 293 . G 0 . DP=26;I16=10,15,0,0,934,35232,0,0,1167,60179,0,0,424,9488,0,0;QS=3,0;MQSB=0.0095249;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,196:8:0 0,15,145:5:0 +17 294 . A 0 . DP=26;I16=10,16,0,0,931,33937,0,0,1227,63779,0,0,443,9785,0,0;QS=3,0;MQSB=0.0149748;MQ0F=0 PL:DP:DV 0,36,252:12:0 0,24,201:8:0 0,18,161:6:0 +17 295 . C 0 . DP=25;I16=10,14,0,0,897,33973,0,0,1169,62097,0,0,430,9544,0,0;QS=3,0;MQSB=0.0310726;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,180:7:0 0,18,159:6:0 +17 296 . A 0 . DP=25;I16=10,15,0,0,874,31846,0,0,1198,62938,0,0,451,9905,0,0;QS=3,0;MQSB=0.0213617;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,169:8:0 0,18,169:6:0 +17 297 . C 0 . DP=25;I16=9,15,0,0,901,34305,0,0,1138,59338,0,0,445,9901,0,0;QS=3,0;MQSB=0.0273237;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,174:7:0 0,18,161:6:0 +17 298 . A 0 . DP=26;I16=11,15,0,0,936,34652,0,0,1258,66538,0,0,459,10121,0,0;QS=3,0;MQSB=0.017008;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,184:8:0 0,21,191:7:0 +17 299 . C 0 . DP=27;I16=11,15,0,0,971,36863,0,0,1258,66538,0,0,464,10266,0,0;QS=3,0;MQSB=0.017008;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,193:8:0 0,21,189:7:0 +17 300 . A 0 . DP=27;I16=11,15,0,0,1001,39455,0,0,1258,66538,0,0,469,10437,0,0;QS=3,0;MQSB=0.017008;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,204:8:0 0,21,210:7:0 +17 301 . G 0 . DP=25;I16=10,14,0,0,928,36116,0,0,1169,62097,0,0,476,10632,0,0;QS=3,0;MQSB=0.0310726;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,195:7:0 0,21,196:7:0 +17 302 . T 0 . DP=25;I16=10,14,0,0,879,32885,0,0,1169,62097,0,0,483,10849,0,0;QS=3,0;MQSB=0.0310726;MQ0F=0 PL:DP:DV 0,30,231:10:0 0,21,172:7:0 0,21,202:7:0 +17 302 . T TA 0 . INDEL;IDV=7;IMF=1;DP=25;I16=2,4,8,11,214,7674,793,33369,236,10564,993,55133,109,2229,377,8629;QS=0.511212,2.48879;VDB=0.27613;SGB=-4.22417;MQSB=0.0443614;MQ0F=0 PL:DP:DV 167,0,96:11:6 157,0,9:7:6 201,21,0:7:7 +17 303 . G 0 . DP=25;I16=10,15,0,0,976,38516,0,0,1229,65697,0,0,497,11181,0,0;QS=3,0;MQSB=0.0443614;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,197:7:0 0,21,195:7:0 +17 304 . C 0 . DP=27;I16=11,16,0,0,991,37005,0,0,1318,70138,0,0,503,11359,0,0;QS=3,0;MQSB=0.129164;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,206:8:0 0,24,200:8:0 +17 305 . C 0 . DP=27;I16=11,16,0,0,1057,41761,0,0,1318,70138,0,0,510,11508,0,0;QS=3,0;MQSB=0.129164;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,213:8:0 0,24,211:8:0 +17 306 . T 0 . DP=27;I16=11,16,0,0,1033,40253,0,0,1318,70138,0,0,517,11679,0,0;QS=3,0;MQSB=0.129164;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,207:8:0 0,24,217:8:0 +17 307 . G 0 . DP=27;I16=11,15,0,0,984,37886,0,0,1289,69297,0,0,498,11198,0,0;QS=3,0;MQSB=0.174566;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,189:7:0 0,24,203:8:0 +17 308 . C 0 . DP=27;I16=11,16,0,0,892,30810,0,0,1318,70138,0,0,529,11991,0,0;QS=3,0;MQSB=0.129164;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,178:8:0 0,24,185:8:0 +17 309 . G 0 . DP=27;I16=11,16,0,0,951,34599,0,0,1318,70138,0,0,535,12183,0,0;QS=3,0;MQSB=0.129164;MQ0F=0 PL:DP:DV 0,33,243:11:0 0,24,183:8:0 0,24,205:8:0 +17 310 . A 0 . DP=27;I16=11,16,0,0,1001,38063,0,0,1318,70138,0,0,540,12350,0,0;QS=3,0;MQSB=0.129164;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,200:8:0 0,24,217:8:0 +17 311 . C 0 . DP=27;I16=11,16,0,0,1037,40263,0,0,1318,70138,0,0,544,12492,0,0;QS=3,0;MQSB=0.129164;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,215:8:0 0,24,210:8:0 +17 312 . A 0 . DP=26;I16=10,16,0,0,985,38043,0,0,1258,66538,0,0,549,12657,0,0;QS=3,0;MQSB=0.157183;MQ0F=0 PL:DP:DV 0,30,237:10:0 0,24,215:8:0 0,24,218:8:0 +17 313 . A 0 . DP=26;I16=10,16,0,0,983,37969,0,0,1258,66538,0,0,551,12695,0,0;QS=3,0;MQSB=0.157183;MQ0F=0 PL:DP:DV 0,30,235:10:0 0,24,219:8:0 0,24,215:8:0 +17 314 . A 0 . DP=27;I16=10,17,0,0,1050,41798,0,0,1318,70138,0,0,553,12757,0,0;QS=3,0;MQSB=0.195223;MQ0F=0 PL:DP:DV 0,33,250:11:0 0,24,217:8:0 0,24,227:8:0 +17 315 . G 0 . DP=26;I16=10,16,0,0,1025,40941,0,0,1289,69297,0,0,557,12843,0,0;QS=3,0;MQSB=0.252051;MQ0F=0 PL:DP:DV 0,30,252:10:0 0,24,216:8:0 0,24,225:8:0 +17 316 . C 0 . DP=27;I16=10,15,0,0,983,39393,0,0,1252,67928,0,0,535,12277,0,0;QS=3,0;MQSB=0.312403;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,183:7:0 0,24,224:8:0 +17 317 . T 0 . DP=27;I16=10,16,0,0,1028,41392,0,0,1320,72056,0,0,547,12557,0,0;QS=3,0;MQSB=0.377061;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,24,230:8:0 0,24,206:8:0 +17 318 . G 0 . DP=27;I16=10,17,0,0,1038,40546,0,0,1349,72897,0,0,570,13018,0,0;QS=3,0;MQSB=0.297797;MQ0F=0 PL:DP:DV 0,30,249:10:0 0,27,235:9:0 0,24,208:8:0 +17 319 . A 0 . DP=27;I16=9,17,0,0,994,38654,0,0,1289,69297,0,0,560,12906,0,0;QS=3,0;MQSB=0.346864;MQ0F=0 PL:DP:DV 0,30,249:10:0 0,27,228:9:0 0,21,185:7:0 +17 320 . A 0 . DP=27;I16=10,17,0,0,1022,39418,0,0,1349,72897,0,0,573,13053,0,0;QS=3,0;MQSB=0.297797;MQ0F=0 PL:DP:DV 0,30,247:10:0 0,27,230:9:0 0,24,211:8:0 +17 321 . T 0 . DP=27;I16=10,17,0,0,1026,39772,0,0,1349,72897,0,0,573,13029,0,0;QS=3,0;MQSB=0.297797;MQ0F=0 PL:DP:DV 0,30,253:10:0 0,27,214:9:0 0,24,218:8:0 +17 322 . G 0 . DP=28;I16=10,18,0,0,1091,43151,0,0,1409,76497,0,0,573,13029,0,0;QS=3,0;MQSB=0.343265;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,27,226:9:0 0,27,223:9:0 +17 323 . C 0 . DP=28;I16=9,18,0,0,1067,42619,0,0,1349,72897,0,0,565,12939,0,0;QS=3,0;MQSB=0.394987;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,27,225:9:0 0,24,198:8:0 +17 324 . T 0 . DP=30;I16=12,18,0,0,1145,44221,0,0,1529,83697,0,0,573,13001,0,0;QS=3,0;MQSB=0.264959;MQ0F=0 PL:DP:DV 0,30,253:10:0 0,27,237:9:0 0,33,255:11:0 +17 325 . A 0 . DP=31;I16=13,18,0,0,1132,42058,0,0,1589,87297,0,0,573,12925,0,0;QS=3,0;MQSB=0.235201;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,208:9:0 0,33,255:11:0 +17 326 . T 0 . DP=31;I16=13,18,0,0,1157,44193,0,0,1589,87297,0,0,574,12878,0,0;QS=3,0;MQSB=0.235201;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,216:9:0 0,33,255:11:0 +17 327 . C 0 . DP=31;I16=13,18,0,0,1147,43895,0,0,1589,87297,0,0,575,12861,0,0;QS=3,0;MQSB=0.235201;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,198:9:0 0,33,255:11:0 +17 328 . A 0 . DP=31;I16=13,18,0,0,1167,44531,0,0,1589,87297,0,0,574,12776,0,0;QS=3,0;MQSB=0.235201;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,226:9:0 0,33,255:11:0 +17 329 . T 0 . DP=31;I16=13,18,0,0,1210,47742,0,0,1589,87297,0,0,572,12676,0,0;QS=3,0;MQSB=0.235201;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,237:9:0 0,33,255:11:0 +17 330 . T 0 . DP=31;I16=13,18,0,0,1185,45839,0,0,1589,87297,0,0,568,12510,0,0;QS=3,0;MQSB=0.235201;MQ0F=0 PL:DP:DV 0,33,254:11:0 0,27,231:9:0 0,33,255:11:0 +17 331 . T 0 . DP=32;I16=14,18,0,0,1154,42510,0,0,1649,90897,0,0,563,12327,0,0;QS=3,0;MQSB=0.210122;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,222:9:0 0,36,255:12:0 +17 332 . A 0 . DP=32;I16=14,18,0,0,1156,42666,0,0,1649,90897,0,0,560,12178,0,0;QS=3,0;MQSB=0.210122;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,214:9:0 0,33,255:11:0 +17 333 . A 0 . DP=32;I16=14,18,0,0,1141,41987,0,0,1649,90897,0,0,558,12064,0,0;QS=3,0;MQSB=0.210122;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,223:9:0 0,33,255:11:0 +17 334 . A 0 . DP=32;I16=14,18,0,0,1162,43328,0,0,1649,90897,0,0,556,11986,0,0;QS=3,0;MQSB=0.210122;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,221:9:0 0,33,255:11:0 +17 335 . A 0 . DP=32;I16=12,18,0,0,1077,40287,0,0,1529,83697,0,0,552,11934,0,0;QS=3,0;MQSB=0.264959;MQ0F=0 PL:DP:DV 0,30,250:10:0 0,27,219:9:0 0,33,251:11:0 +17 336 . A 0 . DP=32;I16=14,17,0,0,1088,39758,0,0,1612,89528,0,0,536,11574,0,0;QS=3,0;MQSB=0.274662;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,211:8:0 0,36,255:12:0 +17 337 . C 0 . DP=32;I16=13,17,0,0,1115,42381,0,0,1552,85928,0,0,531,11565,0,0;QS=3,0;MQSB=0.301511;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,24,202:8:0 0,36,255:12:0 +17 338 . T 0 . DP=30;I16=14,16,0,0,1191,47979,0,0,1560,86456,0,0,554,11878,0,0;QS=3,0;MQSB=0.242376;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,24,226:8:0 0,36,255:12:0 +17 339 . C 0 . DP=31;I16=14,17,0,0,1130,43210,0,0,1589,87297,0,0,554,11874,0,0;QS=3,0;MQSB=0.175471;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,185:8:0 0,36,255:12:0 +17 340 . C 0 . DP=31;I16=14,17,0,0,1196,47044,0,0,1589,87297,0,0,554,11852,0,0;QS=3,0;MQSB=0.175471;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,221:8:0 0,36,255:12:0 +17 341 . T 0 . DP=31;I16=14,17,0,0,1227,48995,0,0,1589,87297,0,0,554,11862,0,0;QS=3,0;MQSB=0.175471;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,216:8:0 0,36,255:12:0 +17 342 . T 0 . DP=31;I16=14,17,0,0,1162,43942,0,0,1589,87297,0,0,554,11904,0,0;QS=3,0;MQSB=0.175471;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,210:8:0 0,36,255:12:0 +17 343 . G 0 . DP=32;I16=14,17,0,0,1150,43702,0,0,1620,90056,0,0,550,11962,0,0;QS=3,0;MQSB=0.283511;MQ0F=0 PL:DP:DV 0,30,249:10:0 0,27,218:9:0 0,36,255:12:0 +17 344 . C 0 . DP=32;I16=14,18,0,0,1181,45169,0,0,1649,90897,0,0,554,12036,0,0;QS=3,0;MQSB=0.210122;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,217:9:0 0,36,255:12:0 +17 345 . T 0 . DP=31;I16=14,17,0,0,1205,47259,0,0,1589,87297,0,0,555,12129,0,0;QS=3,0;MQSB=0.175471;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,221:8:0 0,36,255:12:0 +17 346 . G 0 . DP=31;I16=15,16,0,0,1147,43597,0,0,1620,90056,0,0,557,12255,0,0;QS=3,0;MQSB=0.220358;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,212:8:0 0,36,255:12:0 +17 347 . G 0 . DP=31;I16=14,16,0,0,1119,42227,0,0,1560,86456,0,0,545,12189,0,0;QS=3,0;MQSB=0.242376;MQ0F=0 PL:DP:DV 0,30,251:10:0 0,24,207:8:0 0,36,255:12:0 +17 348 . T 0 . DP=32;I16=15,16,0,0,1145,43007,0,0,1620,90056,0,0,546,12300,0,0;QS=3,0;MQSB=0.220358;MQ0F=0 PL:DP:DV 0,30,243:10:0 0,27,228:9:0 0,36,255:12:0 +17 349 . T 0 . DP=32;I16=16,16,0,0,1194,45350,0,0,1680,93656,0,0,565,12731,0,0;QS=3,0;MQSB=0.201402;MQ0F=0 PL:DP:DV 0,33,246:11:0 0,27,230:9:0 0,36,255:12:0 +17 350 . T 0 . DP=31;I16=16,15,0,0,1142,43072,0,0,1651,92815,0,0,567,12837,0,0;QS=3,0;MQSB=0.286505;MQ0F=0 PL:DP:DV 0,33,249:11:0 0,27,230:9:0 0,33,255:11:0 +17 351 . G 0 . DP=31;I16=16,15,0,0,1146,43750,0,0,1651,92815,0,0,568,12920,0,0;QS=3,0;MQSB=0.286505;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,212:9:0 0,33,255:11:0 +17 352 . A 0 . DP=31;I16=16,14,0,0,1150,45520,0,0,1591,89215,0,0,544,12404,0,0;QS=3,0;MQSB=0.242376;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,224:8:0 0,33,255:11:0 +17 353 . G 0 . DP=29;I16=15,14,0,0,1109,43095,0,0,1562,88374,0,0,570,13064,0,0;QS=3,0;MQSB=0.424373;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,27,231:9:0 0,30,255:10:0 +17 354 . A 0 . DP=28;I16=14,14,0,0,1078,42938,0,0,1502,84774,0,0,571,13075,0,0;QS=3,0;MQSB=0.450096;MQ0F=0 PL:DP:DV 0,27,225:9:0 0,27,244:9:0 0,30,255:10:0 +17 355 . G T, 0 . DP=28;I16=14,13,0,1,1001,37907,41,1681,1442,81174,60,3600,547,12487,25,625;QS=2.875,0.125,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.450096;BQB=1;MQ0F=0 PL:DP:DV 14,0,200,38,203,231:9:1 0,27,222,27,222,222:9:0 0,30,255,30,255,255:10:0 +17 356 . G 0 . DP=27;I16=14,13,0,0,993,37481,0,0,1465,83405,0,0,574,13174,0,0;QS=3,0;MQSB=0.580277;MQ0F=0 PL:DP:DV 0,27,228:9:0 0,24,201:8:0 0,30,255:10:0 +17 357 . C 0 . DP=28;I16=14,13,0,0,1021,39471,0,0,1465,83405,0,0,550,12584,0,0;QS=3,0;MQSB=0.580277;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,24,205:8:0 0,27,251:9:0 +17 358 . A 0 . DP=28;I16=15,13,0,0,1050,40518,0,0,1525,87005,0,0,576,13216,0,0;QS=3,0;MQSB=0.556581;MQ0F=0 PL:DP:DV 0,30,254:10:0 0,24,197:8:0 0,30,255:10:0 +17 359 . G 0 . DP=29;I16=15,13,0,0,1085,42761,0,0,1525,87005,0,0,552,12620,0,0;QS=3,0;MQSB=0.556581;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,187:7:0 0,33,255:11:0 +17 360 . A 0 . DP=29;I16=15,14,0,0,1111,43259,0,0,1585,90605,0,0,579,13297,0,0;QS=3,0;MQSB=0.604224;MQ0F=0 PL:DP:DV 0,30,252:10:0 0,24,220:8:0 0,33,255:11:0 +17 361 . A 0 . DP=29;I16=15,14,0,0,1116,43442,0,0,1585,90605,0,0,579,13273,0,0;QS=3,0;MQSB=0.604224;MQ0F=0 PL:DP:DV 0,30,252:10:0 0,24,219:8:0 0,33,255:11:0 +17 362 . A 0 . DP=29;I16=16,13,0,0,1104,42700,0,0,1585,90605,0,0,580,13272,0,0;QS=3,0;MQSB=0.535133;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,218:8:0 0,30,255:10:0 +17 363 . A 0 . DP=29;I16=16,13,0,0,1087,41437,0,0,1585,90605,0,0,581,13245,0,0;QS=3,0;MQSB=0.535133;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,213:8:0 0,30,255:10:0 +17 364 . T 0 . DP=29;I16=16,13,0,0,1032,37960,0,0,1585,90605,0,0,582,13244,0,0;QS=3,0;MQSB=0.535133;MQ0F=0 PL:DP:DV 0,33,250:11:0 0,24,205:8:0 0,30,255:10:0 +17 365 . G 0 . DP=29;I16=16,13,0,0,1105,43079,0,0,1585,90605,0,0,582,13218,0,0;QS=3,0;MQSB=0.535133;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,211:8:0 0,30,255:10:0 +17 366 . A 0 . DP=29;I16=16,13,0,0,1090,41562,0,0,1585,90605,0,0,581,13167,0,0;QS=3,0;MQSB=0.535133;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,211:8:0 0,30,255:10:0 +17 367 . T 0 . DP=29;I16=16,13,0,0,1055,39149,0,0,1585,90605,0,0,579,13093,0,0;QS=3,0;MQSB=0.535133;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,204:8:0 0,30,255:10:0 +17 368 . A 0 . DP=29;I16=16,13,0,0,1054,39632,0,0,1585,90605,0,0,576,12998,0,0;QS=3,0;MQSB=0.535133;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,208:8:0 0,30,255:10:0 +17 369 . T 0 . DP=28;I16=16,11,0,0,1037,40275,0,0,1496,86164,0,0,548,12256,0,0;QS=3,0;MQSB=0.659218;MQ0F=0 PL:DP:DV 0,30,250:10:0 0,21,196:7:0 0,30,255:10:0 +17 370 . C 0 . DP=28;I16=16,12,0,0,1045,40219,0,0,1556,89764,0,0,570,12790,0,0;QS=3,0;MQSB=0.705296;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,24,201:8:0 0,30,255:10:0 +17 371 . T 0 . DP=29;I16=16,13,0,0,1155,46591,0,0,1616,93364,0,0,567,12725,0,0;QS=3,0;MQSB=0.744925;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,24,227:8:0 0,33,255:11:0 +17 372 . C 0 . DP=30;I16=16,14,0,0,1139,44019,0,0,1676,96964,0,0,564,12636,0,0;QS=3,0;MQSB=0.779025;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,215:8:0 0,33,255:11:0 +17 373 . A 0 . DP=30;I16=16,14,0,0,1142,44118,0,0,1676,96964,0,0,561,12525,0,0;QS=3,0;MQSB=0.779025;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,220:8:0 0,33,255:11:0 +17 374 . T 0 . DP=30;I16=16,14,0,0,1098,41180,0,0,1676,96964,0,0,556,12344,0,0;QS=3,0;MQSB=0.779025;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,221:8:0 0,33,255:11:0 +17 375 . A T, 0 . DP=31;I16=17,13,0,1,1138,43798,14,196,1676,96964,60,3600,547,12177,4,16;QS=2.9661,0.0338983,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.763662;BQB=1;MQ0F=0 PL:DP:DV 0,36,255,36,255,255:12:0 0,24,218,24,218,218:8:0 0,18,255,30,255,255:11:1 +17 376 . G 0 . DP=31;I16=17,14,0,0,1131,42581,0,0,1736,100564,0,0,547,12073,0,0;QS=3,0;MQSB=0.763662;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,220:8:0 0,33,255:11:0 +17 377 . T 0 . DP=31;I16=16,14,0,0,1105,41629,0,0,1676,96964,0,0,518,11360,0,0;QS=3,0;MQSB=0.779025;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,211:8:0 0,33,255:11:0 +17 378 . T 0 . DP=30;I16=18,12,0,0,1098,41066,0,0,1707,99723,0,0,541,11927,0,0;QS=3,0;MQSB=0.878946;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,186:7:0 0,30,255:10:0 +17 379 . G 0 . DP=29;I16=18,10,0,0,1053,40181,0,0,1618,95282,0,0,534,11848,0,0;QS=3,0;MQSB=0.981777;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,187:7:0 0,30,255:10:0 +17 380 . C 0 . DP=29;I16=18,10,0,0,1087,42743,0,0,1618,95282,0,0,514,11172,0,0;QS=3,0;MQSB=0.981777;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,177:6:0 0,30,255:10:0 +17 381 . T 0 . DP=29;I16=18,11,0,0,1168,47412,0,0,1678,98882,0,0,537,11729,0,0;QS=3,0;MQSB=0.987702;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,212:7:0 0,30,255:10:0 +17 382 . T 0 . DP=29;I16=17,11,0,0,1054,40450,0,0,1618,95282,0,0,510,11068,0,0;QS=3,0;MQSB=0.990092;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,182:7:0 0,30,255:10:0 +17 383 . T 0 . DP=29;I16=18,10,0,0,1052,39798,0,0,1618,95282,0,0,507,11013,0,0;QS=3,0;MQSB=0.981777;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,165:6:0 0,30,255:10:0 +17 384 . A 0 . DP=31;I16=19,11,0,0,1077,39885,0,0,1738,102482,0,0,504,10988,0,0;QS=3,0;MQSB=0.985292;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,176:7:0 0,30,255:10:0 +17 385 . C 0 . DP=31;I16=19,12,0,0,1118,41180,0,0,1798,106082,0,0,527,11569,0,0;QS=3,0;MQSB=0.989977;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,24,186:8:0 0,30,255:10:0 +17 386 . T 0 . DP=30;I16=18,12,0,0,1158,45592,0,0,1738,102482,0,0,526,11556,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,191:7:0 0,30,255:10:0 +17 387 . T 0 . DP=30;I16=18,12,0,0,1105,41821,0,0,1738,102482,0,0,525,11573,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,187:7:0 0,30,255:10:0 +17 388 . T 0 . DP=29;I16=17,12,0,0,1089,41577,0,0,1678,98882,0,0,523,11519,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,180:6:0 0,30,255:10:0 +17 389 . G 0 . DP=29;I16=17,12,0,0,1067,40095,0,0,1678,98882,0,0,520,11444,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,171:6:0 0,30,255:10:0 +17 390 . C 0 . DP=29;I16=17,12,0,0,1071,40423,0,0,1678,98882,0,0,517,11399,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,162:6:0 0,30,255:10:0 +17 391 . A 0 . DP=29;I16=18,11,0,0,1091,41603,0,0,1647,96123,0,0,515,11383,0,0;QS=3,0;MQSB=0.995968;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,163:6:0 0,30,255:10:0 +17 392 . T 0 . DP=29;I16=18,11,0,0,1046,38838,0,0,1647,96123,0,0,515,11395,0,0;QS=3,0;MQSB=0.995968;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,153:5:0 0,33,255:11:0 +17 393 . A 0 . DP=28;I16=17,11,0,0,1014,37582,0,0,1587,92523,0,0,517,11435,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,133:5:0 0,33,255:11:0 +17 394 . T 0 . DP=28;I16=17,11,0,0,1022,38342,0,0,1587,92523,0,0,519,11503,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,141:5:0 0,33,255:11:0 +17 395 . T 0 . DP=28;I16=17,11,0,0,1060,40596,0,0,1587,92523,0,0,521,11599,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,164:5:0 0,33,255:11:0 +17 396 . T 0 . DP=28;I16=17,11,0,0,1032,39228,0,0,1587,92523,0,0,523,11723,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,158:5:0 0,33,255:11:0 +17 397 . T 0 . DP=28;I16=17,11,0,0,1046,39510,0,0,1587,92523,0,0,524,11824,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,149:5:0 0,33,255:11:0 +17 398 . A 0 . DP=28;I16=17,11,0,0,1021,38105,0,0,1587,92523,0,0,524,11850,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,144:5:0 0,30,255:10:0 +17 399 . A 0 . DP=28;I16=17,11,0,0,1015,38469,0,0,1587,92523,0,0,526,11900,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,140:5:0 0,30,255:10:0 +17 400 . A 0 . DP=29;I16=17,12,0,0,1056,39702,0,0,1647,96123,0,0,526,11828,0,0;QS=3,0;MQSB=0.988062;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,159:5:0 0,33,255:11:0 +17 401 . A 0 . DP=29;I16=17,11,0,0,1052,40302,0,0,1587,92523,0,0,501,11113,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,160:5:0 0,30,255:10:0 +17 402 . T 0 . DP=29;I16=17,12,0,0,1082,41232,0,0,1647,96123,0,0,526,11680,0,0;QS=3,0;MQSB=0.988062;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,149:5:0 0,33,255:11:0 +17 403 . T 0 . DP=29;I16=17,12,0,0,1085,40985,0,0,1647,96123,0,0,526,11654,0,0;QS=3,0;MQSB=0.988062;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,148:5:0 0,33,255:11:0 +17 404 . G 0 . DP=29;I16=17,12,0,0,1074,40524,0,0,1647,96123,0,0,525,11609,0,0;QS=3,0;MQSB=0.988062;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,131:5:0 0,33,255:11:0 +17 405 . T 0 . DP=27;I16=16,10,0,0,988,37870,0,0,1498,88082,0,0,519,11543,0,0;QS=3,0;MQSB=0.987578;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,103:3:0 0,30,255:10:0 +17 406 . G 0 . DP=27;I16=16,11,0,0,976,36752,0,0,1558,91682,0,0,527,11601,0,0;QS=3,0;MQSB=0.992419;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,125:4:0 0,30,247:10:0 +17 407 . A 0 . DP=27;I16=16,11,0,0,1007,38355,0,0,1558,91682,0,0,526,11538,0,0;QS=3,0;MQSB=0.992419;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,125:4:0 0,30,255:10:0 +17 408 . C 0 . DP=28;I16=16,11,0,0,1006,38136,0,0,1558,91682,0,0,521,11489,0,0;QS=3,0;MQSB=0.992419;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,110:3:0 0,30,244:10:0 +17 409 . T 0 . DP=29;I16=17,12,0,0,1100,42734,0,0,1678,98882,0,0,525,11503,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,131:4:0 0,33,255:11:0 +17 410 . T 0 . DP=29;I16=17,12,0,0,1035,38325,0,0,1678,98882,0,0,524,11432,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,125:4:0 0,33,255:11:0 +17 411 . T 0 . DP=29;I16=17,10,0,0,1003,37747,0,0,1558,91682,0,0,496,10716,0,0;QS=3,0;MQSB=0.984677;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,104:3:0 0,30,255:10:0 +17 412 . C T, 0 . DP=30;I16=17,12,1,0,1094,42458,14,196,1678,98882,60,3600,495,10659,25,625;QS=2.97455,0.0254545,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.991968;BQB=1;MQ0F=0 PL:DP:DV 0,30,255,42,255,255:15:1 0,12,124,12,124,124:4:0 0,33,255,33,255,255:11:0 +17 413 . A 0 . DP=31;I16=18,13,0,0,1189,45985,0,0,1798,106082,0,0,520,11258,0,0;QS=3,0;MQSB=0.995005;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,9,102:3:0 0,33,255:11:0 +17 414 . T 0 . DP=30;I16=18,12,0,0,1151,44355,0,0,1738,102482,0,0,523,11265,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,109:3:0 0,33,255:11:0 +17 415 . G 0 . DP=30;I16=18,12,0,0,1131,43175,0,0,1738,102482,0,0,526,11306,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,110:3:0 0,33,255:11:0 +17 416 . G 0 . DP=30;I16=17,12,0,0,1083,41273,0,0,1678,98882,0,0,514,11156,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,114:3:0 0,30,253:10:0 +17 417 . C 0 . DP=30;I16=18,12,0,0,1114,42244,0,0,1738,102482,0,0,531,11439,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,108:3:0 0,33,255:11:0 +17 418 . A 0 . DP=30;I16=18,12,0,0,1146,44248,0,0,1738,102482,0,0,532,11478,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,111:3:0 0,33,255:11:0 +17 419 . T 0 . DP=30;I16=18,12,0,0,1117,42327,0,0,1738,102482,0,0,532,11498,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,112:3:0 0,33,255:11:0 +17 420 . A 0 . DP=31;I16=18,13,0,0,1117,41011,0,0,1798,106082,0,0,532,11550,0,0;QS=3,0;MQSB=0.995005;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,108:3:0 0,36,255:12:0 +17 421 . A 0 . DP=33;I16=19,14,0,0,1208,45398,0,0,1887,110523,0,0,533,11635,0,0;QS=3,0;MQSB=0.986656;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,113:3:0 0,42,255:14:0 +17 422 . A 0 . DP=33;I16=19,13,0,0,1205,46441,0,0,1827,106923,0,0,510,11082,0,0;QS=3,0;MQSB=0.991023;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,116:3:0 0,39,255:13:0 +17 423 . T 0 . DP=32;I16=19,13,0,0,1202,45416,0,0,1827,106923,0,0,538,11818,0,0;QS=3,0;MQSB=0.991023;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,110:3:0 0,39,255:13:0 +17 424 . A 0 . DP=32;I16=19,13,0,0,1147,41685,0,0,1827,106923,0,0,539,11867,0,0;QS=3,0;MQSB=0.991023;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,106:3:0 0,39,255:13:0 +17 425 . A 0 . DP=29;I16=16,13,0,0,1070,40616,0,0,1647,96123,0,0,542,11900,0,0;QS=3,0;MQSB=0.976248;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,111:3:0 0,33,249:11:0 +17 426 . T 0 . DP=29;I16=16,12,0,0,997,36561,0,0,1587,92523,0,0,519,11287,0,0;QS=3,0;MQSB=0.982906;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,105:3:0 0,30,225:10:0 +17 427 . A 0 . DP=29;I16=16,13,0,0,1024,37266,0,0,1647,96123,0,0,546,11952,0,0;QS=3,0;MQSB=0.976248;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,111:3:0 0,33,242:11:0 +17 428 . C 0 . DP=29;I16=16,13,0,0,1064,39706,0,0,1647,96123,0,0,548,12020,0,0;QS=3,0;MQSB=0.976248;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,111:3:0 0,33,254:11:0 +17 429 . T 0 . DP=30;I16=16,14,0,0,1150,44918,0,0,1707,99723,0,0,549,12067,0,0;QS=3,0;MQSB=0.969373;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,115:3:0 0,33,255:11:0 +17 430 . G 0 . DP=30;I16=16,14,0,0,1113,42443,0,0,1707,99723,0,0,551,12145,0,0;QS=3,0;MQSB=0.969373;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,112:3:0 0,33,246:11:0 +17 431 . G 0 . DP=30;I16=14,14,0,0,1003,36953,0,0,1587,92523,0,0,553,12255,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,101:3:0 0,30,225:10:0 +17 432 . T 0 . DP=28;I16=14,14,0,0,1049,39621,0,0,1587,92523,0,0,556,12346,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,114:3:0 0,30,255:10:0 +17 433 . T 0 . DP=28;I16=14,12,0,0,949,35443,0,0,1467,85323,0,0,509,11217,0,0;QS=3,0;MQSB=0.967472;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,112:3:0 0,27,227:9:0 +17 434 . T 0 . DP=29;I16=15,14,0,0,1036,37654,0,0,1647,96123,0,0,561,12567,0,0;QS=3,0;MQSB=0.960561;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,98:3:0 0,30,243:10:0 +17 435 . A 0 . DP=29;I16=15,13,0,0,1024,37970,0,0,1587,92523,0,0,556,12560,0,0;QS=3,0;MQSB=0.968414;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,103:3:0 0,30,237:10:0 +17 436 . T 0 . DP=28;I16=14,14,0,0,998,36220,0,0,1587,92523,0,0,564,12654,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,110:3:0 0,27,223:9:0 +17 437 . T 0 . DP=28;I16=13,14,0,0,990,36832,0,0,1558,91682,0,0,549,12435,0,0;QS=3,0;MQSB=0.999706;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,109:3:0 0,24,207:8:0 +17 438 . A 0 . DP=28;I16=14,13,0,0,972,35640,0,0,1527,88923,0,0,540,12082,0,0;QS=3,0;MQSB=0.9585;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,107:3:0 0,24,216:8:0 +17 439 . C 0 . DP=28;I16=14,14,0,0,1055,40273,0,0,1587,92523,0,0,563,12649,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,107:3:0 0,27,224:9:0 +17 440 . A 0 . DP=28;I16=14,14,0,0,1095,43251,0,0,1587,92523,0,0,561,12615,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,115:3:0 0,27,247:9:0 +17 441 . G 0 . DP=29;I16=15,14,0,0,1068,40344,0,0,1647,96123,0,0,559,12605,0,0;QS=3,0;MQSB=0.960561;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,9,104:3:0 0,27,198:9:0 +17 442 . A 0 . DP=29;I16=15,14,0,0,1091,41507,0,0,1647,96123,0,0,558,12620,0,0;QS=3,0;MQSB=0.960561;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,9,112:3:0 0,27,233:9:0 +17 443 . A 0 . DP=30;I16=15,14,0,0,1173,49439,0,0,1647,96123,0,0,557,12661,0,0;QS=3,0;MQSB=0.960561;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,9,129:3:0 0,27,246:9:0 +17 444 . G 0 . DP=29;I16=15,13,0,0,1095,44661,0,0,1587,92523,0,0,557,12727,0,0;QS=3,0;MQSB=0.968414;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,91:2:0 0,27,227:9:0 +17 445 . C 0 . DP=30;I16=16,13,0,0,1100,43706,0,0,1647,96123,0,0,557,12817,0,0;QS=3,0;MQSB=0.976248;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,9,111:3:0 0,27,219:9:0 +17 446 . A 0 . DP=30;I16=16,13,0,0,1107,44265,0,0,1647,96123,0,0,557,12881,0,0;QS=3,0;MQSB=0.976248;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,9,115:3:0 0,27,232:9:0 +17 447 . C 0 . DP=29;I16=16,12,0,0,1108,45364,0,0,1618,95282,0,0,555,12817,0,0;QS=3,0;MQSB=0.856268;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,114:3:0 0,27,235:9:0 +17 448 . T 0 . DP=29;I16=16,12,0,0,1125,47237,0,0,1618,95282,0,0,553,12773,0,0;QS=3,0;MQSB=0.856268;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,118:3:0 0,27,240:9:0 +17 449 . A 0 . DP=28;I16=15,12,0,0,1091,45981,0,0,1558,91682,0,0,552,12748,0,0;QS=3,0;MQSB=0.84246;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,90:2:0 0,27,245:9:0 +17 450 . G 0 . DP=28;I16=15,12,0,0,1069,44603,0,0,1558,91682,0,0,551,12741,0,0;QS=3,0;MQSB=0.84246;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,91:2:0 0,27,233:9:0 +17 451 . A 0 . DP=28;I16=15,12,0,0,1021,41371,0,0,1558,91682,0,0,550,12752,0,0;QS=3,0;MQSB=0.84246;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,93:2:0 0,27,244:9:0 +17 452 . A 0 . DP=31;I16=18,11,0,0,1079,43353,0,0,1678,98882,0,0,530,12420,0,0;QS=3,0;MQSB=0.884952;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,9,110:3:0 0,24,225:8:0 +17 453 . A 0 . DP=31;I16=17,11,0,0,1037,41069,0,0,1649,98041,0,0,508,11882,0,0;QS=3,0;MQSB=0.967085;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,9,111:3:0 0,21,221:7:0 +17 454 . A 0 . DP=31;I16=18,12,0,0,1158,47028,0,0,1738,102482,0,0,554,12904,0,0;QS=3,0;MQSB=0.878946;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,9,113:3:0 0,30,255:10:0 +17 455 . T 0 . DP=32;I16=17,13,0,0,1148,46574,0,0,1715,100251,0,0,550,12864,0,0;QS=3,0;MQSB=0.973855;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,113:3:0 0,33,255:11:0 +17 456 . G 0 . DP=32;I16=17,13,0,0,1161,47287,0,0,1746,103010,0,0,534,12296,0,0;QS=3,0;MQSB=0.998031;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,9,116:3:0 0,30,245:10:0 +17 457 . C 0 . DP=33;I16=19,13,0,0,1218,48642,0,0,1835,107451,0,0,563,12967,0,0;QS=3,0;MQSB=0.985204;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,9,118:3:0 0,33,255:11:0 +17 458 . A 0 . DP=33;I16=19,13,0,0,1226,49034,0,0,1835,107451,0,0,568,12990,0,0;QS=3,0;MQSB=0.985204;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,9,111:3:0 0,33,255:11:0 +17 459 . T 0 . DP=33;I16=18,13,0,0,1167,46981,0,0,1775,103851,0,0,565,12945,0,0;QS=3,0;MQSB=0.980167;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,92:2:0 0,33,255:11:0 +17 460 . G 0 . DP=32;I16=19,12,0,0,1219,50105,0,0,1775,103851,0,0,575,12929,0,0;QS=3,0;MQSB=0.989977;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,9,116:3:0 0,30,255:10:0 +17 461 . T 0 . DP=32;I16=19,12,0,0,1213,49819,0,0,1775,103851,0,0,577,12845,0,0;QS=3,0;MQSB=0.989977;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,9,115:3:0 0,30,255:10:0 +17 462 . G 0 . DP=32;I16=19,12,0,0,1190,48962,0,0,1775,103851,0,0,580,12792,0,0;QS=3,0;MQSB=0.989977;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,119:4:0 0,30,241:10:0 +17 463 . G 0 . DP=32;I16=19,12,0,0,1114,44214,0,0,1775,103851,0,0,584,12770,0,0;QS=3,0;MQSB=0.989977;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,114:4:0 0,30,221:10:0 +17 464 . A 0 . DP=32;I16=18,11,0,0,1100,43908,0,0,1686,99410,0,0,556,12106,0,0;QS=3,0;MQSB=0.99095;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,133:4:0 0,24,213:8:0 +17 465 . C 0 . DP=33;I16=20,11,0,0,1191,48085,0,0,1775,103851,0,0,586,12786,0,0;QS=3,0;MQSB=0.996597;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,140:5:0 0,27,231:9:0 +17 466 . A 0 . DP=34;I16=21,12,0,0,1293,53311,0,0,1895,111051,0,0,597,12897,0,0;QS=3,0;MQSB=0.995633;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,154:5:0 0,30,255:10:0 +17 467 . A 0 . DP=34;I16=21,11,0,0,1256,51450,0,0,1835,107451,0,0,597,12891,0,0;QS=3,0;MQSB=0.998231;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,157:5:0 0,27,248:9:0 +17 468 . A 0 . DP=35;I16=22,12,0,0,1274,51268,0,0,1955,114651,0,0,604,12904,0,0;QS=3,0;MQSB=0.997406;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,154:5:0 0,30,251:10:0 +17 469 . A 0 . DP=35;I16=22,12,0,0,1285,52989,0,0,1955,114651,0,0,608,12940,0,0;QS=3,0;MQSB=0.997406;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,146:5:0 0,30,255:10:0 +17 470 . G 0 . DP=35;I16=22,12,0,0,1281,51055,0,0,1955,114651,0,0,612,13016,0,0;QS=3,0;MQSB=0.997406;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,148:5:0 0,30,238:10:0 +17 471 . T 0 . DP=36;I16=22,11,0,0,1239,49021,0,0,1918,113282,0,0,599,12825,0,0;QS=3,0;MQSB=0.915545;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,150:5:0 0,27,232:9:0 +17 472 . T 0 . DP=35;I16=21,12,0,0,1245,48915,0,0,1926,113810,0,0,595,12559,0,0;QS=3,0;MQSB=0.988858;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,153:5:0 0,27,237:9:0 +17 473 . G 0 . DP=35;I16=21,12,0,0,1307,53473,0,0,1926,113810,0,0,599,12651,0,0;QS=3,0;MQSB=0.988858;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,141:5:0 0,27,249:9:0 +17 474 . G 0 . DP=36;I16=22,12,0,0,1284,51708,0,0,1986,117410,0,0,602,12734,0,0;QS=3,0;MQSB=0.986937;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,131:5:0 0,30,255:10:0 +17 475 . G 0 . DP=36;I16=23,12,0,0,1311,51609,0,0,2015,118251,0,0,631,13485,0,0;QS=3,0;MQSB=0.998642;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,141:5:0 0,33,252:11:0 +17 476 . A 0 . DP=36;I16=23,12,0,0,1312,52078,0,0,2015,118251,0,0,634,13606,0,0;QS=3,0;MQSB=0.998642;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,157:5:0 0,33,255:11:0 +17 477 . T 0 . DP=36;I16=23,12,0,0,1318,52668,0,0,2015,118251,0,0,637,13773,0,0;QS=3,0;MQSB=0.998642;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,148:5:0 0,33,255:11:0 +17 478 . T 0 . DP=38;I16=25,12,0,0,1338,51774,0,0,2135,125451,0,0,637,13833,0,0;QS=3,0;MQSB=0.999868;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,18,154:6:0 0,33,255:11:0 +17 479 . A 0 . DP=38;I16=25,12,0,0,1420,57788,0,0,2135,125451,0,0,639,13935,0,0;QS=3,0;MQSB=0.999868;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,18,163:6:0 0,33,255:11:0 +17 480 . G 0 . DP=37;I16=25,11,0,0,1438,60172,0,0,2075,121851,0,0,641,14029,0,0;QS=3,0;MQSB=0.999853;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,165:6:0 0,33,255:11:0 +17 481 . G 0 . DP=37;I16=25,11,0,0,1392,55824,0,0,2075,121851,0,0,642,14112,0,0;QS=3,0;MQSB=0.999853;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,165:6:0 0,33,255:11:0 +17 482 . A 0 . DP=37;I16=24,11,0,0,1352,55134,0,0,2015,118251,0,0,618,13608,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,143:5:0 0,33,255:11:0 +17 483 . G 0 . DP=37;I16=24,12,0,0,1417,57747,0,0,2075,121851,0,0,642,14240,0,0;QS=3,0;MQSB=0.999437;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,165:6:0 0,33,255:11:0 +17 484 . A 0 . DP=36;I16=24,11,0,0,1340,53992,0,0,2015,118251,0,0,643,14281,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,168:6:0 0,33,255:11:0 +17 485 . G 0 . DP=35;I16=23,12,0,0,1329,51411,0,0,2015,118251,0,0,669,14931,0,0;QS=3,0;MQSB=0.998642;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,160:6:0 0,33,255:11:0 +17 486 . A 0 . DP=34;I16=22,12,0,0,1311,51523,0,0,1955,114651,0,0,671,14989,0,0;QS=3,0;MQSB=0.997406;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,173:6:0 0,33,255:11:0 +17 487 . G 0 . DP=34;I16=22,12,0,0,1306,50760,0,0,1955,114651,0,0,672,15030,0,0;QS=3,0;MQSB=0.997406;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,169:6:0 0,33,255:11:0 +17 488 . A 0 . DP=35;I16=22,12,0,0,1274,48140,0,0,1986,117410,0,0,646,14380,0,0;QS=3,0;MQSB=0.986937;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,177:6:0 0,30,255:10:0 +17 489 . A 0 . DP=35;I16=23,12,0,0,1264,46916,0,0,2015,118251,0,0,671,15015,0,0;QS=3,0;MQSB=0.998642;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,175:6:0 0,33,255:11:0 +17 490 . A 0 . DP=36;I16=24,12,0,0,1332,50280,0,0,2075,121851,0,0,671,15061,0,0;QS=3,0;MQSB=0.999437;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,188:7:0 0,33,255:11:0 +17 491 . T 0 . DP=36;I16=24,12,0,0,1284,46802,0,0,2075,121851,0,0,671,15093,0,0;QS=3,0;MQSB=0.999437;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,178:7:0 0,33,255:11:0 +17 492 . G 0 . DP=35;I16=21,12,0,0,1252,48326,0,0,1926,113810,0,0,621,13859,0,0;QS=3,0;MQSB=0.988858;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,172:6:0 0,30,251:10:0 +17 493 . A 0 . DP=34;I16=22,11,0,0,1273,49481,0,0,1926,113810,0,0,650,14672,0,0;QS=3,0;MQSB=0.981935;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,186:7:0 0,24,240:8:0 +17 494 . A 0 . DP=34;I16=22,12,0,0,1326,52604,0,0,1986,117410,0,0,672,15182,0,0;QS=3,0;MQSB=0.986937;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,196:7:0 0,27,255:9:0 +17 495 . G 0 . DP=34;I16=21,12,0,0,1255,48577,0,0,1926,113810,0,0,647,14611,0,0;QS=3,0;MQSB=0.988858;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,168:6:0 0,27,244:9:0 +17 496 . A 0 . DP=34;I16=22,12,0,0,1250,46926,0,0,1986,117410,0,0,670,15220,0,0;QS=3,0;MQSB=0.986937;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,186:7:0 0,27,249:9:0 +17 497 . C 0 . DP=34;I16=22,12,0,0,1250,47006,0,0,1986,117410,0,0,665,15087,0,0;QS=3,0;MQSB=0.986937;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,164:7:0 0,27,239:9:0 +17 498 . A 0 . DP=34;I16=22,12,0,0,1286,49158,0,0,1986,117410,0,0,661,14987,0,0;QS=3,0;MQSB=0.986937;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,185:7:0 0,27,252:9:0 +17 499 . T 0 . DP=34;I16=23,11,0,0,1224,45284,0,0,1986,117410,0,0,659,14919,0,0;QS=3,0;MQSB=0.979712;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,183:7:0 0,30,255:10:0 +17 500 . A 0 . DP=34;I16=23,11,0,0,1230,45152,0,0,1986,117410,0,0,657,14833,0,0;QS=3,0;MQSB=0.979712;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,179:7:0 0,30,255:10:0 +17 501 . T 0 . DP=33;I16=23,10,0,0,1241,47167,0,0,1926,113810,0,0,656,14778,0,0;QS=3,0;MQSB=0.972757;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,186:7:0 0,27,241:9:0 +17 502 . G 0 . DP=33;I16=23,10,0,0,1215,45829,0,0,1926,113810,0,0,655,14753,0,0;QS=3,0;MQSB=0.972757;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,183:7:0 0,27,235:9:0 +17 503 . T 0 . DP=34;I16=23,11,0,0,1194,43366,0,0,1986,117410,0,0,654,14758,0,0;QS=3,0;MQSB=0.979712;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,177:7:0 0,27,234:9:0 +17 504 . C 0 . DP=34;I16=23,11,0,0,1218,45552,0,0,1986,117410,0,0,651,14643,0,0;QS=3,0;MQSB=0.979712;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,183:7:0 0,27,219:9:0 +17 505 . C 0 . DP=35;I16=23,11,0,0,1207,44321,0,0,1986,117410,0,0,641,14509,0,0;QS=3,0;MQSB=0.979712;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,189:7:0 0,27,221:9:0 +17 506 . A 0 . DP=35;I16=24,11,0,0,1266,46776,0,0,2046,121010,0,0,646,14504,0,0;QS=3,0;MQSB=0.977529;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,188:7:0 0,27,231:9:0 +17 507 . C 0 . DP=35;I16=23,11,0,0,1220,45016,0,0,1986,117410,0,0,635,14401,0,0;QS=3,0;MQSB=0.979712;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,183:7:0 0,27,226:9:0 +17 508 . A 0 . DP=34;I16=24,10,0,0,1204,44542,0,0,1986,117410,0,0,643,14491,0,0;QS=3,0;MQSB=0.970272;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,189:7:0 0,27,220:9:0 +17 509 . C 0 . DP=34;I16=24,10,0,0,1272,48272,0,0,1986,117410,0,0,640,14430,0,0;QS=3,0;MQSB=0.970272;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,186:7:0 0,27,241:9:0 +17 510 . A 0 . DP=34;I16=22,11,0,0,1194,44196,0,0,1926,113810,0,0,613,13773,0,0;QS=3,0;MQSB=0.981935;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,187:7:0 0,24,221:8:0 +17 511 . A 0 . DP=34;I16=23,11,0,0,1222,45562,0,0,1986,117410,0,0,637,14395,0,0;QS=3,0;MQSB=0.979712;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,195:7:0 0,24,233:8:0 +17 512 . A C, 0 . DP=33;I16=22,10,0,1,1121,40793,13,169,1866,110210,60,3600,628,14340,9,81;QS=2.97719,0.022807,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.981935;BQB=1;MQ0F=0 PL:DP:DV 0,39,255,51,255,255:18:1 0,21,183,21,183,183:7:0 0,24,231,24,231,231:8:0 +17 513 . A 0 . DP=32;I16=20,10,0,0,1115,42183,0,0,1746,103010,0,0,598,13624,0,0;QS=3,0;MQSB=0.980594;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,175:6:0 0,24,233:8:0 +17 514 . A T, 0 . DP=32;I16=20,9,0,1,1066,40004,16,256,1686,99410,60,3600,586,13500,11,121;QS=2.97075,0.0292505,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.980594;BQB=1;MQ0F=0 PL:DP:DV 0,31,255,45,255,255:16:1 0,18,171,18,171,171:6:0 0,24,235,24,235,235:8:0 +17 515 . C 0 . DP=32;I16=18,10,0,0,1010,37294,0,0,1626,95810,0,0,561,12915,0,0;QS=3,0;MQSB=0.986018;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,167:6:0 0,24,211:8:0 +17 516 . C 0 . DP=32;I16=21,10,0,0,1100,40570,0,0,1806,106610,0,0,612,13954,0,0;QS=3,0;MQSB=0.977926;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,187:7:0 0,24,215:8:0 +17 517 . T 0 . DP=33;I16=23,10,0,0,1269,49995,0,0,1926,113810,0,0,636,14626,0,0;QS=3,0;MQSB=0.972757;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,201:7:0 0,24,242:8:0 +17 518 . G 0 . DP=34;I16=24,10,0,0,1247,46839,0,0,1986,117410,0,0,636,14696,0,0;QS=3,0;MQSB=0.970272;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,182:7:0 0,24,220:8:0 +17 519 . T 0 . DP=36;I16=25,11,0,0,1283,46693,0,0,2106,124610,0,0,636,14742,0,0;QS=3,0;MQSB=0.975394;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,21,177:7:0 0,24,224:8:0 +17 520 . T 0 . DP=36;I16=24,11,0,0,1238,44894,0,0,2046,121010,0,0,613,14193,0,0;QS=3,0;MQSB=0.977529;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,21,180:7:0 0,24,223:8:0 +17 521 . C 0 . DP=34;I16=25,9,0,0,1280,49454,0,0,1986,117410,0,0,641,14875,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,21,191:7:0 0,21,204:7:0 +17 522 . A 0 . DP=32;I16=24,8,0,0,1158,43228,0,0,1897,112969,0,0,646,14960,0,0;QS=3,0;MQSB=0.872525;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,21,185:7:0 0,15,170:5:0 +17 523 . T G, 0 . DP=32;I16=23,8,1,0,1184,45708,15,225,1837,109369,60,3600,626,14446,25,625;QS=2.9794,0.0206044,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.872525;BQB=1;MQ0F=0 PL:DP:DV 0,44,255,57,255,255:20:1 0,21,191,21,191,191:7:0 0,15,166,15,166,166:5:0 +17 524 . T 0 . DP=32;I16=24,7,0,0,1084,39474,0,0,1837,109369,0,0,629,14483,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,21,194:7:0 0,12,140:4:0 +17 525 . G 0 . DP=32;I16=24,7,0,0,1181,45669,0,0,1837,109369,0,0,631,14495,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,21,188:7:0 0,12,129:4:0 +17 526 . C 0 . DP=32;I16=24,7,0,0,1146,43950,0,0,1860,111600,0,0,633,14531,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,21,185:7:0 0,12,131:4:0 +17 527 . A 0 . DP=33;I16=24,8,0,0,1209,46265,0,0,1897,112969,0,0,636,14634,0,0;QS=3,0;MQSB=0.872525;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,194:7:0 0,18,181:6:0 +17 528 . G 0 . DP=33;I16=24,8,0,0,1256,49824,0,0,1897,112969,0,0,634,14484,0,0;QS=3,0;MQSB=0.872525;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,18,169:6:0 0,18,193:6:0 +17 529 . C 0 . DP=32;I16=24,7,0,0,1148,44362,0,0,1837,109369,0,0,633,14357,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,187:7:0 0,18,184:6:0 +17 530 . T 0 . DP=32;I16=25,7,0,0,1244,49168,0,0,1897,112969,0,0,657,14883,0,0;QS=3,0;MQSB=0.850154;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,196:7:0 0,18,202:6:0 +17 531 . T 0 . DP=32;I16=25,7,0,0,1177,44171,0,0,1897,112969,0,0,654,14714,0,0;QS=3,0;MQSB=0.850154;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,181:7:0 0,18,193:6:0 +17 532 . T 0 . DP=32;I16=24,7,0,0,1153,43543,0,0,1837,109369,0,0,630,14116,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,181:7:0 0,18,192:6:0 +17 533 . C 0 . DP=32;I16=24,7,0,0,1142,43940,0,0,1837,109369,0,0,619,13649,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,178:7:0 0,18,180:6:0 +17 534 . T 0 . DP=31;I16=24,6,0,0,1212,49426,0,0,1777,105769,0,0,615,13479,0,0;QS=3,0;MQSB=0.82403;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,205:7:0 0,18,205:6:0 +17 535 . A 0 . DP=31;I16=24,6,0,0,1080,39870,0,0,1777,105769,0,0,611,13341,0,0;QS=3,0;MQSB=0.82403;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,194:7:0 0,18,189:6:0 +17 536 . C 0 . DP=31;I16=24,7,0,0,1097,40707,0,0,1837,109369,0,0,631,13809,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,184:7:0 0,18,157:6:0 +17 537 . C 0 . DP=31;I16=22,7,0,0,1034,38564,0,0,1717,102169,0,0,587,12861,0,0;QS=3,0;MQSB=0.854582;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,172:7:0 0,18,183:6:0 +17 538 . A 0 . DP=31;I16=24,7,0,0,1138,42478,0,0,1837,109369,0,0,620,13536,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,189:7:0 0,18,181:6:0 +17 539 . T 0 . DP=31;I16=24,7,0,0,1134,42070,0,0,1837,109369,0,0,614,13422,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,178:7:0 0,18,181:6:0 +17 540 . C 0 . DP=31;I16=24,7,0,0,1148,43768,0,0,1837,109369,0,0,608,13340,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,177:7:0 0,18,178:6:0 +17 541 . A 0 . DP=32;I16=24,6,0,0,1083,40483,0,0,1777,105769,0,0,551,11991,0,0;QS=3,0;MQSB=0.82403;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,180:8:0 0,15,150:5:0 +17 542 . C 0 . DP=33;I16=25,6,0,0,1123,41759,0,0,1837,109369,0,0,570,12552,0,0;QS=3,0;MQSB=0.822578;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,172:8:0 0,18,174:6:0 +17 543 . C 0 . DP=34;I16=25,9,0,0,1219,45959,0,0,1986,117410,0,0,601,13245,0,0;QS=3,0;MQSB=0.621145;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,27,194:9:0 0,18,188:6:0 +17 544 . A 0 . DP=33;I16=24,8,0,0,1170,43898,0,0,1866,110210,0,0,570,12506,0,0;QS=3,0;MQSB=0.579578;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,24,192:8:0 0,18,180:6:0 +17 545 . A 0 . DP=33;I16=25,8,0,0,1174,43602,0,0,1926,113810,0,0,587,12951,0,0;QS=3,0;MQSB=0.576102;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,24,190:8:0 0,18,184:6:0 +17 546 . A 0 . DP=32;I16=24,8,0,0,1126,41444,0,0,1866,110210,0,0,580,12802,0,0;QS=3,0;MQSB=0.579578;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,166:7:0 0,18,193:6:0 +17 547 . A 0 . DP=32;I16=24,7,0,0,1129,42381,0,0,1806,106610,0,0,547,12009,0,0;QS=3,0;MQSB=0.525788;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,180:7:0 0,18,195:6:0 +17 548 . A 0 . DP=33;I16=23,9,0,0,1153,42673,0,0,1866,110210,0,0,561,12489,0,0;QS=3,0;MQSB=0.628357;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,181:7:0 0,21,211:7:0 +17 549 . T G, 0 . DP=32;I16=22,8,0,1,1101,40987,20,400,1746,103010,60,3600,530,11716,25,625;QS=2.96748,0.0325203,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.632337;BQB=1;MQ0F=0 PL:DP:DV 0,31,255,48,255,255:17:1 0,21,168,21,168,168:7:0 0,21,208,21,208,208:7:0 +17 550 . T 0 . DP=32;I16=22,9,0,0,1052,37298,0,0,1806,106610,0,0,548,12176,0,0;QS=3,0;MQSB=0.632337;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,150:7:0 0,21,220:7:0 +17 551 . G 0 . DP=31;I16=22,9,0,0,1121,41639,0,0,1806,106610,0,0,541,12045,0,0;QS=3,0;MQSB=0.632337;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,172:7:0 0,21,208:7:0 +17 552 . C 0 . DP=30;I16=21,9,0,0,1093,41365,0,0,1746,103010,0,0,535,11947,0,0;QS=3,0;MQSB=0.636601;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,167:7:0 0,21,208:7:0 +17 553 . A 0 . DP=30;I16=20,8,0,0,981,35387,0,0,1626,95810,0,0,485,10831,0,0;QS=3,0;MQSB=0.596163;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,150:6:0 0,21,194:7:0 +17 554 . A 0 . DP=30;I16=19,9,0,0,975,35601,0,0,1626,95810,0,0,488,10906,0,0;QS=3,0;MQSB=0.646113;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,139:5:0 0,24,211:8:0 +17 555 . A 0 . DP=30;I16=20,10,0,0,1024,36526,0,0,1746,103010,0,0,514,11392,0,0;QS=3,0;MQSB=0.679025;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,150:6:0 0,21,211:7:0 +17 556 . C 0 . DP=29;I16=20,9,0,0,1055,39195,0,0,1709,101641,0,0,509,11219,0,0;QS=3,0;MQSB=0.894839;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,158:6:0 0,18,186:6:0 +17 557 . A 0 . DP=27;I16=18,9,0,0,987,36749,0,0,1589,94441,0,0,506,11074,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,157:6:0 0,18,186:6:0 +17 558 . A 0 . DP=27;I16=18,8,0,0,948,35808,0,0,1560,93600,0,0,477,10281,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,143:5:0 0,18,177:6:0 +17 559 . C A, 0 . DP=27;I16=17,8,0,1,908,33726,14,196,1500,90000,29,841,448,9516,25,625;QS=2.92708,0.0729167,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.90038;BQB=1;MQ0F=0 PL:DP:DV 0,42,255,42,255,255:14:0 0,4,116,15,119,123:6:1 0,18,169,18,169,169:6:0 +17 560 . C 0 . DP=28;I16=19,9,0,0,992,36552,0,0,1649,98041,0,0,494,10654,0,0;QS=3,0;MQSB=0.896555;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,160:6:0 0,21,181:7:0 +17 561 . A 0 . DP=28;I16=18,9,0,0,963,35455,0,0,1589,94441,0,0,466,9946,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,158:6:0 0,21,194:7:0 +17 562 . C 0 . DP=28;I16=18,9,0,0,1006,38392,0,0,1589,94441,0,0,463,9893,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,153:6:0 0,21,187:7:0 +17 563 . A 0 . DP=27;I16=17,9,0,0,893,32413,0,0,1529,90841,0,0,460,9820,0,0;QS=3,0;MQSB=0.90038;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,149:5:0 0,21,179:7:0 +17 564 . C 0 . DP=27;I16=18,9,0,0,859,28747,0,0,1589,94441,0,0,482,10402,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,121:5:0 0,21,182:7:0 +17 565 . G 0 . DP=30;I16=17,9,0,0,818,26928,0,0,1560,93600,0,0,454,9764,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,96:4:0 0,21,154:7:0 +17 566 . C 0 . DP=29;I16=15,11,0,0,903,33405,0,0,1529,90841,0,0,424,9084,0,0;QS=3,0;MQSB=0.927041;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,155:5:0 0,18,167:6:0 +17 567 . C 0 . DP=30;I16=15,12,0,0,932,33774,0,0,1589,94441,0,0,462,10178,0,0;QS=3,0;MQSB=0.935229;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,155:5:0 0,21,196:7:0 +17 568 . C 0 . DP=29;I16=15,13,0,0,1057,40817,0,0,1649,98041,0,0,482,10438,0,0;QS=3,0;MQSB=0.942064;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,183:6:0 0,18,189:6:0 +17 569 . T 0 . DP=30;I16=16,12,0,0,1056,41296,0,0,1649,98041,0,0,493,10655,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,190:6:0 0,21,213:7:0 +17 570 . T 0 . DP=30;I16=16,12,0,0,954,34972,0,0,1680,100800,0,0,472,10086,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,157:5:0 0,21,195:7:0 +17 571 . C 0 . DP=31;I16=17,12,0,0,1061,40675,0,0,1740,104400,0,0,472,10158,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,155:5:0 0,21,193:7:0 +17 572 . A 0 . DP=31;I16=18,12,0,0,1102,42642,0,0,1769,105241,0,0,499,10887,0,0;QS=3,0;MQSB=0.929991;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,203:7:0 0,18,175:6:0 +17 573 . A 0 . DP=31;I16=18,12,0,0,1057,38473,0,0,1769,105241,0,0,501,10975,0,0;QS=3,0;MQSB=0.929991;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,199:7:0 0,18,178:6:0 +17 574 . C A, 0 . DP=31;I16=18,11,0,1,1088,41328,15,225,1740,104400,29,841,478,10422,25,625;QS=2.94071,0.0592885,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.929991;BQB=1;MQ0F=0 PL:DP:DV 0,48,255,48,255,255:16:0 0,9,170,21,173,177:8:1 0,18,173,18,173,173:6:0 +17 575 . T 0 . DP=30;I16=16,10,0,0,1024,41260,0,0,1560,93600,0,0,448,9842,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,21,209:7:0 0,15,163:5:0 +17 576 . G 0 . DP=30;I16=17,12,0,0,1047,40077,0,0,1709,101641,0,0,507,11087,0,0;QS=3,0;MQSB=0.931617;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,208:8:0 0,15,151:5:0 +17 577 . G 0 . DP=30;I16=16,12,0,0,999,37747,0,0,1649,98041,0,0,489,10755,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,24,204:8:0 0,15,146:5:0 +17 578 . G 0 . DP=29;I16=16,13,0,0,975,34803,0,0,1709,101641,0,0,520,11286,0,0;QS=3,0;MQSB=0.940317;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,198:8:0 0,15,151:5:0 +17 579 . G 0 . DP=30;I16=15,13,0,0,1028,38752,0,0,1649,98041,0,0,484,10514,0,0;QS=3,0;MQSB=0.942064;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,224:8:0 0,12,145:4:0 +17 580 . A C, 0 . DP=30;I16=15,14,1,0,1060,39178,16,256,1709,101641,60,3600,510,11078,17,289;QS=2.97338,0.0266223,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.946202;BQB=1;MQ0F=0 PL:DP:DV 0,34,255,48,255,255:17:1 0,24,221,24,221,221:8:0 0,15,155,15,155,155:5:0 +17 581 . A 0 . DP=31;I16=16,15,0,0,1083,39215,0,0,1829,108841,0,0,530,11384,0,0;QS=3,0;MQSB=0.951229;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,24,223:8:0 0,15,153:5:0 +17 582 . C 0 . DP=31;I16=15,15,0,0,1080,39870,0,0,1769,105241,0,0,519,11211,0,0;QS=3,0;MQSB=0.952765;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,207:8:0 0,15,151:5:0 +17 583 . T 0 . DP=30;I16=16,14,0,0,1136,43996,0,0,1769,105241,0,0,539,11523,0,0;QS=3,0;MQSB=0.946202;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,238:8:0 0,15,163:5:0 +17 584 . C 0 . DP=31;I16=16,13,0,0,1051,39351,0,0,1709,101641,0,0,499,10619,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,207:7:0 0,15,157:5:0 +17 585 . A 0 . DP=31;I16=17,14,0,0,1096,39866,0,0,1798,106082,0,0,549,11751,0,0;QS=3,0;MQSB=0.998229;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,24,211:8:0 0,15,157:5:0 +17 586 . T 0 . DP=31;I16=16,14,0,0,1081,39839,0,0,1738,102482,0,0,546,11796,0,0;QS=3,0;MQSB=0.999136;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,212:8:0 0,15,156:5:0 +17 587 . C 0 . DP=31;I16=17,13,0,0,1070,39402,0,0,1769,105241,0,0,532,11350,0,0;QS=3,0;MQSB=0.963674;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,201:7:0 0,15,155:5:0 +17 588 . A 0 . DP=31;I16=17,14,0,0,1126,41642,0,0,1798,106082,0,0,562,12140,0,0;QS=3,0;MQSB=0.998229;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,24,222:8:0 0,15,164:5:0 +17 589 . A 0 . DP=31;I16=17,14,0,0,1157,43973,0,0,1798,106082,0,0,568,12340,0,0;QS=3,0;MQSB=0.998229;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,24,236:8:0 0,15,165:5:0 +17 590 . C 0 . DP=32;I16=16,14,0,0,1094,41302,0,0,1769,105241,0,0,549,11951,0,0;QS=3,0;MQSB=0.958545;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,192:6:0 0,18,175:6:0 +17 591 . A 0 . DP=31;I16=16,15,0,0,1165,44163,0,0,1798,106082,0,0,579,12695,0,0;QS=3,0;MQSB=0.999805;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,209:7:0 0,18,188:6:0 +17 592 . A 0 . DP=31;I16=15,15,0,0,1114,42144,0,0,1738,102482,0,0,571,12651,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,215:7:0 0,18,182:6:0 +17 593 . C 0 . DP=31;I16=15,14,0,0,1065,39889,0,0,1709,101641,0,0,550,12132,0,0;QS=3,0;MQSB=0.954405;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,191:6:0 0,18,174:6:0 +17 594 . A 0 . DP=33;I16=16,16,0,0,1163,42917,0,0,1858,109682,0,0,572,12672,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,205:7:0 0,24,212:8:0 +17 595 . A 0 . DP=33;I16=17,16,0,0,1130,39996,0,0,1918,113282,0,0,589,12905,0,0;QS=3,0;MQSB=0.999838;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,198:7:0 0,24,213:8:0 +17 596 . A 0 . DP=33;I16=16,16,0,0,1059,37039,0,0,1858,109682,0,0,590,12952,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,169:7:0 0,24,230:8:0 +17 597 . C 0 . DP=33;I16=17,16,0,0,1196,44890,0,0,1918,113282,0,0,592,12990,0,0;QS=3,0;MQSB=0.999838;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,204:7:0 0,24,220:8:0 +17 598 . T 0 . DP=33;I16=16,16,0,0,1214,47104,0,0,1858,109682,0,0,593,13013,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,217:7:0 0,24,239:8:0 +17 599 . T 0 . DP=33;I16=16,17,0,0,1183,43669,0,0,1918,113282,0,0,599,13095,0,0;QS=3,0;MQSB=0.999838;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,197:7:0 0,27,247:9:0 +17 600 . G 0 . DP=32;I16=15,17,0,0,1174,44066,0,0,1858,109682,0,0,601,13145,0,0;QS=3,0;MQSB=0.999287;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,194:7:0 0,24,232:8:0 +17 601 . T 0 . DP=32;I16=15,17,0,0,1114,39954,0,0,1858,109682,0,0,603,13227,0,0;QS=3,0;MQSB=0.999287;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,188:7:0 0,24,235:8:0 +17 602 . G 0 . DP=32;I16=15,15,0,0,1090,40326,0,0,1769,105241,0,0,555,12091,0,0;QS=3,0;MQSB=0.952765;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,185:6:0 0,24,229:8:0 +17 603 . G 0 . DP=31;I16=15,16,0,0,1052,37460,0,0,1798,106082,0,0,607,13437,0,0;QS=3,0;MQSB=0.999805;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,186:7:0 0,24,219:8:0 +17 604 . T 0 . DP=31;I16=14,16,0,0,1009,35893,0,0,1769,105241,0,0,564,12540,0,0;QS=3,0;MQSB=0.958545;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,24,195:8:0 0,21,212:7:0 +17 605 . T 0 . DP=31;I16=12,15,0,0,1001,37741,0,0,1589,94441,0,0,514,11258,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,200:7:0 0,21,214:7:0 +17 606 . T 0 . DP=31;I16=13,16,0,0,992,35202,0,0,1709,101641,0,0,587,13125,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,21,189:7:0 0,24,217:8:0 +17 607 . A 0 . DP=31;I16=14,16,0,0,1027,36129,0,0,1738,102482,0,0,607,13577,0,0;QS=3,0;MQSB=0.999136;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,176:7:0 0,24,222:8:0 +17 608 . C 0 . DP=32;I16=15,15,0,0,983,33775,0,0,1769,105241,0,0,564,12564,0,0;QS=3,0;MQSB=0.952765;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,21,178:7:0 0,27,214:9:0 +17 609 . C 0 . DP=32;I16=14,17,0,0,1074,38220,0,0,1798,106082,0,0,606,13678,0,0;QS=3,0;MQSB=0.998229;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,190:7:0 0,27,238:9:0 +17 610 . C 0 . DP=32;I16=15,16,0,0,1158,44218,0,0,1829,108841,0,0,594,13444,0,0;QS=3,0;MQSB=0.951229;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,211:8:0 0,27,246:9:0 +17 611 . A 0 . DP=32;I16=15,16,0,0,1080,39204,0,0,1798,106082,0,0,590,13260,0,0;QS=3,0;MQSB=0.999805;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,27,220:9:0 0,27,246:9:0 +17 612 . C 0 . DP=33;I16=16,17,0,0,1175,43305,0,0,1918,113282,0,0,617,13993,0,0;QS=3,0;MQSB=0.999838;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,27,214:9:0 0,27,250:9:0 +17 613 . A 0 . DP=34;I16=16,17,0,0,1131,40011,0,0,1949,116041,0,0,604,13874,0,0;QS=3,0;MQSB=0.954207;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,27,223:9:0 0,27,239:9:0 +17 614 . C 0 . DP=34;I16=16,17,0,0,1183,43743,0,0,1949,116041,0,0,608,14022,0,0;QS=3,0;MQSB=0.954207;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,27,223:9:0 0,27,245:9:0 +17 615 . A 0 . DP=34;I16=16,18,0,0,1199,43809,0,0,1978,116882,0,0,626,14394,0,0;QS=3,0;MQSB=0.999405;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,30,240:10:0 0,27,254:9:0 +17 616 . A 0 . DP=34;I16=16,17,0,0,1190,44024,0,0,1949,116041,0,0,615,14351,0,0;QS=3,0;MQSB=0.954207;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,27,247:9:0 0,27,255:9:0 +17 617 . T 0 . DP=33;I16=15,18,0,0,1170,43066,0,0,1918,113282,0,0,630,14624,0,0;QS=3,0;MQSB=0.998531;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,30,241:10:0 0,27,255:9:0 +17 618 . G 0 . DP=34;I16=15,19,0,0,1166,41452,0,0,1978,116882,0,0,632,14706,0,0;QS=3,0;MQSB=0.997597;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,30,248:10:0 0,27,240:9:0 +17 619 . G 0 . DP=32;I16=14,18,0,0,1153,42591,0,0,1858,109682,0,0,638,14816,0,0;QS=3,0;MQSB=0.997118;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,30,254:10:0 0,27,247:9:0 +17 620 . A 0 . DP=32;I16=14,17,0,0,1083,39757,0,0,1798,106082,0,0,616,14176,0,0;QS=3,0;MQSB=0.998229;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,30,248:10:0 0,27,255:9:0 +17 621 . A 0 . DP=32;I16=13,18,0,0,1170,45248,0,0,1798,106082,0,0,627,14519,0,0;QS=3,0;MQSB=0.995005;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,27,255:9:0 0,27,255:9:0 +17 622 . G 0 . DP=32;I16=12,18,0,0,1060,39160,0,0,1769,105241,0,0,604,13888,0,0;QS=3,0;MQSB=0.968257;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,236:9:0 0,27,249:9:0 +17 623 . A T, 0 . DP=32;I16=10,18,1,0,1010,37414,15,225,1649,98041,60,3600,563,12953,25,625;QS=2.96144,0.0385604,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.969907;BQB=1;MQ0F=0 PL:DP:DV 0,20,241,33,244,246:12:1 0,24,213,24,213,213:8:0 0,27,255,27,255,255:9:0 +17 624 . C 0 . DP=32;I16=13,17,0,0,1034,37292,0,0,1738,102482,0,0,607,13887,0,0;QS=3,0;MQSB=0.996503;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,220:9:0 0,27,242:9:0 +17 625 . C 0 . DP=32;I16=13,18,0,0,1108,41138,0,0,1798,106082,0,0,632,14470,0,0;QS=3,0;MQSB=0.995005;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,27,234:9:0 0,27,249:9:0 +17 626 . A 0 . DP=32;I16=13,17,0,0,1090,40718,0,0,1738,102482,0,0,607,13827,0,0;QS=3,0;MQSB=0.996503;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,237:9:0 0,27,247:9:0 +17 627 . C 0 . DP=32;I16=12,18,0,0,1146,44452,0,0,1769,105241,0,0,607,13833,0,0;QS=3,0;MQSB=0.968257;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,244:9:0 0,27,255:9:0 +17 628 . T 0 . DP=32;I16=11,19,0,0,1124,43114,0,0,1769,105241,0,0,608,13862,0,0;QS=3,0;MQSB=0.972375;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,27,249:9:0 0,24,249:8:0 +17 629 . T 0 . DP=32;I16=12,19,0,0,1114,41138,0,0,1798,106082,0,0,634,14490,0,0;QS=3,0;MQSB=0.989977;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,247:9:0 0,24,226:8:0 +17 630 . A 0 . DP=31;I16=11,18,0,0,1101,42885,0,0,1740,104400,0,0,610,13844,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,24,242:8:0 0,24,235:8:0 +17 631 . G 0 . DP=31;I16=12,18,0,0,1083,40525,0,0,1769,105241,0,0,636,14474,0,0;QS=3,0;MQSB=0.929991;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,233:8:0 0,24,223:8:0 +17 632 . C 0 . DP=31;I16=11,18,0,0,1105,42665,0,0,1740,104400,0,0,612,13880,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,24,233:8:0 0,24,224:8:0 +17 633 . A 0 . DP=31;I16=12,18,0,0,1056,38190,0,0,1769,105241,0,0,638,14562,0,0;QS=3,0;MQSB=0.929991;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,218:8:0 0,24,214:8:0 +17 634 . A 0 . DP=31;I16=12,18,0,0,1110,42208,0,0,1769,105241,0,0,638,14594,0,0;QS=3,0;MQSB=0.929991;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,238:8:0 0,24,229:8:0 +17 635 . C 0 . DP=31;I16=11,18,0,0,1031,37871,0,0,1740,104400,0,0,613,14025,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,24,220:8:0 0,24,229:8:0 +17 636 . A 0 . DP=31;I16=11,18,0,0,1115,43327,0,0,1740,104400,0,0,611,14005,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,24,228:8:0 0,24,243:8:0 +17 637 . A 0 . DP=31;I16=12,18,0,0,1152,44602,0,0,1769,105241,0,0,634,14634,0,0;QS=3,0;MQSB=0.929991;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,238:8:0 0,24,242:8:0 +17 638 . A 0 . DP=31;I16=12,18,0,0,1118,42406,0,0,1769,105241,0,0,631,14611,0,0;QS=3,0;MQSB=0.929991;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,235:8:0 0,24,238:8:0 +17 639 . A 0 . DP=30;I16=11,18,0,0,1037,38233,0,0,1709,101641,0,0,602,13934,0,0;QS=3,0;MQSB=0.921439;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,24,230:8:0 0,24,227:8:0 +17 640 . A 0 . DP=31;I16=11,19,0,0,1154,45368,0,0,1769,105241,0,0,596,13804,0,0;QS=3,0;MQSB=0.91982;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,242:8:0 0,24,240:8:0 +17 641 . G 0 . DP=31;I16=11,19,0,0,1018,36496,0,0,1769,105241,0,0,590,13650,0,0;QS=3,0;MQSB=0.91982;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,214:8:0 0,24,218:8:0 +17 642 . G 0 . DP=30;I16=11,19,0,0,1057,38459,0,0,1769,105241,0,0,610,14148,0,0;QS=3,0;MQSB=0.91982;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,187:7:0 0,24,221:8:0 +17 643 . A 0 . DP=29;I16=11,17,0,0,969,35477,0,0,1649,98041,0,0,585,13605,0,0;QS=3,0;MQSB=0.923174;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,199:7:0 0,24,237:8:0 +17 644 . C A, 0 . DP=29;I16=9,18,1,0,898,30864,17,289,1620,97200,60,3600,549,12567,25,625;QS=2.95685,0.0431472,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=1;BQB=1;MQ0F=0 PL:DP:DV 0,22,236,36,239,243:13:1 0,21,195,21,195,195:7:0 0,24,204,24,204,204:8:0 +17 645 . C 0 . DP=30;I16=10,19,0,0,1067,40337,0,0,1709,101641,0,0,584,13274,0,0;QS=3,0;MQSB=0.909373;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,21,198:7:0 0,24,226:8:0 +17 646 . A T, 0 . DP=31;I16=9,20,1,0,1044,38174,14,196,1740,104400,60,3600,553,12499,25,625;QS=2.97113,0.028866,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=1;BQB=1;MQ0F=0 PL:DP:DV 0,27,255,39,255,255:14:1 0,21,197,21,197,197:7:0 0,27,229,27,229,229:9:0 +17 647 . A 0 . DP=33;I16=10,21,0,0,1041,35883,0,0,1829,108841,0,0,573,12999,0,0;QS=3,0;MQSB=0.906252;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,21,189:7:0 0,30,213:10:0 +17 648 . A 0 . DP=33;I16=11,22,0,0,1030,34122,0,0,1949,116041,0,0,594,13478,0,0;QS=3,0;MQSB=0.915545;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,188:7:0 0,30,194:10:0 +17 649 . C 0 . DP=32;I16=10,21,0,0,1099,39879,0,0,1860,111600,0,0,566,12738,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,188:7:0 0,27,217:9:0 +17 650 . T 0 . DP=31;I16=11,18,0,0,1006,37114,0,0,1709,101641,0,0,549,12407,0,0;QS=3,0;MQSB=0.921439;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,187:6:0 0,24,226:8:0 +17 651 . C 0 . DP=32;I16=11,20,0,0,1117,41181,0,0,1829,108841,0,0,581,13107,0,0;QS=3,0;MQSB=0.918304;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,186:6:0 0,27,229:9:0 +17 652 . C 0 . DP=32;I16=9,21,0,0,1126,43084,0,0,1769,105241,0,0,557,12423,0,0;QS=3,0;MQSB=0.893237;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,196:6:0 0,24,213:8:0 +17 653 . T 0 . DP=33;I16=9,23,0,0,1141,42631,0,0,1889,112441,0,0,556,12382,0,0;QS=3,0;MQSB=0.890331;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,198:6:0 0,24,225:8:0 +17 654 . G 0 . DP=33;I16=10,23,0,0,1171,43025,0,0,1949,116041,0,0,578,12798,0,0;QS=3,0;MQSB=0.903508;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,191:6:0 0,24,223:8:0 +17 655 . G 0 . DP=32;I16=10,22,0,0,1118,40202,0,0,1889,112441,0,0,575,12573,0,0;QS=3,0;MQSB=0.904837;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,181:6:0 0,24,213:8:0 +17 656 . T 0 . DP=32;I16=10,22,0,0,1090,38566,0,0,1889,112441,0,0,571,12333,0,0;QS=3,0;MQSB=0.904837;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,185:6:0 0,24,213:8:0 +17 657 . A 0 . DP=32;I16=10,21,0,0,1100,40006,0,0,1829,108841,0,0,557,12029,0,0;QS=3,0;MQSB=0.906252;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,183:6:0 0,24,191:8:0 +17 658 . C 0 . DP=32;I16=10,21,0,0,1115,41039,0,0,1829,108841,0,0,542,11520,0,0;QS=3,0;MQSB=0.906252;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,168:5:0 0,24,211:8:0 +17 659 . A 0 . DP=32;I16=10,21,0,0,1141,42897,0,0,1829,108841,0,0,547,11685,0,0;QS=3,0;MQSB=0.906252;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,191:6:0 0,24,216:8:0 +17 660 . T 0 . DP=33;I16=10,22,0,0,1139,41887,0,0,1889,112441,0,0,553,11659,0,0;QS=3,0;MQSB=0.904837;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,186:6:0 0,24,214:8:0 +17 661 . G 0 . DP=32;I16=9,22,0,0,1107,41531,0,0,1829,108841,0,0,549,11549,0,0;QS=3,0;MQSB=0.891738;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,191:6:0 0,21,188:7:0 +17 662 . C 0 . DP=32;I16=8,22,0,0,1087,40811,0,0,1800,108000,0,0,523,10991,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,192:6:0 0,21,187:7:0 +17 663 . A 0 . DP=32;I16=9,22,0,0,1036,36816,0,0,1829,108841,0,0,540,11388,0,0;QS=3,0;MQSB=0.891738;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,192:6:0 0,21,186:7:0 +17 664 . A 0 . DP=32;I16=9,23,0,0,1125,40759,0,0,1889,112441,0,0,552,11628,0,0;QS=3,0;MQSB=0.890331;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,188:6:0 0,21,184:7:0 +17 665 . C 0 . DP=30;I16=9,21,0,0,1075,39697,0,0,1769,105241,0,0,550,11650,0,0;QS=3,0;MQSB=0.893237;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,186:6:0 0,21,184:7:0 +17 666 . T 0 . DP=29;I16=9,20,0,0,1096,41946,0,0,1709,101641,0,0,547,11607,0,0;QS=3,0;MQSB=0.894839;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,171:5:0 0,21,194:7:0 +17 667 . G 0 . DP=31;I16=11,19,0,0,1037,37627,0,0,1769,105241,0,0,524,11198,0,0;QS=3,0;MQSB=0.91982;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,189:6:0 0,21,188:7:0 +17 668 . A 0 . DP=31;I16=11,20,0,0,1102,39980,0,0,1829,108841,0,0,543,11625,0,0;QS=3,0;MQSB=0.918304;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,190:6:0 0,21,187:7:0 +17 669 . C 0 . DP=30;I16=10,19,0,0,1051,38869,0,0,1740,104400,0,0,528,11464,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,182:6:0 0,21,189:7:0 +17 670 . A 0 . DP=30;I16=11,19,0,0,1121,43423,0,0,1769,105241,0,0,540,11642,0,0;QS=3,0;MQSB=0.91982;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,194:6:0 0,21,205:7:0 +17 671 . G 0 . DP=30;I16=11,19,0,0,1101,41035,0,0,1769,105241,0,0,537,11637,0,0;QS=3,0;MQSB=0.91982;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,181:6:0 0,21,191:7:0 +17 672 . A 0 . DP=30;I16=10,19,0,0,1031,37795,0,0,1740,104400,0,0,521,11479,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,185:6:0 0,21,185:7:0 +17 673 . T 0 . DP=29;I16=8,19,0,0,954,34984,0,0,1589,94441,0,0,497,10885,0,0;QS=3,0;MQSB=0.880529;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,126:4:0 0,21,192:7:0 +17 674 . G 0 . DP=29;I16=10,18,0,0,974,35736,0,0,1649,98041,0,0,497,10827,0,0;QS=3,0;MQSB=0.911099;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,146:5:0 0,21,185:7:0 +17 675 . A 0 . DP=28;I16=9,19,0,0,996,36338,0,0,1649,98041,0,0,517,11389,0,0;QS=3,0;MQSB=0.896555;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,124:4:0 0,21,189:7:0 +17 676 . A 0 . DP=29;I16=8,19,0,0,988,36578,0,0,1589,94441,0,0,462,10106,0,0;QS=3,0;MQSB=0.880529;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,128:4:0 0,21,186:7:0 +17 677 . T 0 . DP=29;I16=9,20,0,0,1006,36126,0,0,1709,101641,0,0,507,11303,0,0;QS=3,0;MQSB=0.894839;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,12,120:4:0 0,21,192:7:0 +17 678 . C 0 . DP=29;I16=9,20,0,0,1020,36984,0,0,1709,101641,0,0,502,11280,0,0;QS=3,0;MQSB=0.894839;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,12,117:4:0 0,21,191:7:0 +17 679 . T 0 . DP=27;I16=6,19,0,0,902,33612,0,0,1469,87241,0,0,460,10414,0,0;QS=3,0;MQSB=0.833024;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,96:3:0 0,21,195:7:0 +17 680 . C 0 . DP=26;I16=7,18,0,0,879,32295,0,0,1469,87241,0,0,468,10482,0,0;QS=3,0;MQSB=0.862128;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,98:3:0 0,21,181:7:0 +17 681 . A 0 . DP=27;I16=7,17,0,0,844,30190,0,0,1409,83641,0,0,465,10425,0,0;QS=3,0;MQSB=0.864405;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,106:3:0 0,21,174:7:0 +17 682 . A 0 . DP=27;I16=7,20,0,0,919,32179,0,0,1589,94441,0,0,500,11096,0,0;QS=3,0;MQSB=0.858077;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,145:5:0 0,21,176:7:0 +17 683 . A 0 . DP=29;I16=8,21,0,0,949,32735,0,0,1709,101641,0,0,499,11103,0,0;QS=3,0;MQSB=0.876998;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,172:6:0 0,21,167:7:0 +17 684 . C 0 . DP=29;I16=6,21,0,0,802,24468,0,0,1589,94441,0,0,473,10459,0,0;QS=3,0;MQSB=0.829029;MQ0F=0 PL:DP:DV 0,45,251:15:0 0,15,118:5:0 0,21,145:7:0 +17 685 . G 0 . DP=28;I16=6,21,0,0,908,32092,0,0,1620,97200,0,0,498,11090,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,130:5:0 0,21,175:7:0 +17 686 . C 0 . DP=28;I16=7,21,0,0,977,35493,0,0,1680,100800,0,0,500,11080,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,170:6:0 0,21,180:7:0 +17 687 . A 0 . DP=28;I16=6,20,0,0,900,31952,0,0,1560,93600,0,0,475,10469,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,175:6:0 0,21,174:7:0 +17 688 . T 0 . DP=27;I16=6,21,0,0,937,33971,0,0,1620,97200,0,0,501,11135,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,153:6:0 0,21,187:7:0 +17 689 . T A, 0 . DP=27;I16=5,20,1,0,829,28967,13,169,1500,90000,60,3600,463,10359,25,625;QS=2.97105,0.0289532,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=1;BQB=1;MQ0F=0 PL:DP:DV 0,28,231,39,234,234:14:1 0,15,116,15,116,116:5:0 0,21,185,21,185,185:7:0 +17 690 . C 0 . DP=27;I16=6,20,0,0,935,34553,0,0,1560,93600,0,0,486,10974,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,146:5:0 0,21,165:7:0 +17 691 . C 0 . DP=26;I16=5,18,0,0,842,31906,0,0,1380,82800,0,0,446,10166,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,129:4:0 0,18,161:6:0 +17 692 . T 0 . DP=26;I16=6,19,0,0,886,32434,0,0,1500,90000,0,0,486,11082,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,146:5:0 0,18,164:6:0 +17 693 . C 0 . DP=27;I16=6,20,0,0,891,31839,0,0,1560,93600,0,0,483,11007,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,141:5:0 0,21,172:7:0 +17 694 . C 0 . DP=27;I16=6,21,0,0,808,25004,0,0,1620,97200,0,0,498,11248,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,242:14:0 0,18,136:6:0 0,21,146:7:0 +17 695 . G 0 . DP=25;I16=4,20,0,0,807,28037,0,0,1440,86400,0,0,476,10692,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,246:13:0 0,18,145:6:0 0,15,124:5:0 +17 696 . T 0 . DP=25;I16=5,20,0,0,896,32870,0,0,1500,90000,0,0,499,11129,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,150:6:0 0,15,141:5:0 +17 697 . G 0 . DP=26;I16=5,19,0,0,852,30594,0,0,1409,83641,0,0,450,9858,0,0;QS=3,0;MQSB=0.796124;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,142:5:0 0,15,120:5:0 +17 698 . T 0 . DP=27;I16=6,20,0,0,917,33201,0,0,1529,90841,0,0,502,11114,0,0;QS=3,0;MQSB=0.83095;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,154:6:0 0,15,131:5:0 +17 699 . G 0 . DP=28;I16=5,21,0,0,923,34103,0,0,1529,90841,0,0,498,10884,0,0;QS=3,0;MQSB=0.79189;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,163:6:0 0,15,132:5:0 +17 700 . A 0 . DP=28;I16=6,22,0,0,989,35833,0,0,1618,95282,0,0,530,11626,0,0;QS=3,0;MQSB=0.904554;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,169:7:0 0,18,148:6:0 +17 701 . A 0 . DP=29;I16=5,23,0,0,992,35956,0,0,1618,95282,0,0,517,11459,0,0;QS=3,0;MQSB=0.864394;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,186:7:0 0,18,144:6:0 +17 702 . A 0 . DP=29;I16=5,23,0,0,1103,44105,0,0,1618,95282,0,0,520,11508,0,0;QS=3,0;MQSB=0.864394;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,204:7:0 0,18,159:6:0 +17 703 . G 0 . DP=29;I16=5,23,0,0,1014,37508,0,0,1618,95282,0,0,522,11534,0,0;QS=3,0;MQSB=0.864394;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,172:7:0 0,18,144:6:0 +17 704 . A T, 0 . DP=29;I16=4,23,1,0,954,34200,16,256,1558,91682,60,3600,499,10963,13,169;QS=2.97064,0.0293578,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.864394;BQB=1;MQ0F=0 PL:DP:DV 0,31,255,45,255,255:16:1 0,18,154,18,154,154:6:0 0,18,139,18,139,139:6:0 +17 705 . A 0 . DP=29;I16=6,22,0,0,1042,39930,0,0,1618,95282,0,0,513,11189,0,0;QS=3,0;MQSB=0.904554;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,189:7:0 0,18,157:6:0 +17 706 . G 0 . DP=30;I16=6,23,0,0,1029,37763,0,0,1678,98882,0,0,513,11225,0,0;QS=3,0;MQSB=0.900586;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,170:7:0 0,18,131:6:0 +17 707 . C 0 . DP=30;I16=5,22,0,0,944,34494,0,0,1558,91682,0,0,464,10040,0,0;QS=3,0;MQSB=0.868709;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,131:5:0 0,18,134:6:0 +17 708 . C 0 . DP=30;I16=6,24,0,0,898,27574,0,0,1738,102482,0,0,540,12010,0,0;QS=3,0;MQSB=0.896846;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,153:8:0 0,18,110:6:0 +17 709 . G 0 . DP=29;I16=5,22,0,0,968,36130,0,0,1558,91682,0,0,507,11343,0,0;QS=3,0;MQSB=0.868709;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,178:8:0 0,15,132:5:0 +17 710 . G 0 . DP=29;I16=5,23,0,0,961,34825,0,0,1618,95282,0,0,533,12029,0,0;QS=3,0;MQSB=0.864394;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,24,174:8:0 0,15,122:5:0 +17 711 . A 0 . DP=29;I16=6,23,0,0,996,35700,0,0,1647,96123,0,0,565,12723,0,0;QS=3,0;MQSB=0.957107;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,171:7:0 0,18,142:6:0 +17 712 . C 0 . DP=29;I16=6,23,0,0,1069,40863,0,0,1647,96123,0,0,565,12767,0,0;QS=3,0;MQSB=0.957107;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,156:7:0 0,18,146:6:0 +17 713 . T 0 . DP=29;I16=6,23,0,0,1072,40426,0,0,1647,96123,0,0,565,12835,0,0;QS=3,0;MQSB=0.957107;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,187:7:0 0,18,149:6:0 +17 714 . C 0 . DP=28;I16=6,21,0,0,988,37236,0,0,1558,91682,0,0,541,12301,0,0;QS=3,0;MQSB=0.90877;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,153:6:0 0,15,125:5:0 +17 715 . A 0 . DP=28;I16=6,20,0,0,884,31414,0,0,1498,88082,0,0,522,12004,0,0;QS=3,0;MQSB=0.913254;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,138:6:0 0,15,120:5:0 +17 716 . C 0 . DP=29;I16=4,23,0,0,998,37756,0,0,1527,88923,0,0,547,12501,0,0;QS=3,0;MQSB=0.877203;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,141:5:0 0,18,145:6:0 +17 717 . A 0 . DP=31;I16=8,23,0,0,1136,42928,0,0,1767,103323,0,0,574,13254,0,0;QS=3,0;MQSB=0.987595;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,212:8:0 0,18,153:6:0 +17 718 . G 0 . DP=29;I16=7,22,0,0,1066,40006,0,0,1647,96123,0,0,579,13407,0,0;QS=3,0;MQSB=0.979435;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,24,223:8:0 0,18,139:6:0 +17 719 . G 0 . DP=29;I16=7,19,0,0,952,35868,0,0,1529,90841,0,0,510,11756,0,0;QS=3,0;MQSB=0.860025;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,204:8:0 0,12,120:4:0 +17 720 . G 0 . DP=28;I16=6,20,0,0,986,37838,0,0,1467,85323,0,0,552,12940,0,0;QS=3,0;MQSB=0.970805;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,216:8:0 0,18,147:6:0 +17 721 . C 0 . DP=28;I16=6,21,0,0,989,36901,0,0,1527,88923,0,0,567,13183,0,0;QS=3,0;MQSB=0.966147;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,24,197:8:0 0,18,147:6:0 +17 722 . A 0 . DP=28;I16=6,21,0,0,949,33837,0,0,1527,88923,0,0,569,13225,0,0;QS=3,0;MQSB=0.966147;MQ0F=0 PL:DP:DV 0,39,244:13:0 0,24,205:8:0 0,18,143:6:0 +17 723 . A 0 . DP=28;I16=6,19,0,0,925,34825,0,0,1438,84482,0,0,530,12366,0,0;QS=3,0;MQSB=0.918029;MQ0F=0 PL:DP:DV 0,36,253:12:0 0,24,206:8:0 0,15,135:5:0 +17 724 . C 0 . DP=28;I16=5,22,0,0,967,35983,0,0,1527,88923,0,0,566,13028,0,0;QS=3,0;MQSB=0.932273;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,21,161:7:0 0,18,140:6:0 +17 725 . A 0 . DP=28;I16=6,21,0,0,911,31971,0,0,1527,88923,0,0,565,12987,0,0;QS=3,0;MQSB=0.966147;MQ0F=0 PL:DP:DV 0,42,246:14:0 0,21,168:7:0 0,18,137:6:0 +17 726 . C 0 . DP=28;I16=6,21,0,0,947,34531,0,0,1527,88923,0,0,563,12919,0,0;QS=3,0;MQSB=0.966147;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,21,166:7:0 0,18,136:6:0 +17 727 . A C, 0 . DP=28;I16=6,20,0,1,904,32194,17,289,1498,88082,29,841,535,12199,25,625;QS=2.90811,0.0918919,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.966147;BQB=1;MQ0F=0 PL:DP:DV 0,42,247,42,247,247:14:0 0,21,191,21,191,191:7:0 0,1,109,15,112,119:6:1 +17 728 . C 0 . DP=29;I16=6,22,0,0,1018,37990,0,0,1587,92523,0,0,557,12701,0,0;QS=3,0;MQSB=0.961573;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,208:8:0 0,18,142:6:0 +17 729 . T 0 . DP=29;I16=7,22,0,0,1063,39315,0,0,1647,96123,0,0,581,13227,0,0;QS=3,0;MQSB=0.979435;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,244:9:0 0,18,142:6:0 +17 730 . A 0 . DP=29;I16=7,21,0,0,993,35883,0,0,1618,95282,0,0,555,12529,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,219:9:0 0,15,135:5:0 +17 731 . T 0 . DP=29;I16=7,22,0,0,1024,37312,0,0,1647,96123,0,0,578,13058,0,0;QS=3,0;MQSB=0.979435;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,210:9:0 0,18,148:6:0 +17 732 . C 0 . DP=29;I16=7,21,0,0,1006,37058,0,0,1618,95282,0,0,550,12314,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,219:9:0 0,15,129:5:0 +17 733 . T 0 . DP=29;I16=7,21,0,0,985,35497,0,0,1618,95282,0,0,547,12221,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,222:9:0 0,15,134:5:0 +17 734 . G 0 . DP=29;I16=7,21,0,0,997,36453,0,0,1587,92523,0,0,544,12154,0,0;QS=3,0;MQSB=0.982906;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,204:8:0 0,18,139:6:0 +17 735 . A 0 . DP=30;I16=7,21,0,0,963,33993,0,0,1618,95282,0,0,515,11437,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,190:8:0 0,18,148:6:0 +17 736 . C 0 . DP=30;I16=8,20,0,0,1042,39326,0,0,1618,95282,0,0,512,11320,0,0;QS=3,0;MQSB=0.954515;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,218:8:0 0,18,152:6:0 +17 737 . T 0 . DP=30;I16=8,22,0,0,1071,39825,0,0,1707,99723,0,0,560,12480,0,0;QS=3,0;MQSB=0.990151;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,243:9:0 0,21,149:7:0 +17 738 . G 0 . DP=30;I16=8,21,0,0,1016,36816,0,0,1678,98882,0,0,533,11793,0,0;QS=3,0;MQSB=0.950946;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,210:9:0 0,18,141:6:0 +17 739 . T 0 . DP=30;I16=7,22,0,0,1020,37326,0,0,1647,96123,0,0,534,11900,0,0;QS=3,0;MQSB=0.979435;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,202:8:0 0,21,155:7:0 +17 740 . T 0 . DP=29;I16=7,21,0,0,1011,37465,0,0,1587,92523,0,0,532,11848,0,0;QS=3,0;MQSB=0.982906;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,24,232:8:0 0,21,155:7:0 +17 741 . T 0 . DP=29;I16=7,21,0,0,984,36052,0,0,1587,92523,0,0,528,11722,0,0;QS=3,0;MQSB=0.982906;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,24,224:8:0 0,21,151:7:0 +17 742 . C 0 . DP=30;I16=8,21,0,0,1046,39056,0,0,1678,98882,0,0,525,11671,0,0;QS=3,0;MQSB=0.950946;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,243:9:0 0,18,136:6:0 +17 743 . A 0 . DP=30;I16=8,21,0,0,1026,37156,0,0,1678,98882,0,0,520,11500,0,0;QS=3,0;MQSB=0.950946;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,239:9:0 0,18,131:6:0 +17 744 . T 0 . DP=30;I16=8,22,0,0,1100,41010,0,0,1707,99723,0,0,540,11984,0,0;QS=3,0;MQSB=0.990151;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,247:9:0 0,21,154:7:0 +17 745 . G 0 . DP=31;I16=9,22,0,0,1078,38890,0,0,1767,103323,0,0,535,11873,0,0;QS=3,0;MQSB=0.996219;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,227:9:0 0,24,178:8:0 +17 746 . G 0 . DP=31;I16=9,21,0,0,1001,35191,0,0,1707,99723,0,0,531,11793,0,0;QS=3,0;MQSB=0.997698;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,27,201:9:0 0,24,178:8:0 +17 747 . G 0 . DP=30;I16=9,20,0,0,1017,36831,0,0,1647,96123,0,0,509,11343,0,0;QS=3,0;MQSB=0.99889;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,201:8:0 0,21,174:7:0 +17 748 . A 0 . DP=30;I16=10,20,0,0,1046,37438,0,0,1707,99723,0,0,529,11721,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,27,242:9:0 0,18,159:6:0 +17 749 . A 0 . DP=31;I16=10,21,0,0,1077,38303,0,0,1767,103323,0,0,530,11728,0,0;QS=3,0;MQSB=0.999777;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,27,240:9:0 0,18,164:6:0 +17 750 . A 0 . DP=32;I16=10,20,0,0,1129,43093,0,0,1738,102482,0,0,500,11252,0,0;QS=3,0;MQSB=0.976097;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,232:8:0 0,15,161:5:0 +17 751 . G 0 . DP=31;I16=11,20,0,0,1065,37955,0,0,1767,103323,0,0,535,11787,0,0;QS=3,0;MQSB=0.999148;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,27,206:9:0 0,18,150:6:0 +17 752 . T 0 . DP=31;I16=11,20,0,0,1034,35786,0,0,1767,103323,0,0,537,11793,0,0;QS=3,0;MQSB=0.999148;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,27,223:9:0 0,18,143:6:0 +17 753 . C 0 . DP=31;I16=12,19,0,0,1073,38779,0,0,1767,103323,0,0,540,11834,0,0;QS=3,0;MQSB=0.994873;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,30,227:10:0 0,18,158:6:0 +17 754 . T 0 . DP=31;I16=12,19,0,0,1135,42527,0,0,1767,103323,0,0,542,11808,0,0;QS=3,0;MQSB=0.994873;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,30,255:10:0 0,18,172:6:0 +17 755 . G 0 . DP=31;I16=12,19,0,0,1157,43695,0,0,1767,103323,0,0,544,11814,0,0;QS=3,0;MQSB=0.994873;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,30,255:10:0 0,18,162:6:0 +17 756 . G 0 . DP=30;I16=12,17,0,0,1002,35566,0,0,1647,96123,0,0,539,11753,0,0;QS=3,0;MQSB=0.988062;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,30,242:10:0 0,18,157:6:0 +17 757 . A 0 . DP=30;I16=12,17,0,0,1035,37723,0,0,1678,98882,0,0,523,11197,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,30,248:10:0 0,15,152:5:0 +17 758 . A 0 . DP=30;I16=12,18,0,0,1015,35685,0,0,1707,99723,0,0,549,11825,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,30,247:10:0 0,18,156:6:0 +17 759 . A 0 . DP=30;I16=12,16,0,0,998,36498,0,0,1618,95282,0,0,526,11472,0,0;QS=3,0;MQSB=0.995699;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,242:9:0 0,15,151:5:0 +17 760 . C 0 . DP=31;I16=12,18,0,0,916,29466,0,0,1707,99723,0,0,547,11741,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,30,217:10:0 0,18,128:6:0 +17 761 . G 0 . DP=30;I16=11,16,0,0,932,32884,0,0,1589,94441,0,0,512,11028,0,0;QS=3,0;MQSB=0.925036;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,27,220:9:0 0,15,153:5:0 +17 762 . G 0 . DP=29;I16=11,18,0,0,1012,36984,0,0,1647,96123,0,0,541,11629,0,0;QS=3,0;MQSB=0.995968;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,27,220:9:0 0,21,173:7:0 +17 763 . C A, 0 . DP=29;I16=11,16,0,1,948,35124,15,225,1558,91682,29,841,527,11473,2,4;QS=2.93697,0.0630252,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.993109;BQB=1;MQ0F=0 PL:DP:DV 0,39,255,39,255,255:13:0 0,24,193,24,193,193:8:0 0,6,158,18,161,165:7:1 +17 764 . A 0 . DP=31;I16=12,18,0,0,1051,37737,0,0,1738,102482,0,0,516,11020,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,30,250:10:0 0,18,163:6:0 +17 765 . A 0 . DP=32;I16=12,18,0,0,1071,39369,0,0,1738,102482,0,0,525,11379,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,30,254:10:0 0,18,169:6:0 +17 766 . C 0 . DP=31;I16=13,18,0,0,1065,38285,0,0,1798,106082,0,0,547,11797,0,0;QS=3,0;MQSB=0.995005;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,33,235:11:0 0,18,164:6:0 +17 767 . A 0 . DP=30;I16=12,18,0,0,996,34692,0,0,1738,102482,0,0,552,11926,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,33,244:11:0 0,18,148:6:0 +17 768 . C 0 . DP=30;I16=12,18,0,0,1095,40739,0,0,1738,102482,0,0,556,12038,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,33,255:11:0 0,18,173:6:0 +17 769 . C 0 . DP=30;I16=12,18,0,0,1110,42272,0,0,1738,102482,0,0,559,12133,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,33,255:11:0 0,18,173:6:0 +17 770 . A 0 . DP=30;I16=12,18,0,0,1098,40852,0,0,1738,102482,0,0,562,12262,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,33,255:11:0 0,18,171:6:0 +17 771 . T 0 . DP=30;I16=12,18,0,0,1111,41771,0,0,1738,102482,0,0,563,12325,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,33,255:11:0 0,18,177:6:0 +17 772 . T 0 . DP=30;I16=12,18,0,0,1107,41429,0,0,1738,102482,0,0,563,12373,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,33,255:11:0 0,18,176:6:0 +17 773 . G 0 . DP=30;I16=12,18,0,0,1123,42761,0,0,1738,102482,0,0,562,12406,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,33,255:11:0 0,18,175:6:0 +17 774 . A 0 . DP=30;I16=12,18,0,0,1151,44801,0,0,1738,102482,0,0,560,12422,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,33,255:11:0 0,18,179:6:0 +17 775 . G 0 . DP=30;I16=12,18,0,0,1136,43766,0,0,1738,102482,0,0,557,12419,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,33,255:11:0 0,18,177:6:0 +17 776 . A 0 . DP=29;I16=12,17,0,0,1053,38865,0,0,1678,98882,0,0,553,12345,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,30,255:10:0 0,18,169:6:0 +17 777 . C 0 . DP=28;I16=12,16,0,0,1019,37631,0,0,1618,95282,0,0,550,12298,0,0;QS=3,0;MQSB=0.995699;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,27,229:9:0 0,18,165:6:0 +17 778 . A 0 . DP=28;I16=12,16,0,0,1079,42041,0,0,1618,95282,0,0,547,12277,0,0;QS=3,0;MQSB=0.995699;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,27,241:9:0 0,18,181:6:0 +17 779 . G 0 . DP=28;I16=12,16,0,0,1025,38825,0,0,1618,95282,0,0,543,12231,0,0;QS=3,0;MQSB=0.995699;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,27,231:9:0 0,18,170:6:0 +17 780 . A 0 . DP=28;I16=12,16,0,0,1005,36773,0,0,1618,95282,0,0,538,12160,0,0;QS=3,0;MQSB=0.995699;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,27,242:9:0 0,18,166:6:0 +17 781 . A 0 . DP=28;I16=12,15,0,0,965,35857,0,0,1589,94441,0,0,519,11889,0,0;QS=3,0;MQSB=0.935229;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,222:8:0 0,15,159:5:0 +17 782 . A 0 . DP=28;I16=12,16,0,0,1003,37315,0,0,1618,95282,0,0,530,12044,0,0;QS=3,0;MQSB=0.995699;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,229:8:0 0,18,171:6:0 +17 783 . A 0 . DP=28;I16=12,16,0,0,989,36477,0,0,1618,95282,0,0,527,12001,0,0;QS=3,0;MQSB=0.995699;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,24,230:8:0 0,21,178:7:0 +17 784 . C 0 . DP=26;I16=11,15,0,0,967,36387,0,0,1498,88082,0,0,527,11983,0,0;QS=3,0;MQSB=0.994627;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,207:7:0 0,21,178:7:0 +17 785 . A 0 . DP=26;I16=11,15,0,0,989,38499,0,0,1498,88082,0,0,527,11989,0,0;QS=3,0;MQSB=0.994627;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,213:7:0 0,21,187:7:0 +17 786 . G 0 . DP=26;I16=11,14,0,0,938,35698,0,0,1438,84482,0,0,501,11343,0,0;QS=3,0;MQSB=0.996634;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,211:7:0 0,21,180:7:0 +17 787 . G 0 . DP=26;I16=11,15,0,0,914,33428,0,0,1498,88082,0,0,525,11969,0,0;QS=3,0;MQSB=0.994627;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,189:7:0 0,21,175:7:0 +17 788 . T 0 . DP=26;I16=11,15,0,0,913,33357,0,0,1498,88082,0,0,524,11992,0,0;QS=3,0;MQSB=0.994627;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,180:7:0 0,21,188:7:0 +17 789 . G 0 . DP=26;I16=11,15,0,0,963,36645,0,0,1498,88082,0,0,523,12037,0,0;QS=3,0;MQSB=0.994627;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,193:7:0 0,21,183:7:0 +17 790 . A 0 . DP=26;I16=11,15,0,0,999,39113,0,0,1498,88082,0,0,520,12002,0,0;QS=3,0;MQSB=0.994627;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,198:7:0 0,21,201:7:0 +17 791 . G 0 . DP=26;I16=11,15,0,0,934,34208,0,0,1498,88082,0,0,516,11934,0,0;QS=3,0;MQSB=0.994627;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,180:7:0 0,21,172:7:0 +17 792 . T 0 . DP=26;I16=11,15,0,0,895,32009,0,0,1498,88082,0,0,511,11833,0,0;QS=3,0;MQSB=0.994627;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,184:7:0 0,21,172:7:0 +17 793 . G 0 . DP=27;I16=11,15,0,0,965,36389,0,0,1498,88082,0,0,504,11652,0,0;QS=3,0;MQSB=0.994627;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,193:7:0 0,21,170:7:0 +17 794 . G 0 . DP=26;I16=11,15,0,0,888,31804,0,0,1498,88082,0,0,508,11592,0,0;QS=3,0;MQSB=0.994627;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,198:8:0 0,18,161:6:0 +17 795 . T 0 . DP=26;I16=9,15,0,0,859,31399,0,0,1409,83641,0,0,472,10908,0,0;QS=3,0;MQSB=0.96464;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,211:7:0 0,18,160:6:0 +17 796 . T 0 . DP=27;I16=11,16,0,0,907,31641,0,0,1558,91682,0,0,499,11375,0,0;QS=3,0;MQSB=0.992419;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,27,221:9:0 0,15,150:5:0 +17 797 . G 0 . DP=26;I16=11,15,0,0,882,31700,0,0,1529,90841,0,0,498,11298,0,0;QS=3,0;MQSB=0.927041;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,27,215:9:0 0,12,135:4:0 +17 798 . C 0 . DP=26;I16=9,15,0,0,806,28552,0,0,1440,86400,0,0,466,10582,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,207:8:0 0,12,126:4:0 +17 799 . C 0 . DP=26;I16=10,15,0,0,947,36407,0,0,1500,90000,0,0,491,11185,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,234:9:0 0,12,137:4:0 +17 800 . T 0 . DP=26;I16=11,15,0,0,993,38475,0,0,1529,90841,0,0,495,11199,0,0;QS=3,0;MQSB=0.927041;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,27,255:9:0 0,12,139:4:0 +17 801 . G 0 . DP=25;I16=11,14,0,0,938,35854,0,0,1469,87241,0,0,495,11209,0,0;QS=3,0;MQSB=0.929204;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,240:9:0 0,12,145:4:0 +17 802 . G 0 . DP=25;I16=11,14,0,0,892,32802,0,0,1469,87241,0,0,495,11239,0,0;QS=3,0;MQSB=0.929204;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,229:9:0 0,12,137:4:0 +17 803 . G 0 . DP=25;I16=11,14,0,0,906,33502,0,0,1469,87241,0,0,495,11289,0,0;QS=3,0;MQSB=0.929204;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,237:9:0 0,12,136:4:0 +17 804 . G 0 . DP=25;I16=11,12,0,0,868,33326,0,0,1349,80041,0,0,466,10846,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,223:8:0 0,12,138:4:0 +17 805 . C 0 . DP=24;I16=9,14,0,0,810,29684,0,0,1380,82800,0,0,482,11208,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,220:8:0 0,12,128:4:0 +17 806 . C 0 . DP=25;I16=9,14,0,0,814,29856,0,0,1380,82800,0,0,483,11293,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,214:8:0 0,12,122:4:0 +17 807 . A 0 . DP=25;I16=10,15,0,0,939,35997,0,0,1500,90000,0,0,503,11525,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,242:9:0 0,12,146:4:0 +17 808 . G 0 . DP=25;I16=10,15,0,0,918,34720,0,0,1500,90000,0,0,505,11591,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,238:9:0 0,12,136:4:0 +17 809 . G 0 . DP=25;I16=10,15,0,0,926,34932,0,0,1500,90000,0,0,506,11626,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,226:9:0 0,12,136:4:0 +17 810 . G C, 0 . DP=25;I16=10,13,0,1,824,30436,14,196,1380,82800,60,3600,480,11288,14,196;QS=2.96552,0.0344828,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=1;BQB=1;MQ0F=0 PL:DP:DV 0,21,255,33,255,255:12:1 0,24,216,24,216,216:8:0 0,12,132,12,132,132:4:0 +17 811 . A 0 . DP=25;I16=9,14,0,0,808,29404,0,0,1380,82800,0,0,484,11294,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,204:7:0 0,12,139:4:0 +17 812 . A 0 . DP=25;I16=10,15,0,0,831,29515,0,0,1500,90000,0,0,500,11392,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,216:9:0 0,12,139:4:0 +17 813 . C 0 . DP=25;I16=10,15,0,0,915,34093,0,0,1500,90000,0,0,497,11307,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,239:9:0 0,12,138:4:0 +17 814 . T 0 . DP=25;I16=10,15,0,0,987,39343,0,0,1500,90000,0,0,494,11244,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,255:9:0 0,12,148:4:0 +17 815 . T 0 . DP=25;I16=10,15,0,0,894,32670,0,0,1500,90000,0,0,491,11203,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,235:9:0 0,12,143:4:0 +17 816 . T 0 . DP=25;I16=10,15,0,0,898,32990,0,0,1500,90000,0,0,488,11184,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,239:9:0 0,12,136:4:0 +17 817 . C 0 . DP=24;I16=10,14,0,0,898,34256,0,0,1440,86400,0,0,485,11137,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,235:9:0 0,12,124:4:0 +17 818 . T 0 . DP=23;I16=9,14,0,0,883,34371,0,0,1380,82800,0,0,484,11110,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,225:8:0 0,12,143:4:0 +17 819 . G 0 . DP=23;I16=9,13,0,0,832,31932,0,0,1320,79200,0,0,461,10573,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,24,217:8:0 0,12,142:4:0 +17 820 . G 0 . DP=24;I16=10,14,0,0,844,30848,0,0,1440,86400,0,0,484,11114,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,230:9:0 0,12,135:4:0 +17 821 . G 0 . DP=24;I16=10,14,0,0,852,31572,0,0,1440,86400,0,0,484,11098,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,234:9:0 0,12,142:4:0 +17 822 . G 0 . DP=25;I16=10,15,0,0,879,31785,0,0,1500,90000,0,0,481,10955,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,220:9:0 0,12,127:4:0 +17 823 . T 0 . DP=25;I16=10,15,0,0,844,29686,0,0,1500,90000,0,0,478,10786,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,217:9:0 0,12,127:4:0 +17 824 . C 0 . DP=25;I16=9,14,0,0,824,30252,0,0,1380,82800,0,0,427,9477,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,215:9:0 0,9,98:3:0 +17 825 . A 0 . DP=25;I16=10,15,0,0,881,31665,0,0,1500,90000,0,0,467,10277,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,234:9:0 0,12,116:4:0 +17 826 . T 0 . DP=25;I16=10,15,0,0,826,28364,0,0,1500,90000,0,0,461,10039,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,250:12:0 0,27,232:9:0 0,12,117:4:0 +17 827 . A 0 . DP=25;I16=10,15,0,0,851,29477,0,0,1500,90000,0,0,455,9829,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,227:9:0 0,12,123:4:0 +17 828 . T C, 0 . DP=25;I16=2,4,8,11,199,6917,656,23340,360,21600,1140,68400,116,2716,333,6931;QS=0.597777,2.40222,0;VDB=0.842082;SGB=-4.20907;RPB=0.950652;MQB=1;MQSB=1;BQB=0.929717;MQ0F=0 PL:DP:DV 211,0,35,217,65,255:12:10 116,0,91,128,106,213:9:5 120,12,0,120,12,120:4:4 +17 829 . T 0 . DP=24;I16=10,13,0,0,863,32931,0,0,1380,82800,0,0,418,8818,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,242:8:0 0,12,132:4:0 +17 830 . C 0 . DP=24;I16=10,14,0,0,910,34966,0,0,1440,86400,0,0,437,9267,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,220:8:0 0,12,134:4:0 +17 831 . T 0 . DP=24;I16=10,14,0,0,906,34886,0,0,1440,86400,0,0,431,9119,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,243:8:0 0,12,133:4:0 +17 832 . C 0 . DP=24;I16=10,14,0,0,888,33634,0,0,1440,86400,0,0,425,8999,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,220:8:0 0,12,123:4:0 +17 833 . T 0 . DP=25;I16=10,14,0,0,820,29920,0,0,1440,86400,0,0,418,8856,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,224:8:0 0,12,113:4:0 +17 834 . G A, 0 . DP=25;I16=2,3,7,10,164,5898,590,21124,300,18000,1020,61200,104,2296,305,6441;QS=0.520056,2.47994,0;VDB=0.788006;SGB=-4.01214;RPB=0.999233;MQB=1;MQSB=1;BQB=0.821668;MQ0F=0 PL:DP:DV 185,0,46,191,73,246:11:9 128,0,59,137,74,193:8:5 89,9,0,89,9,89:3:3 +17 835 . T 0 . DP=26;I16=9,15,0,0,767,26675,0,0,1440,86400,0,0,406,8652,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,240:12:0 0,24,213:8:0 0,12,98:4:0 +17 836 . G 0 . DP=23;I16=8,15,0,0,833,30561,0,0,1380,82800,0,0,403,8541,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,243:11:0 0,24,214:8:0 0,12,130:4:0 +17 837 . T 0 . DP=23;I16=8,15,0,0,843,31499,0,0,1380,82800,0,0,400,8456,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,241:11:0 0,24,221:8:0 0,12,143:4:0 +17 838 . T 0 . DP=23;I16=8,15,0,0,870,33172,0,0,1380,82800,0,0,397,8397,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,252:11:0 0,24,224:8:0 0,12,134:4:0 +17 839 . G 0 . DP=24;I16=8,15,0,0,862,32774,0,0,1380,82800,0,0,393,8315,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,249:11:0 0,24,212:8:0 0,12,142:4:0 +17 840 . A 0 . DP=25;I16=9,15,0,0,876,32682,0,0,1440,86400,0,0,375,7731,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,243:11:0 0,21,196:7:0 0,18,180:6:0 +17 841 . T 0 . DP=25;I16=9,16,0,0,861,30879,0,0,1500,90000,0,0,396,8260,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,213:11:0 0,24,226:8:0 0,18,185:6:0 +17 842 . T 0 . DP=24;I16=9,15,0,0,872,31990,0,0,1440,86400,0,0,393,8199,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,227:10:0 0,24,231:8:0 0,18,175:6:0 +17 843 . C 0 . DP=24;I16=9,15,0,0,844,30604,0,0,1440,86400,0,0,390,8172,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,228:10:0 0,24,229:8:0 0,18,160:6:0 +17 844 . T 0 . DP=24;I16=9,15,0,0,900,34094,0,0,1440,86400,0,0,386,8128,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,227:10:0 0,24,238:8:0 0,18,189:6:0 +17 845 . G 0 . DP=25;I16=10,15,0,0,916,33866,0,0,1500,90000,0,0,382,8116,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,239:10:0 0,24,225:8:0 0,21,196:7:0 +17 846 . G 0 . DP=24;I16=9,14,0,0,802,28414,0,0,1380,82800,0,0,354,7460,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,223:9:0 0,24,208:8:0 0,18,164:6:0 +17 847 . T 0 . DP=24;I16=8,15,0,0,809,29007,0,0,1380,82800,0,0,377,8083,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,210:9:0 0,24,219:8:0 0,18,149:6:0 +17 848 . G 0 . DP=23;I16=8,15,0,0,829,30351,0,0,1380,82800,0,0,384,8138,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,199:8:0 0,27,243:9:0 0,18,167:6:0 +17 849 . G 0 . DP=22;I16=8,12,0,0,684,23844,0,0,1200,72000,0,0,349,7517,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,160:6:0 0,27,233:9:0 0,15,140:5:0 +17 850 . T 0 . DP=21;I16=6,14,0,0,706,25508,0,0,1200,72000,0,0,360,7568,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,153:6:0 0,24,226:8:0 0,18,147:6:0 +17 851 . G 0 . DP=21;I16=7,14,0,0,707,24667,0,0,1260,75600,0,0,386,8254,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,140:6:0 0,27,233:9:0 0,18,156:6:0 +17 852 . G 0 . DP=21;I16=7,13,0,0,687,24223,0,0,1200,72000,0,0,368,7976,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,147:6:0 0,27,222:9:0 0,15,146:5:0 +17 853 . A 0 . DP=21;I16=7,14,0,0,721,25603,0,0,1260,75600,0,0,388,8442,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,146:6:0 0,27,223:9:0 0,18,166:6:0 +17 854 . A 0 . DP=21;I16=7,14,0,0,725,25843,0,0,1260,75600,0,0,389,8517,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,179:7:0 0,24,209:8:0 0,18,168:6:0 +17 855 . A 0 . DP=21;I16=7,14,0,0,683,23803,0,0,1260,75600,0,0,391,8611,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,171:7:0 0,24,204:8:0 0,18,152:6:0 +17 856 . C 0 . DP=21;I16=7,14,0,0,763,28293,0,0,1260,75600,0,0,392,8676,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,192:7:0 0,24,222:8:0 0,18,172:6:0 +17 857 . A 0 . DP=22;I16=8,14,0,0,786,28480,0,0,1320,79200,0,0,393,8763,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,182:7:0 0,24,220:8:0 0,21,194:7:0 +17 858 . A 0 . DP=22;I16=8,14,0,0,816,31358,0,0,1320,79200,0,0,395,8873,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,192:7:0 0,24,236:8:0 0,21,198:7:0 +17 859 . G 0 . DP=22;I16=8,14,0,0,824,31356,0,0,1320,79200,0,0,395,8907,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,202:7:0 0,24,223:8:0 0,21,203:7:0 +17 860 . A 0 . DP=22;I16=8,13,0,0,743,26985,0,0,1260,75600,0,0,369,8291,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,184:7:0 0,21,202:7:0 0,21,190:7:0 +17 861 . C 0 . DP=22;I16=8,14,0,0,770,28376,0,0,1320,79200,0,0,393,8899,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,206:8:0 0,24,216:8:0 0,18,161:6:0 +17 862 . T 0 . DP=22;I16=8,14,0,0,762,27500,0,0,1320,79200,0,0,393,8905,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,188:8:0 0,24,213:8:0 0,18,177:6:0 +17 863 . G 0 . DP=23;I16=9,14,0,0,836,30660,0,0,1380,82800,0,0,393,8935,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,228:9:0 0,24,221:8:0 0,18,180:6:0 +17 864 . T 0 . DP=22;I16=9,13,0,0,795,29085,0,0,1320,79200,0,0,395,8989,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,215:8:0 0,24,221:8:0 0,18,180:6:0 +17 865 . C 0 . DP=22;I16=8,14,0,0,785,28475,0,0,1320,79200,0,0,397,9015,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,227:9:0 0,21,193:7:0 0,18,177:6:0 +17 866 . C 0 . DP=21;I16=7,13,0,0,694,24890,0,0,1200,72000,0,0,395,8985,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,220:8:0 0,18,149:6:0 0,18,177:6:0 +17 867 . C 0 . DP=21;I16=7,14,0,0,761,28443,0,0,1260,75600,0,0,403,9023,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,223:9:0 0,18,182:6:0 0,18,187:6:0 +17 868 . A 0 . DP=21;I16=7,14,0,0,799,31183,0,0,1260,75600,0,0,406,9054,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,228:9:0 0,18,189:6:0 0,18,202:6:0 +17 869 . G 0 . DP=21;I16=7,14,0,0,795,30733,0,0,1260,75600,0,0,409,9103,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,236:9:0 0,18,190:6:0 0,18,187:6:0 +17 870 . C 0 . DP=21;I16=7,13,0,0,758,29080,0,0,1200,72000,0,0,403,9089,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,226:8:0 0,18,183:6:0 0,18,187:6:0 +17 871 . C 0 . DP=21;I16=7,14,0,0,769,29383,0,0,1260,75600,0,0,413,9155,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,232:9:0 0,18,176:6:0 0,18,192:6:0 +17 872 . T 0 . DP=21;I16=7,14,0,0,785,29879,0,0,1260,75600,0,0,413,9109,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,228:9:0 0,18,187:6:0 0,18,188:6:0 +17 873 . G 0 . DP=21;I16=7,14,0,0,768,28506,0,0,1260,75600,0,0,413,9083,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,233:9:0 0,18,172:6:0 0,18,182:6:0 +17 874 . G 0 . DP=21;I16=7,12,0,0,700,26434,0,0,1140,68400,0,0,374,8234,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,227:8:0 0,15,143:5:0 0,18,189:6:0 +17 875 . G 0 . DP=21;I16=7,14,0,0,717,25659,0,0,1260,75600,0,0,411,8995,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,227:9:0 0,18,163:6:0 0,18,159:6:0 +17 876 . T 0 . DP=21;I16=7,14,0,0,719,25261,0,0,1260,75600,0,0,410,8984,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,222:9:0 0,18,156:6:0 0,18,173:6:0 +17 877 . G 0 . DP=21;I16=7,14,0,0,747,27419,0,0,1260,75600,0,0,409,8995,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,235:9:0 0,18,162:6:0 0,18,176:6:0 +17 878 . A 0 . DP=21;I16=7,13,0,0,738,27650,0,0,1200,72000,0,0,391,8739,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,216:8:0 0,18,172:6:0 0,18,191:6:0 +17 879 . T 0 . DP=21;I16=7,13,0,0,731,26927,0,0,1200,72000,0,0,389,8759,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,214:8:0 0,18,175:6:0 0,18,184:6:0 +17 880 . A 0 . DP=21;I16=7,14,0,0,737,26481,0,0,1260,75600,0,0,405,9109,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,227:9:0 0,18,165:6:0 0,18,172:6:0 +17 881 . C 0 . DP=20;I16=7,13,0,0,742,27898,0,0,1200,72000,0,0,404,9154,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,231:8:0 0,18,164:6:0 0,18,183:6:0 +17 882 . A 0 . DP=20;I16=7,13,0,0,776,30564,0,0,1200,72000,0,0,403,9217,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,225:8:0 0,18,188:6:0 0,18,200:6:0 +17 883 . G 0 . DP=20;I16=7,13,0,0,702,25898,0,0,1200,72000,0,0,401,9247,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,214:8:0 0,18,175:6:0 0,18,176:6:0 +17 884 . C 0 . DP=19;I16=7,12,0,0,629,21449,0,0,1140,68400,0,0,400,9292,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,201:8:0 0,18,155:6:0 0,15,144:5:0 +17 885 . G 0 . DP=18;I16=7,11,0,0,605,20851,0,0,1080,64800,0,0,400,9350,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,215:8:0 0,15,140:5:0 0,15,130:5:0 +17 886 . A 0 . DP=18;I16=7,11,0,0,681,26145,0,0,1080,64800,0,0,400,9420,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,222:8:0 0,15,164:5:0 0,15,163:5:0 +17 887 . G 0 . DP=18;I16=7,11,0,0,631,22891,0,0,1080,64800,0,0,399,9451,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,222:8:0 0,15,138:5:0 0,15,149:5:0 +17 888 . A 0 . DP=18;I16=7,10,0,0,593,21563,0,0,1020,61200,0,0,373,8867,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,216:8:0 0,15,132:5:0 0,12,127:4:0 +17 889 . C 0 . DP=18;I16=7,11,0,0,624,22732,0,0,1080,64800,0,0,396,9492,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,213:8:0 0,15,134:5:0 0,15,160:5:0 +17 890 . C 0 . DP=19;I16=7,11,0,0,616,22426,0,0,1080,64800,0,0,368,8826,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,215:8:0 0,15,138:5:0 0,15,152:5:0 +17 891 . C 0 . DP=19;I16=7,11,0,0,661,24891,0,0,1080,64800,0,0,365,8745,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,227:8:0 0,15,141:5:0 0,15,165:5:0 +17 892 . C 0 . DP=19;I16=7,12,0,0,691,25761,0,0,1140,68400,0,0,387,9299,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,230:9:0 0,15,146:5:0 0,15,167:5:0 +17 893 . A 0 . DP=19;I16=7,12,0,0,673,24521,0,0,1140,68400,0,0,384,9238,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,221:9:0 0,15,142:5:0 0,15,166:5:0 +17 894 . T 0 . DP=19;I16=7,12,0,0,670,24268,0,0,1140,68400,0,0,380,9138,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,225:9:0 0,15,134:5:0 0,15,165:5:0 +17 895 . C 0 . DP=20;I16=8,12,0,0,712,26186,0,0,1200,72000,0,0,376,9050,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,248:10:0 0,15,149:5:0 0,15,162:5:0 +17 896 . T 0 . DP=19;I16=8,10,0,0,684,26696,0,0,1080,64800,0,0,348,8300,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,238:9:0 0,12,141:4:0 0,15,180:5:0 +17 897 . C 0 . DP=18;I16=8,10,0,0,693,27001,0,0,1080,64800,0,0,370,8764,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,12,131:4:0 0,15,166:5:0 +17 898 . T 0 . DP=18;I16=8,10,0,0,674,25656,0,0,1080,64800,0,0,367,8617,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,243:9:0 0,12,125:4:0 0,15,172:5:0 +17 899 . A 0 . DP=18;I16=9,8,0,0,597,21451,0,0,1020,61200,0,0,340,7858,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,239:9:0 0,9,99:3:0 0,15,145:5:0 +17 900 . C 0 . DP=18;I16=9,9,0,0,658,24550,0,0,1080,64800,0,0,364,8362,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,98:3:0 0,15,166:5:0 +17 901 . C 0 . DP=18;I16=9,9,0,0,680,26004,0,0,1080,64800,0,0,363,8255,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,99:3:0 0,15,169:5:0 +17 902 . A 0 . DP=18;I16=9,9,0,0,681,26253,0,0,1080,64800,0,0,362,8162,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,253:10:0 0,9,115:3:0 0,15,174:5:0 +17 903 . A 0 . DP=18;I16=9,8,0,0,645,24625,0,0,1020,61200,0,0,336,7458,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,250:9:0 0,9,101:3:0 0,15,171:5:0 +17 904 . A 0 . DP=18;I16=9,9,0,0,640,23412,0,0,1080,64800,0,0,359,7969,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,249:10:0 0,9,85:3:0 0,15,174:5:0 +17 905 . A 0 . DP=18;I16=9,9,0,0,675,25673,0,0,1080,64800,0,0,357,7871,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,103:3:0 0,15,172:5:0 +17 906 . A 0 . DP=18;I16=9,9,0,0,669,25193,0,0,1080,64800,0,0,355,7789,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,102:3:0 0,15,166:5:0 +17 907 . A 0 . DP=18;I16=9,9,0,0,661,24541,0,0,1080,64800,0,0,353,7723,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,94:3:0 0,15,165:5:0 +17 908 . T 0 . DP=18;I16=9,9,0,0,673,25579,0,0,1080,64800,0,0,351,7673,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,83:3:0 0,15,168:5:0 +17 909 . T 0 . DP=18;I16=9,9,0,0,653,23847,0,0,1080,64800,0,0,348,7590,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,95:3:0 0,15,161:5:0 +17 910 . A 0 . DP=18;I16=9,9,0,0,652,23790,0,0,1080,64800,0,0,344,7476,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,248:10:0 0,9,104:3:0 0,15,162:5:0 +17 911 . A 0 . DP=18;I16=9,9,0,0,688,26440,0,0,1080,64800,0,0,340,7382,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,109:3:0 0,15,168:5:0 +17 912 . A 0 . DP=18;I16=9,9,0,0,691,26705,0,0,1080,64800,0,0,336,7308,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,115:3:0 0,15,173:5:0 +17 913 . A 0 . DP=19;I16=9,10,0,0,692,25762,0,0,1140,68400,0,0,332,7254,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,109:3:0 0,15,171:5:0 +17 914 . A 0 . DP=19;I16=9,10,0,0,712,26966,0,0,1140,68400,0,0,329,7221,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,109:3:0 0,15,164:5:0 +17 915 . T 0 . DP=18;I16=9,9,0,0,638,23228,0,0,1080,64800,0,0,326,7160,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,247:10:0 0,9,99:3:0 0,15,163:5:0 +17 916 . T 0 . DP=19;I16=9,8,0,0,626,23136,0,0,1020,61200,0,0,296,6396,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,241:9:0 0,9,103:3:0 0,15,164:5:0 +17 917 . A 0 . DP=19;I16=9,10,0,0,726,27962,0,0,1117,66169,0,0,318,6908,0,0;QS=3,0;MQSB=0.934728;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,125:4:0 0,15,171:5:0 +17 918 . G 0 . DP=19;I16=9,10,0,0,688,25456,0,0,1117,66169,0,0,314,6818,0,0;QS=3,0;MQSB=0.934728;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,129:4:0 0,15,147:5:0 +17 919 . C 0 . DP=18;I16=8,10,0,0,672,25786,0,0,1057,62569,0,0,311,6751,0,0;QS=3,0;MQSB=0.938795;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,92:3:0 0,15,152:5:0 +17 920 . T 0 . DP=18;I16=8,10,0,0,681,26113,0,0,1057,62569,0,0,308,6706,0,0;QS=3,0;MQSB=0.938795;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,95:3:0 0,15,171:5:0 +17 921 . G 0 . DP=17;I16=7,10,0,0,617,22841,0,0,997,58969,0,0,304,6582,0,0;QS=3,0;MQSB=0.943335;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,6,47:2:0 0,15,164:5:0 +17 922 . G 0 . DP=16;I16=7,8,0,0,560,21156,0,0,877,51769,0,0,276,5852,0,0;QS=3,0;MQSB=0.921243;MQ0F=0 PL:DP:DV 0,24,243:8:0 0,6,64:2:0 0,15,151:5:0 +17 923 . G 0 . DP=16;I16=7,8,0,0,562,21350,0,0,877,51769,0,0,273,5765,0,0;QS=3,0;MQSB=0.921243;MQ0F=0 PL:DP:DV 0,24,245:8:0 0,6,65:2:0 0,15,144:5:0 +17 924 . C 0 . DP=16;I16=7,9,0,0,603,22955,0,0,937,55369,0,0,295,6321,0,0;QS=3,0;MQSB=0.933674;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,6,57:2:0 0,15,157:5:0 +17 925 . A 0 . DP=16;I16=7,9,0,0,576,21618,0,0,937,55369,0,0,291,6219,0,0;QS=3,0;MQSB=0.933674;MQ0F=0 PL:DP:DV 0,27,244:9:0 0,6,58:2:0 0,15,163:5:0 +17 926 . T 0 . DP=16;I16=7,9,0,0,585,22015,0,0,937,55369,0,0,287,6133,0,0;QS=3,0;MQSB=0.933674;MQ0F=0 PL:DP:DV 0,27,241:9:0 0,6,63:2:0 0,15,161:5:0 +17 927 . G 0 . DP=17;I16=7,10,0,0,641,24481,0,0,997,58969,0,0,283,6063,0,0;QS=3,0;MQSB=0.943335;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,9,82:3:0 0,15,158:5:0 +17 928 . G 0 . DP=17;I16=7,10,0,0,625,23195,0,0,997,58969,0,0,280,6010,0,0;QS=3,0;MQSB=0.943335;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,9,84:3:0 0,15,150:5:0 +17 929 . T 0 . DP=16;I16=7,9,0,0,580,21580,0,0,937,55369,0,0,277,5925,0,0;QS=3,0;MQSB=0.933674;MQ0F=0 PL:DP:DV 0,27,248:9:0 0,9,79:3:0 0,12,128:4:0 +17 930 . G 0 . DP=16;I16=7,8,0,0,565,21561,0,0,877,51769,0,0,249,5233,0,0;QS=3,0;MQSB=0.921243;MQ0F=0 PL:DP:DV 0,24,247:8:0 0,9,82:3:0 0,12,127:4:0 +17 931 . G 0 . DP=16;I16=7,9,0,0,553,19935,0,0,937,55369,0,0,271,5809,0,0;QS=3,0;MQSB=0.933674;MQ0F=0 PL:DP:DV 0,27,244:9:0 0,9,80:3:0 0,12,113:4:0 +17 932 . T 0 . DP=16;I16=7,9,0,0,558,20128,0,0,937,55369,0,0,268,5778,0,0;QS=3,0;MQSB=0.933674;MQ0F=0 PL:DP:DV 0,27,229:9:0 0,9,89:3:0 0,12,122:4:0 +17 933 . G 0 . DP=16;I16=7,8,0,0,558,20926,0,0,877,51769,0,0,239,5091,0,0;QS=3,0;MQSB=0.921243;MQ0F=0 PL:DP:DV 0,24,241:8:0 0,9,94:3:0 0,12,116:4:0 +17 934 . C 0 . DP=15;I16=7,8,0,0,548,20256,0,0,877,51769,0,0,261,5673,0,0;QS=3,0;MQSB=0.921243;MQ0F=0 PL:DP:DV 0,27,244:9:0 0,9,83:3:0 0,9,99:3:0 +17 935 . A 0 . DP=15;I16=7,8,0,0,534,19780,0,0,846,49010,0,0,259,5647,0,0;QS=3,0;MQSB=0.720273;MQ0F=0 PL:DP:DV 0,27,233:9:0 0,9,86:3:0 0,9,101:3:0 +17 936 . T 0 . DP=15;I16=7,8,0,0,579,22499,0,0,846,49010,0,0,257,5589,0,0;QS=3,0;MQSB=0.720273;MQ0F=0 PL:DP:DV 0,27,252:9:0 0,9,91:3:0 0,9,100:3:0 +17 937 . G 0 . DP=16;I16=8,7,0,0,550,20650,0,0,846,49010,0,0,232,5022,0,0;QS=3,0;MQSB=0.651439;MQ0F=0 PL:DP:DV 0,24,228:8:0 0,9,84:3:0 0,12,115:4:0 +17 938 . C 0 . DP=16;I16=8,7,0,0,553,20669,0,0,846,49010,0,0,231,5001,0,0;QS=3,0;MQSB=0.651439;MQ0F=0 PL:DP:DV 0,24,234:8:0 0,9,77:3:0 0,12,119:4:0 +17 939 . C 0 . DP=16;I16=8,8,0,0,582,22100,0,0,906,52610,0,0,250,5392,0,0;QS=3,0;MQSB=0.702619;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,9,71:3:0 0,12,115:4:0 +17 940 . T 0 . DP=15;I16=8,7,0,0,583,23339,0,0,846,49010,0,0,248,5320,0,0;QS=3,0;MQSB=0.651439;MQ0F=0 PL:DP:DV 0,27,252:9:0 0,6,71:2:0 0,12,124:4:0 +17 941 . G 0 . DP=14;I16=7,7,0,0,501,18707,0,0,786,45410,0,0,246,5216,0,0;QS=3,0;MQSB=0.714506;MQ0F=0 PL:DP:DV 0,27,240:9:0 0,6,59:2:0 0,9,93:3:0 +17 942 . T 0 . DP=14;I16=7,7,0,0,525,19799,0,0,786,45410,0,0,244,5128,0,0;QS=3,0;MQSB=0.714506;MQ0F=0 PL:DP:DV 0,27,237:9:0 0,6,70:2:0 0,9,94:3:0 +17 943 . A 0 . DP=14;I16=7,7,0,0,545,21399,0,0,786,45410,0,0,242,5056,0,0;QS=3,0;MQSB=0.714506;MQ0F=0 PL:DP:DV 0,27,248:9:0 0,6,71:2:0 0,9,93:3:0 +17 944 . G 0 . DP=14;I16=7,7,0,0,529,20143,0,0,786,45410,0,0,240,5000,0,0;QS=3,0;MQSB=0.714506;MQ0F=0 PL:DP:DV 0,27,249:9:0 0,6,65:2:0 0,9,95:3:0 +17 945 . T 0 . DP=14;I16=7,7,0,0,523,19621,0,0,786,45410,0,0,238,4960,0,0;QS=3,0;MQSB=0.714506;MQ0F=0 PL:DP:DV 0,27,239:9:0 0,6,70:2:0 0,9,95:3:0 +17 946 . C 0 . DP=13;I16=6,6,0,0,455,17581,0,0,666,38210,0,0,223,4739,0,0;QS=3,0;MQSB=0.660716;MQ0F=0 PL:DP:DV 0,24,240:8:0 0,6,56:2:0 0,6,70:2:0 +17 947 . C 0 . DP=14;I16=7,7,0,0,509,19007,0,0,755,42651,0,0,238,4928,0,0;QS=3,0;MQSB=0.925999;MQ0F=0 PL:DP:DV 0,27,251:9:0 0,9,83:3:0 0,6,66:2:0 +17 948 . C 0 . DP=14;I16=7,7,0,0,520,20050,0,0,755,42651,0,0,237,4887,0,0;QS=3,0;MQSB=0.925999;MQ0F=0 PL:DP:DV 0,27,254:9:0 0,9,78:3:0 0,6,69:2:0 +17 949 . A 0 . DP=15;I16=7,8,0,0,547,20705,0,0,815,46251,0,0,236,4864,0,0;QS=3,0;MQSB=0.959011;MQ0F=0 PL:DP:DV 0,30,250:10:0 0,9,90:3:0 0,6,72:2:0 +17 950 . G 0 . DP=15;I16=6,8,0,0,563,22871,0,0,786,45410,0,0,231,4835,0,0;QS=3,0;MQSB=0.740818;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,6,71:2:0 0,6,72:2:0 +17 951 . C 0 . DP=16;I16=7,8,0,0,554,21080,0,0,846,49010,0,0,230,4840,0,0;QS=3,0;MQSB=0.720273;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,65:2:0 0,6,73:2:0 +17 952 . T 0 . DP=16;I16=8,8,0,0,595,22565,0,0,875,49851,0,0,237,4913,0,0;QS=3,0;MQSB=0.934676;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,93:3:0 0,6,73:2:0 +17 953 . A 0 . DP=16;I16=8,8,0,0,567,20515,0,0,875,49851,0,0,237,4921,0,0;QS=3,0;MQSB=0.934676;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,91:3:0 0,6,69:2:0 +17 954 . T 0 . DP=15;I16=7,8,0,0,544,20412,0,0,815,46251,0,0,238,4948,0,0;QS=3,0;MQSB=0.959011;MQ0F=0 PL:DP:DV 0,30,249:10:0 0,9,94:3:0 0,6,69:2:0 +17 955 . T 0 . DP=15;I16=7,8,0,0,543,19953,0,0,815,46251,0,0,239,4993,0,0;QS=3,0;MQSB=0.959011;MQ0F=0 PL:DP:DV 0,30,246:10:0 0,9,95:3:0 0,6,68:2:0 +17 956 . C 0 . DP=15;I16=6,8,0,0,543,21255,0,0,786,45410,0,0,229,4935,0,0;QS=3,0;MQSB=0.740818;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,6,62:2:0 0,6,70:2:0 +17 957 . A 0 . DP=15;I16=7,8,0,0,504,17684,0,0,815,46251,0,0,241,5137,0,0;QS=3,0;MQSB=0.959011;MQ0F=0 PL:DP:DV 0,30,240:10:0 0,9,74:3:0 0,6,67:2:0 +17 958 . C 0 . DP=14;I16=6,8,0,0,505,18981,0,0,755,42651,0,0,243,5235,0,0;QS=3,0;MQSB=0.981425;MQ0F=0 PL:DP:DV 0,30,253:10:0 0,9,78:3:0 0,3,39:1:0 +17 959 . A 0 . DP=14;I16=5,8,0,0,519,20885,0,0,726,41810,0,0,231,5153,0,0;QS=3,0;MQSB=0.765017;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,6,72:2:0 0,3,38:1:0 +17 960 . G 0 . DP=15;I16=6,9,0,0,539,19901,0,0,815,46251,0,0,247,5479,0,0;QS=3,0;MQSB=0.99308;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,106:4:0 0,3,41:1:0 +17 961 . T 0 . DP=14;I16=6,8,0,0,523,19835,0,0,755,42651,0,0,250,5574,0,0;QS=3,0;MQSB=0.981425;MQ0F=0 PL:DP:DV 0,27,248:9:0 0,12,114:4:0 0,3,39:1:0 +17 962 . G 0 . DP=14;I16=5,8,0,0,498,19194,0,0,726,41810,0,0,236,5394,0,0;QS=3,0;MQSB=0.765017;MQ0F=0 PL:DP:DV 0,27,253:9:0 0,9,91:3:0 0,3,36:1:0 +17 963 . C 0 . DP=13;I16=5,8,0,0,500,19610,0,0,695,39051,0,0,256,5754,0,0;QS=3,0;MQSB=0.997325;MQ0F=0 PL:DP:DV 0,24,234:8:0 0,12,118:4:0 0,3,40:1:0 +17 964 . T 0 . DP=13;I16=5,8,0,0,512,20430,0,0,695,39051,0,0,259,5835,0,0;QS=3,0;MQSB=0.997325;MQ0F=0 PL:DP:DV 0,24,227:8:0 0,12,128:4:0 0,3,42:1:0 +17 965 . G 0 . DP=13;I16=4,8,0,0,467,18429,0,0,666,38210,0,0,241,5477,0,0;QS=3,0;MQSB=0.793923;MQ0F=0 PL:DP:DV 0,24,228:8:0 0,9,93:3:0 0,3,40:1:0 +17 966 . A 0 . DP=13;I16=4,8,0,0,443,16785,0,0,666,38210,0,0,242,5490,0,0;QS=3,0;MQSB=0.793923;MQ0F=0 PL:DP:DV 0,24,212:8:0 0,9,95:3:0 0,3,40:1:0 +17 967 . G 0 . DP=13;I16=4,8,0,0,464,18036,0,0,666,38210,0,0,243,5513,0,0;QS=3,0;MQSB=0.793923;MQ0F=0 PL:DP:DV 0,24,230:8:0 0,9,91:3:0 0,3,41:1:0 +17 968 . G 0 . DP=13;I16=4,8,0,0,441,16549,0,0,666,38210,0,0,244,5546,0,0;QS=3,0;MQSB=0.793923;MQ0F=0 PL:DP:DV 0,24,218:8:0 0,9,87:3:0 0,3,42:1:0 +17 969 . T 0 . DP=13;I16=4,8,0,0,450,16970,0,0,666,38210,0,0,245,5589,0,0;QS=3,0;MQSB=0.793923;MQ0F=0 PL:DP:DV 0,24,220:8:0 0,9,98:3:0 0,3,31:1:0 +17 970 . G 0 . DP=13;I16=4,7,0,0,413,15579,0,0,629,36841,0,0,220,4968,0,0;QS=3,0;MQSB=0.924449;MQ0F=0 PL:DP:DV 0,24,221:8:0 0,6,71:2:0 0,3,33:1:0 +17 971 . G 0 . DP=13;I16=4,8,0,0,459,17711,0,0,666,38210,0,0,245,5609,0,0;QS=3,0;MQSB=0.793923;MQ0F=0 PL:DP:DV 0,24,223:8:0 0,9,93:3:0 0,3,38:1:0 +17 972 . G 0 . DP=13;I16=4,8,0,0,446,17192,0,0,666,38210,0,0,245,5637,0,0;QS=3,0;MQSB=0.793923;MQ0F=0 PL:DP:DV 0,24,210:8:0 0,9,96:3:0 0,3,39:1:0 +17 973 . A 0 . DP=12;I16=4,7,0,0,402,15018,0,0,606,34610,0,0,246,5676,0,0;QS=3,0;MQSB=0.763675;MQ0F=0 PL:DP:DV 0,21,192:7:0 0,9,89:3:0 0,3,42:1:0 +17 974 . A 0 . DP=12;I16=4,7,0,0,417,16273,0,0,606,34610,0,0,247,5725,0,0;QS=3,0;MQSB=0.763675;MQ0F=0 PL:DP:DV 0,21,198:7:0 0,9,96:3:0 0,3,42:1:0 +17 975 . G 0 . DP=13;I16=4,8,0,0,454,17560,0,0,666,38210,0,0,247,5733,0,0;QS=3,0;MQSB=0.793923;MQ0F=0 PL:DP:DV 0,24,213:8:0 0,9,95:3:0 0,3,42:1:0 +17 976 . A 0 . DP=13;I16=4,8,0,0,431,16083,0,0,666,38210,0,0,248,5750,0,0;QS=3,0;MQSB=0.793923;MQ0F=0 PL:DP:DV 0,24,227:8:0 0,9,70:3:0 0,3,41:1:0 +17 977 . T 0 . DP=13;I16=4,8,0,0,438,16316,0,0,666,38210,0,0,248,5726,0,0;QS=3,0;MQSB=0.793923;MQ0F=0 PL:DP:DV 0,24,210:8:0 0,9,93:3:0 0,3,37:1:0 +17 978 . G 0 . DP=12;I16=4,8,0,0,430,16060,0,0,666,38210,0,0,248,5710,0,0;QS=3,0;MQSB=0.793923;MQ0F=0 PL:DP:DV 0,24,224:8:0 0,9,75:3:0 0,3,40:1:0 +17 979 . C 0 . DP=13;I16=4,8,0,0,453,17461,0,0,689,40441,0,0,223,5077,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,27,232:9:0 0,6,72:2:0 0,3,41:1:0 +17 980 . T 0 . DP=13;I16=4,8,0,0,438,16412,0,0,689,40441,0,0,224,5078,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,27,220:9:0 0,6,76:2:0 0,3,43:1:0 +17 981 . T 0 . DP=13;I16=4,9,0,0,484,18602,0,0,726,41810,0,0,250,5714,0,0;QS=3,0;MQSB=0.826565;MQ0F=0 PL:DP:DV 0,27,224:9:0 0,9,97:3:0 0,3,41:1:0 +17 982 . G 0 . DP=14;I16=4,10,0,0,520,20128,0,0,786,45410,0,0,250,5686,0,0;QS=3,0;MQSB=0.852144;MQ0F=0 PL:DP:DV 0,30,237:10:0 0,9,99:3:0 0,3,40:1:0 +17 983 . A 0 . DP=14;I16=4,10,0,0,570,23360,0,0,786,45410,0,0,251,5671,0,0;QS=3,0;MQSB=0.852144;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,101:3:0 0,3,42:1:0 +17 984 . G 0 . DP=15;I16=4,10,0,0,529,20459,0,0,786,45410,0,0,252,5670,0,0;QS=3,0;MQSB=0.852144;MQ0F=0 PL:DP:DV 0,30,253:10:0 0,9,88:3:0 0,3,43:1:0 +17 985 . C 0 . DP=17;I16=4,13,0,0,580,20280,0,0,966,56210,0,0,261,5747,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,33,246:11:0 0,12,100:4:0 0,6,65:2:0 +17 986 . C A, 0 . DP=17;I16=3,12,0,1,519,18353,13,169,846,49010,60,3600,235,5101,4,16;QS=2.95873,0.0412698,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.921781;BQB=1;MQ0F=0 PL:DP:DV 0,16,197,27,200,201:10:1 0,12,108,12,108,108:4:0 0,6,69,6,69,69:2:0 +17 987 . C 0 . DP=17;I16=4,13,0,0,634,23914,0,0,966,56210,0,0,267,5755,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,107:4:0 0,6,69:2:0 +17 988 . A 0 . DP=17;I16=4,13,0,0,633,24341,0,0,966,56210,0,0,269,5737,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,111:4:0 0,6,82:2:0 +17 989 . G 0 . DP=17;I16=4,13,0,0,635,24149,0,0,966,56210,0,0,271,5739,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,114:4:0 0,6,80:2:0 +17 990 . G 0 . DP=16;I16=4,12,0,0,591,22177,0,0,906,52610,0,0,274,5760,0,0;QS=3,0;MQSB=0.88901;MQ0F=0 PL:DP:DV 0,30,246:10:0 0,12,105:4:0 0,6,83:2:0 +17 991 . A 0 . DP=16;I16=3,11,0,0,548,21542,0,0,809,47641,0,0,227,4549,0,0;QS=3,0;MQSB=0.973096;MQ0F=0 PL:DP:DV 0,27,232:9:0 0,9,100:3:0 0,6,80:2:0 +17 992 . G 0 . DP=16;I16=4,12,0,0,562,20436,0,0,906,52610,0,0,278,5760,0,0;QS=3,0;MQSB=0.88901;MQ0F=0 PL:DP:DV 0,30,240:10:0 0,12,102:4:0 0,6,76:2:0 +17 993 . T 0 . DP=16;I16=4,12,0,0,564,20752,0,0,906,52610,0,0,280,5790,0,0;QS=3,0;MQSB=0.88901;MQ0F=0 PL:DP:DV 0,30,222:10:0 0,12,121:4:0 0,6,73:2:0 +17 994 . T 0 . DP=17;I16=5,11,0,0,597,22625,0,0,906,52610,0,0,270,5696,0,0;QS=3,0;MQSB=0.851779;MQ0F=0 PL:DP:DV 0,27,227:9:0 0,12,123:4:0 0,9,103:3:0 +17 995 . C 0 . DP=16;I16=4,11,0,0,588,23228,0,0,846,49010,0,0,273,5741,0,0;QS=3,0;MQSB=0.872525;MQ0F=0 PL:DP:DV 0,24,216:8:0 0,12,119:4:0 0,9,110:3:0 +17 996 . A 0 . DP=16;I16=4,12,0,0,562,20416,0,0,906,52610,0,0,290,6000,0,0;QS=3,0;MQSB=0.88901;MQ0F=0 PL:DP:DV 0,27,207:9:0 0,12,107:4:0 0,9,113:3:0 +17 997 . A 0 . DP=16;I16=4,12,0,0,600,23520,0,0,906,52610,0,0,294,6110,0,0;QS=3,0;MQSB=0.88901;MQ0F=0 PL:DP:DV 0,27,209:9:0 0,12,123:4:0 0,9,121:3:0 +17 998 . G 0 . DP=17;I16=4,13,0,0,603,22299,0,0,966,56210,0,0,298,6240,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,30,226:10:0 0,12,99:4:0 0,9,115:3:0 +17 999 . G 0 . DP=17;I16=4,12,0,0,575,21519,0,0,906,52610,0,0,302,6390,0,0;QS=3,0;MQSB=0.88901;MQ0F=0 PL:DP:DV 0,27,202:9:0 0,12,118:4:0 0,9,111:3:0 +17 1000 . C 0 . DP=17;I16=4,13,0,0,637,24465,0,0,966,56210,0,0,308,6564,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,30,235:10:0 0,12,118:4:0 0,9,109:3:0 +17 1001 . T 0 . DP=17;I16=4,13,0,0,647,24907,0,0,966,56210,0,0,312,6708,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,30,228:10:0 0,12,120:4:0 0,9,122:3:0 +17 1002 . G 0 . DP=17;I16=4,13,0,0,627,23691,0,0,966,56210,0,0,316,6872,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,30,220:10:0 0,12,123:4:0 0,9,109:3:0 +17 1003 . C T, 0 . DP=18;I16=4,13,0,1,633,23953,22,484,966,56210,60,3600,297,6515,21,441;QS=2.9375,0.0625,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.913725;BQB=1;MQ0F=0 PL:DP:DV 0,8,207,27,211,220:10:1 0,15,132,15,132,132:5:0 0,9,102,9,102,102:3:0 +17 1004 . A 0 . DP=19;I16=5,14,0,0,653,23107,0,0,1086,63410,0,0,321,7061,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,33,231:11:0 0,15,131:5:0 0,9,98:3:0 +17 1005 . A 0 . DP=19;I16=5,14,0,0,670,24380,0,0,1086,63410,0,0,324,7138,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,33,231:11:0 0,15,132:5:0 0,9,113:3:0 +17 1006 . T 0 . DP=19;I16=4,14,0,0,659,24869,0,0,1026,59810,0,0,327,7237,0,0;QS=3,0;MQSB=0.913725;MQ0F=0 PL:DP:DV 0,30,220:10:0 0,15,134:5:0 0,9,115:3:0 +17 1007 . G 0 . DP=18;I16=4,13,0,0,651,25373,0,0,966,56210,0,0,306,6732,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,27,225:9:0 0,15,138:5:0 0,9,113:3:0 +17 1008 . A 0 . DP=18;I16=4,13,0,0,667,27041,0,0,966,56210,0,0,309,6821,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,27,222:9:0 0,15,147:5:0 0,9,118:3:0 +17 1009 . G 0 . DP=18;I16=4,13,0,0,635,24431,0,0,966,56210,0,0,312,6928,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,27,213:9:0 0,15,139:5:0 0,9,116:3:0 +17 1010 . C 0 . DP=18;I16=4,14,0,0,661,25289,0,0,1026,59810,0,0,339,7629,0,0;QS=3,0;MQSB=0.913725;MQ0F=0 PL:DP:DV 0,30,234:10:0 0,15,126:5:0 0,9,114:3:0 +17 1011 . T 0 . DP=18;I16=4,14,0,0,671,25325,0,0,1026,59810,0,0,339,7623,0,0;QS=3,0;MQSB=0.913725;MQ0F=0 PL:DP:DV 0,30,226:10:0 0,15,131:5:0 0,9,118:3:0 +17 1012 . A 0 . DP=19;I16=5,14,0,0,639,22891,0,0,1063,61179,0,0,339,7633,0,0;QS=3,0;MQSB=0.990403;MQ0F=0 PL:DP:DV 0,30,201:10:0 0,18,154:6:0 0,9,113:3:0 +17 1013 . T 0 . DP=18;I16=5,12,0,0,623,23913,0,0,943,53979,0,0,325,7385,0,0;QS=3,0;MQSB=0.998612;MQ0F=0 PL:DP:DV 0,24,202:8:0 0,18,161:6:0 0,9,115:3:0 +17 1014 . G 0 . DP=18;I16=5,13,0,0,656,24596,0,0,1003,57579,0,0,341,7605,0,0;QS=3,0;MQSB=0.995153;MQ0F=0 PL:DP:DV 0,27,218:9:0 0,18,159:6:0 0,9,113:3:0 +17 1015 . A 0 . DP=18;I16=5,13,0,0,646,23878,0,0,1003,57579,0,0,342,7618,0,0;QS=3,0;MQSB=0.995153;MQ0F=0 PL:DP:DV 0,27,209:9:0 0,18,164:6:0 0,9,109:3:0 +17 1016 . T 0 . DP=17;I16=4,12,0,0,588,22114,0,0,929,54841,0,0,340,7632,0,0;QS=3,0;MQSB=0.971017;MQ0F=0 PL:DP:DV 0,27,212:9:0 0,12,124:4:0 0,9,101:3:0 +17 1017 . T 0 . DP=18;I16=5,13,0,0,635,23433,0,0,1026,59810,0,0,346,7694,0,0;QS=3,0;MQSB=0.942222;MQ0F=0 PL:DP:DV 0,27,213:9:0 0,18,155:6:0 0,9,105:3:0 +17 1018 . G 0 . DP=18;I16=5,13,0,0,650,24550,0,0,1026,59810,0,0,349,7757,0,0;QS=3,0;MQSB=0.942222;MQ0F=0 PL:DP:DV 0,27,215:9:0 0,18,179:6:0 0,9,91:3:0 +17 1019 . C 0 . DP=18;I16=5,12,0,0,555,18561,0,0,966,56210,0,0,327,7213,0,0;QS=3,0;MQSB=0.951229;MQ0F=0 PL:DP:DV 0,24,181:8:0 0,18,143:6:0 0,9,104:3:0 +17 1020 . G 0 . DP=19;I16=6,12,0,0,625,22287,0,0,1026,59810,0,0,332,7402,0,0;QS=3,0;MQSB=0.97296;MQ0F=0 PL:DP:DV 0,27,228:9:0 0,18,157:6:0 0,9,87:3:0 +17 1021 . C 0 . DP=19;I16=5,13,0,0,625,22761,0,0,1026,59810,0,0,332,7326,0,0;QS=3,0;MQSB=0.942222;MQ0F=0 PL:DP:DV 0,27,220:9:0 0,18,153:6:0 0,9,92:3:0 +17 1022 . C 0 . DP=19;I16=6,13,0,0,727,27975,0,0,1086,63410,0,0,360,8034,0,0;QS=3,0;MQSB=0.965977;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,168:6:0 0,9,110:3:0 +17 1023 . A 0 . DP=19;I16=6,12,0,0,647,23997,0,0,1026,59810,0,0,338,7510,0,0;QS=3,0;MQSB=0.97296;MQ0F=0 PL:DP:DV 0,27,216:9:0 0,18,168:6:0 0,9,112:3:0 +17 1024 . C 0 . DP=20;I16=7,13,0,0,729,27471,0,0,1146,67010,0,0,364,8154,0,0;QS=3,0;MQSB=0.980568;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,169:6:0 0,9,106:3:0 +17 1025 . T 0 . DP=20;I16=7,13,0,0,757,29387,0,0,1146,67010,0,0,366,8192,0,0;QS=3,0;MQSB=0.980568;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,181:6:0 0,9,117:3:0 +17 1026 . G 0 . DP=20;I16=7,13,0,0,747,28435,0,0,1146,67010,0,0,367,8201,0,0;QS=3,0;MQSB=0.980568;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,169:6:0 0,9,113:3:0 +17 1027 . C 0 . DP=20;I16=7,13,0,0,720,26688,0,0,1146,67010,0,0,368,8232,0,0;QS=3,0;MQSB=0.980568;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,145:6:0 0,9,110:3:0 +17 1028 . A 0 . DP=19;I16=6,12,0,0,645,23681,0,0,1026,59810,0,0,348,7800,0,0;QS=3,0;MQSB=0.97296;MQ0F=0 PL:DP:DV 0,30,238:10:0 0,15,146:5:0 0,9,99:3:0 +17 1029 . C 0 . DP=19;I16=7,12,0,0,699,26817,0,0,1086,63410,0,0,371,8305,0,0;QS=3,0;MQSB=0.985816;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,138:5:0 0,9,111:3:0 +17 1030 . T 0 . DP=19;I16=7,12,0,0,749,29789,0,0,1086,63410,0,0,371,8293,0,0;QS=3,0;MQSB=0.985816;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,158:5:0 0,9,122:3:0 +17 1031 . T 0 . DP=21;I16=9,12,0,0,748,27726,0,0,1206,70610,0,0,371,8297,0,0;QS=3,0;MQSB=0.997478;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,144:5:0 0,9,113:3:0 +17 1032 . T 0 . DP=21;I16=9,12,0,0,761,28033,0,0,1206,70610,0,0,373,8319,0,0;QS=3,0;MQSB=0.997478;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,156:5:0 0,9,111:3:0 +17 1033 . G 0 . DP=22;I16=10,12,0,0,773,28227,0,0,1266,74210,0,0,375,8361,0,0;QS=3,0;MQSB=0.999457;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,169:6:0 0,9,101:3:0 +17 1034 . G 0 . DP=22;I16=8,12,0,0,703,25617,0,0,1169,69241,0,0,340,7684,0,0;QS=3,0;MQSB=0.953497;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,149:5:0 0,9,102:3:0 +17 1035 . C 0 . DP=21;I16=10,11,0,0,719,26103,0,0,1237,73369,0,0,382,8508,0,0;QS=3,0;MQSB=0.927743;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,163:6:0 0,9,94:3:0 +17 1036 . C 0 . DP=22;I16=11,10,0,0,756,28390,0,0,1237,73369,0,0,360,7938,0,0;QS=3,0;MQSB=0.939898;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,175:6:0 0,12,135:4:0 +17 1037 . T 0 . DP=22;I16=11,11,0,0,839,32737,0,0,1297,76969,0,0,389,8641,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,188:6:0 0,12,138:4:0 +17 1038 . G 0 . DP=21;I16=10,10,0,0,752,28750,0,0,1177,69769,0,0,368,8066,0,0;QS=3,0;MQSB=0.931063;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,184:6:0 0,9,107:3:0 +17 1039 . G 0 . DP=21;I16=10,11,0,0,775,29373,0,0,1237,73369,0,0,397,8761,0,0;QS=3,0;MQSB=0.927743;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,189:6:0 0,9,111:3:0 +17 1040 . A 0 . DP=21;I16=10,11,0,0,759,28007,0,0,1237,73369,0,0,401,8851,0,0;QS=3,0;MQSB=0.927743;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,177:6:0 0,9,107:3:0 +17 1041 . C 0 . DP=21;I16=8,11,0,0,713,27117,0,0,1140,68400,0,0,371,8255,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,155:5:0 0,9,110:3:0 +17 1042 . A 0 . DP=23;I16=12,10,0,0,800,29464,0,0,1297,76969,0,0,384,8466,0,0;QS=3,0;MQSB=0.947103;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,185:6:0 0,15,145:5:0 +17 1043 . A 0 . DP=23;I16=12,11,0,0,850,32160,0,0,1357,80569,0,0,414,9192,0,0;QS=3,0;MQSB=0.944319;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,188:6:0 0,15,159:5:0 +17 1044 . C 0 . DP=23;I16=12,10,0,0,812,30758,0,0,1297,76969,0,0,394,8690,0,0;QS=3,0;MQSB=0.947103;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,181:6:0 0,15,150:5:0 +17 1045 . A 0 . DP=23;I16=12,11,0,0,887,34519,0,0,1357,80569,0,0,424,9460,0,0;QS=3,0;MQSB=0.944319;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,197:6:0 0,15,156:5:0 +17 1046 . G 0 . DP=23;I16=12,11,0,0,862,33240,0,0,1357,80569,0,0,428,9576,0,0;QS=3,0;MQSB=0.944319;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,183:6:0 0,15,158:5:0 +17 1047 . A 0 . DP=23;I16=12,11,0,0,890,34804,0,0,1357,80569,0,0,432,9712,0,0;QS=3,0;MQSB=0.944319;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,198:6:0 0,15,165:5:0 +17 1048 . G 0 . DP=23;I16=12,10,0,0,846,33054,0,0,1297,76969,0,0,411,9243,0,0;QS=3,0;MQSB=0.947103;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,195:6:0 0,15,156:5:0 +17 1049 . C 0 . DP=22;I16=12,10,0,0,808,30644,0,0,1297,76969,0,0,441,10043,0,0;QS=3,0;MQSB=0.947103;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,182:6:0 0,15,160:5:0 +17 1050 . A 0 . DP=22;I16=11,10,0,0,808,31334,0,0,1237,73369,0,0,430,9940,0,0;QS=3,0;MQSB=0.939898;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,193:6:0 0,12,138:4:0 +17 1051 . A 0 . DP=21;I16=11,9,0,0,731,27495,0,0,1177,69769,0,0,423,9621,0,0;QS=3,0;MQSB=0.943233;MQ0F=0 PL:DP:DV 0,27,238:9:0 0,18,187:6:0 0,15,150:5:0 +17 1052 . A 0 . DP=21;I16=11,9,0,0,759,29327,0,0,1177,69769,0,0,427,9747,0,0;QS=3,0;MQSB=0.943233;MQ0F=0 PL:DP:DV 0,27,247:9:0 0,18,190:6:0 0,15,150:5:0 +17 1053 . A 0 . DP=21;I16=11,8,0,0,674,25210,0,0,1117,66169,0,0,406,9264,0,0;QS=3,0;MQSB=0.946915;MQ0F=0 PL:DP:DV 0,24,224:8:0 0,18,161:6:0 0,15,149:5:0 +17 1054 . C 0 . DP=21;I16=11,10,0,0,791,30157,0,0,1237,73369,0,0,459,10623,0,0;QS=3,0;MQSB=0.939898;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,189:6:0 0,15,153:5:0 +17 1055 . C 0 . DP=22;I16=12,10,0,0,818,31448,0,0,1297,76969,0,0,462,10750,0,0;QS=3,0;MQSB=0.947103;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,191:6:0 0,15,157:5:0 +17 1056 . C 0 . DP=22;I16=12,9,0,0,793,31265,0,0,1237,73369,0,0,441,10271,0,0;QS=3,0;MQSB=0.950149;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,195:6:0 0,15,161:5:0 +17 1057 . T 0 . DP=23;I16=12,10,0,0,821,31667,0,0,1297,76969,0,0,467,10911,0,0;QS=3,0;MQSB=0.947103;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,196:6:0 0,15,159:5:0 +17 1058 . G 0 . DP=23;I16=12,11,0,0,863,32871,0,0,1357,80569,0,0,493,11569,0,0;QS=3,0;MQSB=0.944319;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,197:7:0 0,15,155:5:0 +17 1059 . T 0 . DP=23;I16=12,10,0,0,797,29803,0,0,1297,76969,0,0,468,10944,0,0;QS=3,0;MQSB=0.947103;MQ0F=0 PL:DP:DV 0,30,249:10:0 0,21,202:7:0 0,15,152:5:0 +17 1060 . C 0 . DP=23;I16=12,11,0,0,829,31041,0,0,1357,80569,0,0,492,11536,0,0;QS=3,0;MQSB=0.944319;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,178:7:0 0,15,163:5:0 +17 1061 . T 0 . DP=22;I16=12,9,0,0,810,31840,0,0,1237,73369,0,0,465,10797,0,0;QS=3,0;MQSB=0.950149;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,175:5:0 0,15,158:5:0 +17 1062 . C A, 0 . DP=22;I16=12,9,0,1,826,32780,33,1089,1237,73369,60,3600,462,10652,25,625;QS=2.85398,0.146018,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.947103;BQB=1;MQ0F=0 PL:DP:DV 0,33,255,33,255,255:11:0 15,0,151,30,154,176:6:1 0,15,164,15,164,164:5:0 +17 1063 . T 0 . DP=22;I16=12,9,0,0,820,32460,0,0,1237,73369,0,0,459,10525,0,0;QS=3,0;MQSB=0.950149;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,183:6:0 0,15,166:5:0 +17 1064 . A 0 . DP=23;I16=12,9,0,0,793,30355,0,0,1237,73369,0,0,464,10752,0,0;QS=3,0;MQSB=0.950149;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,180:6:0 0,15,162:5:0 +17 1065 . A 0 . DP=23;I16=12,9,0,0,814,31978,0,0,1237,73369,0,0,462,10694,0,0;QS=3,0;MQSB=0.950149;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,186:6:0 0,15,174:5:0 +17 1066 . A 0 . DP=27;I16=15,9,0,0,890,34378,0,0,1417,84169,0,0,460,10652,0,0;QS=3,0;MQSB=0.96464;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,198:7:0 0,18,181:6:0 +17 1067 . A 0 . DP=27;I16=15,10,0,0,913,35031,0,0,1477,87769,0,0,470,10600,0,0;QS=3,0;MQSB=0.962269;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,208:7:0 0,18,182:6:0 +17 1068 . A 0 . DP=27;I16=15,9,0,0,898,34580,0,0,1417,84169,0,0,456,10342,0,0;QS=3,0;MQSB=0.96464;MQ0F=0 PL:DP:DV 0,30,253:10:0 0,24,218:8:0 0,18,181:6:0 +17 1069 . A 0 . DP=28;I16=16,10,0,0,914,33888,0,0,1537,91369,0,0,481,10925,0,0;QS=3,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,207:8:0 0,21,177:7:0 +17 1070 . A 0 . DP=28;I16=15,11,0,0,955,36445,0,0,1537,91369,0,0,467,10351,0,0;QS=3,0;MQSB=0.960078;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,223:8:0 0,21,188:7:0 +17 1071 . G 0 . DP=28;I16=16,10,0,0,974,37570,0,0,1537,91369,0,0,466,10284,0,0;QS=3,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,192:7:0 0,21,191:7:0 +17 1072 . A 0 . DP=28;I16=16,11,0,0,1007,38205,0,0,1597,94969,0,0,490,10868,0,0;QS=3,0;MQSB=0.96384;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,239:8:0 0,21,195:7:0 +17 1073 . A 0 . DP=28;I16=16,10,0,0,976,37822,0,0,1537,91369,0,0,463,10177,0,0;QS=3,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,33,254:11:0 0,24,236:8:0 0,21,199:7:0 +17 1074 . A 0 . DP=28;I16=16,11,0,0,1003,38097,0,0,1597,94969,0,0,484,10664,0,0;QS=3,0;MQSB=0.96384;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,232:8:0 0,21,203:7:0 +17 1075 . A 0 . DP=28;I16=16,10,0,0,964,36762,0,0,1537,91369,0,0,476,10564,0,0;QS=3,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,222:8:0 0,21,200:7:0 +17 1076 . G 0 . DP=28;I16=16,10,0,0,966,37048,0,0,1537,91369,0,0,476,10536,0,0;QS=3,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,209:8:0 0,21,183:7:0 +17 1077 . A 0 . DP=29;I16=17,11,0,0,1038,39240,0,0,1657,98569,0,0,480,10548,0,0;QS=3,0;MQSB=0.967085;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,231:8:0 0,24,209:8:0 +17 1078 . A 0 . DP=29;I16=17,11,0,0,1053,40425,0,0,1657,98569,0,0,480,10562,0,0;QS=3,0;MQSB=0.967085;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,234:8:0 0,24,214:8:0 +17 1079 . A 0 . DP=28;I16=17,10,0,0,1019,39007,0,0,1597,94969,0,0,479,10505,0,0;QS=3,0;MQSB=0.968979;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,223:8:0 0,24,206:8:0 +17 1080 . A 0 . DP=29;I16=18,10,0,0,1049,40827,0,0,1657,98569,0,0,478,10478,0,0;QS=3,0;MQSB=0.971673;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,246:9:0 0,24,218:8:0 +17 1081 . G 0 . DP=30;I16=19,8,0,0,988,37392,0,0,1597,94969,0,0,436,9550,0,0;QS=3,0;MQSB=0.977696;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,24,210:8:0 0,27,210:9:0 +17 1082 . A 0 . DP=30;I16=20,7,0,0,989,37109,0,0,1597,94969,0,0,438,9564,0,0;QS=3,0;MQSB=0.981425;MQ0F=0 PL:DP:DV 0,27,224:9:0 0,27,226:9:0 0,27,217:9:0 +17 1083 . A 0 . DP=30;I16=20,8,0,0,1039,39827,0,0,1657,98569,0,0,455,9803,0,0;QS=3,0;MQSB=0.979523;MQ0F=0 PL:DP:DV 0,30,246:10:0 0,27,233:9:0 0,27,217:9:0 +17 1084 . A 0 . DP=31;I16=21,8,0,0,1049,39097,0,0,1717,102169,0,0,457,9849,0,0;QS=3,0;MQSB=0.981133;MQ0F=0 PL:DP:DV 0,33,253:11:0 0,27,226:9:0 0,27,215:9:0 +17 1085 . A 0 . DP=30;I16=21,8,0,0,1052,39534,0,0,1717,102169,0,0,486,10552,0,0;QS=3,0;MQSB=0.981133;MQ0F=0 PL:DP:DV 0,30,232:10:0 0,30,247:10:0 0,27,214:9:0 +17 1086 . A 0 . DP=28;I16=21,6,0,0,969,36223,0,0,1597,94969,0,0,492,10660,0,0;QS=3,0;MQSB=0.98481;MQ0F=0 PL:DP:DV 0,30,219:10:0 0,27,236:9:0 0,24,179:8:0 +17 1087 . C 0 . DP=28;I16=22,6,0,0,984,36046,0,0,1657,98569,0,0,498,10796,0,0;QS=3,0;MQSB=0.985992;MQ0F=0 PL:DP:DV 0,30,234:10:0 0,27,229:9:0 0,27,173:9:0 +17 1088 . T 0 . DP=29;I16=23,6,0,0,1133,45203,0,0,1717,102169,0,0,503,10863,0,0;QS=3,0;MQSB=0.987041;MQ0F=0 PL:DP:DV 0,30,252:10:0 0,30,250:10:0 0,27,198:9:0 +17 1089 . C 0 . DP=29;I16=23,6,0,0,1093,42347,0,0,1717,102169,0,0,509,10965,0,0;QS=3,0;MQSB=0.987041;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,30,237:10:0 0,27,188:9:0 +17 1090 . A 0 . DP=29;I16=23,6,0,0,1061,39845,0,0,1717,102169,0,0,515,11103,0,0;QS=3,0;MQSB=0.987041;MQ0F=0 PL:DP:DV 0,30,221:10:0 0,30,250:10:0 0,27,183:9:0 +17 1091 . C 0 . DP=29;I16=23,6,0,0,1063,39713,0,0,1717,102169,0,0,521,11277,0,0;QS=3,0;MQSB=0.987041;MQ0F=0 PL:DP:DV 0,30,247:10:0 0,30,244:10:0 0,27,177:9:0 +17 1092 . T 0 . DP=29;I16=23,6,0,0,1121,44489,0,0,1717,102169,0,0,524,11334,0,0;QS=3,0;MQSB=0.987041;MQ0F=0 PL:DP:DV 0,30,244:10:0 0,30,251:10:0 0,27,198:9:0 +17 1093 . G 0 . DP=29;I16=23,6,0,0,1085,41377,0,0,1717,102169,0,0,526,11372,0,0;QS=3,0;MQSB=0.987041;MQ0F=0 PL:DP:DV 0,30,249:10:0 0,30,243:10:0 0,27,184:9:0 +17 1094 . G 0 . DP=29;I16=22,6,0,0,1018,38808,0,0,1657,98569,0,0,521,11393,0,0;QS=3,0;MQSB=0.985992;MQ0F=0 PL:DP:DV 0,30,243:10:0 0,30,232:10:0 0,24,185:8:0 +17 1095 . A 0 . DP=28;I16=22,6,0,0,1023,38551,0,0,1657,98569,0,0,529,11443,0,0;QS=3,0;MQSB=0.985992;MQ0F=0 PL:DP:DV 0,30,236:10:0 0,30,244:10:0 0,24,178:8:0 +17 1096 . T 0 . DP=30;I16=24,5,0,0,1020,37168,0,0,1717,102169,0,0,505,10849,0,0;QS=3,0;MQSB=0.989637;MQ0F=0 PL:DP:DV 0,33,234:11:0 0,27,220:9:0 0,27,178:9:0 +17 1097 . A 0 . DP=30;I16=24,6,0,0,1056,38166,0,0,1777,105769,0,0,533,11537,0,0;QS=3,0;MQSB=0.987976;MQ0F=0 PL:DP:DV 0,33,230:11:0 0,30,237:10:0 0,27,177:9:0 +17 1098 . T 0 . DP=29;I16=24,5,0,0,1081,40557,0,0,1717,102169,0,0,537,11633,0,0;QS=3,0;MQSB=0.989637;MQ0F=0 PL:DP:DV 0,30,210:10:0 0,30,251:10:0 0,27,186:9:0 +17 1099 . G 0 . DP=29;I16=24,5,0,0,1091,41719,0,0,1717,102169,0,0,540,11712,0,0;QS=3,0;MQSB=0.989637;MQ0F=0 PL:DP:DV 0,30,229:10:0 0,30,242:10:0 0,27,182:9:0 +17 1100 . A 0 . DP=29;I16=24,5,0,0,1106,42976,0,0,1717,102169,0,0,543,11825,0,0;QS=3,0;MQSB=0.989637;MQ0F=0 PL:DP:DV 0,30,210:10:0 0,30,255:10:0 0,27,191:9:0 +17 1101 . A 0 . DP=29;I16=24,5,0,0,1154,46420,0,0,1717,102169,0,0,545,11921,0,0;QS=3,0;MQSB=0.989637;MQ0F=0 PL:DP:DV 0,30,222:10:0 0,30,255:10:0 0,27,198:9:0 +17 1102 . T 0 . DP=29;I16=24,4,0,0,1046,39520,0,0,1657,98569,0,0,522,11424,0,0;QS=3,0;MQSB=0.991416;MQ0F=0 PL:DP:DV 0,30,210:10:0 0,27,233:9:0 0,27,186:9:0 +17 1103 . G 0 . DP=30;I16=24,6,0,0,1134,43486,0,0,1777,105769,0,0,548,12158,0,0;QS=3,0;MQSB=0.987976;MQ0F=0 PL:DP:DV 0,30,223:10:0 0,30,255:10:0 0,30,222:10:0 +17 1104 . A 0 . DP=28;I16=23,5,0,0,1089,43067,0,0,1657,98569,0,0,552,12296,0,0;QS=3,0;MQSB=0.988819;MQ0F=0 PL:DP:DV 0,27,213:9:0 0,27,233:9:0 0,30,233:10:0 +17 1105 . T 0 . DP=28;I16=23,5,0,0,1035,38743,0,0,1657,98569,0,0,556,12462,0,0;QS=3,0;MQSB=0.988819;MQ0F=0 PL:DP:DV 0,27,203:9:0 0,27,227:9:0 0,30,222:10:0 +17 1106 . A 0 . DP=29;I16=23,5,0,0,1003,36715,0,0,1657,98569,0,0,532,11882,0,0;QS=3,0;MQSB=0.988819;MQ0F=0 PL:DP:DV 0,30,227:10:0 0,24,198:8:0 0,30,217:10:0 +17 1107 . C 0 . DP=29;I16=23,6,0,0,1093,41509,0,0,1717,102169,0,0,558,12532,0,0;QS=3,0;MQSB=0.987041;MQ0F=0 PL:DP:DV 0,30,244:10:0 0,27,233:9:0 0,30,220:10:0 +17 1108 . A 0 . DP=29;I16=23,6,0,0,1138,44908,0,0,1717,102169,0,0,558,12536,0,0;QS=3,0;MQSB=0.987041;MQ0F=0 PL:DP:DV 0,30,239:10:0 0,27,253:9:0 0,30,227:10:0 +17 1109 . G 0 . DP=29;I16=23,6,0,0,1140,45200,0,0,1717,102169,0,0,557,12519,0,0;QS=3,0;MQSB=0.987041;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,27,240:9:0 0,30,224:10:0 +17 1110 . G 0 . DP=29;I16=23,6,0,0,1086,41054,0,0,1717,102169,0,0,555,12481,0,0;QS=3,0;MQSB=0.987041;MQ0F=0 PL:DP:DV 0,30,242:10:0 0,27,229:9:0 0,30,224:10:0 +17 1111 . T 0 . DP=29;I16=22,6,0,0,1025,37919,0,0,1680,100800,0,0,552,12470,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,227:10:0 0,24,227:8:0 0,30,211:10:0 +17 1112 . T 0 . DP=28;I16=22,6,0,0,1034,38986,0,0,1680,100800,0,0,550,12440,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,226:10:0 0,24,221:8:0 0,30,221:10:0 +17 1113 . G 0 . DP=28;I16=23,5,0,0,1085,42273,0,0,1680,100800,0,0,548,12386,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,202:7:0 0,33,222:11:0 +17 1114 . A 0 . DP=28;I16=23,5,0,0,1079,42279,0,0,1680,100800,0,0,546,12306,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,235:10:0 0,21,209:7:0 0,33,238:11:0 +17 1115 . G 0 . DP=28;I16=23,5,0,0,1114,44550,0,0,1680,100800,0,0,544,12250,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,208:7:0 0,33,234:11:0 +17 1116 . G 0 . DP=29;I16=24,5,0,0,1059,39531,0,0,1740,104400,0,0,542,12218,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,236:10:0 0,24,204:8:0 0,33,226:11:0 +17 1117 . A 0 . DP=29;I16=24,5,0,0,1124,43896,0,0,1740,104400,0,0,541,12211,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,235:10:0 0,24,227:8:0 0,33,234:11:0 +17 1118 . T 0 . DP=29;I16=24,4,0,0,1100,44802,0,0,1680,100800,0,0,539,12131,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,230:10:0 0,21,188:7:0 0,33,248:11:0 +17 1119 . C 0 . DP=29;I16=23,4,0,0,1078,44864,0,0,1620,97200,0,0,526,11958,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,224:9:0 0,21,191:7:0 0,33,255:11:0 +17 1120 . C 0 . DP=29;I16=23,5,0,0,1113,46071,0,0,1680,100800,0,0,536,12054,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,227:9:0 0,24,214:8:0 0,33,255:11:0 +17 1121 . A 0 . DP=30;I16=24,5,0,0,1167,48549,0,0,1740,104400,0,0,536,12056,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,233:9:0 0,24,220:8:0 0,36,255:12:0 +17 1122 . T 0 . DP=32;I16=26,5,0,0,1235,50967,0,0,1860,111600,0,0,535,11985,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,230:10:0 0,27,238:9:0 0,36,255:12:0 +17 1123 . T 0 . DP=32;I16=26,5,0,0,1219,50121,0,0,1860,111600,0,0,535,11893,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,221:10:0 0,27,236:9:0 0,36,255:12:0 +17 1124 . A 0 . DP=31;I16=25,5,0,0,1187,48827,0,0,1800,108000,0,0,536,11832,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,218:9:0 0,27,235:9:0 0,36,255:12:0 +17 1125 . T 0 . DP=31;I16=25,5,0,0,1211,51001,0,0,1800,108000,0,0,537,11801,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,228:9:0 0,27,235:9:0 0,36,255:12:0 +17 1126 . C 0 . DP=31;I16=25,5,0,0,1225,52001,0,0,1800,108000,0,0,538,11800,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,234:9:0 0,27,241:9:0 0,36,255:12:0 +17 1127 . T 0 . DP=31;I16=25,5,0,0,1257,55245,0,0,1800,108000,0,0,539,11829,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,231:9:0 0,27,252:9:0 0,36,255:12:0 +17 1128 . G 0 . DP=31;I16=25,5,0,0,1217,51743,0,0,1800,108000,0,0,540,11888,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,236:9:0 0,27,229:9:0 0,36,255:12:0 +17 1129 . A G, 0 . DP=31;I16=24,4,0,1,1101,45631,32,1024,1680,100800,60,3600,514,11300,25,625;QS=2.93535,0.0646465,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=1;BQB=1;MQ0F=0 PL:DP:DV 0,24,204,24,204,204:8:0 0,27,229,27,229,229:9:0 0,4,198,33,201,219:12:1 +17 1130 . A 0 . DP=31;I16=25,5,0,0,1189,49509,0,0,1800,108000,0,0,539,11943,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,215:9:0 0,27,236:9:0 0,36,255:12:0 +17 1131 . A 0 . DP=29;I16=23,5,0,0,1156,49362,0,0,1680,100800,0,0,540,11988,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,206:7:0 0,27,250:9:0 0,36,255:12:0 +17 1132 . T 0 . DP=29;I16=23,5,0,0,1123,47359,0,0,1680,100800,0,0,540,12008,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,198:7:0 0,27,229:9:0 0,36,255:12:0 +17 1133 . G 0 . DP=30;I16=23,5,0,0,1148,48796,0,0,1680,100800,0,0,540,12052,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,214:7:0 0,27,232:9:0 0,36,255:12:0 +17 1134 . C 0 . DP=29;I16=22,6,0,0,1162,50224,0,0,1680,100800,0,0,547,12155,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,209:7:0 0,27,254:9:0 0,36,255:12:0 +17 1135 . T 0 . DP=29;I16=22,6,0,0,1214,55020,0,0,1680,100800,0,0,549,12257,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,209:7:0 0,27,255:9:0 0,36,255:12:0 +17 1136 . T 0 . DP=29;I16=22,6,0,0,1148,49270,0,0,1680,100800,0,0,551,12383,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,200:7:0 0,27,255:9:0 0,36,255:12:0 +17 1137 . G 0 . DP=28;I16=21,6,0,0,1087,46051,0,0,1620,97200,0,0,554,12532,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,214:7:0 0,27,234:9:0 0,33,254:11:0 +17 1138 . G 0 . DP=28;I16=21,6,0,0,1040,42504,0,0,1620,97200,0,0,557,12703,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,197:7:0 0,27,234:9:0 0,33,246:11:0 +17 1139 . A 0 . DP=28;I16=21,6,0,0,1103,47389,0,0,1620,97200,0,0,559,12845,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,200:7:0 0,27,254:9:0 0,33,255:11:0 +17 1140 . C 0 . DP=28;I16=21,6,0,0,1072,44372,0,0,1620,97200,0,0,561,13007,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,214:7:0 0,27,234:9:0 0,33,250:11:0 +17 1141 . C 0 . DP=28;I16=21,6,0,0,1106,47298,0,0,1620,97200,0,0,562,13140,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,212:7:0 0,27,245:9:0 0,33,255:11:0 +17 1142 . A 0 . DP=28;I16=21,6,0,0,1114,47788,0,0,1620,97200,0,0,560,13146,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,212:7:0 0,27,255:9:0 0,33,251:11:0 +17 1143 . G 0 . DP=26;I16=19,7,0,0,1041,42249,0,0,1560,93600,0,0,585,13799,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,222:7:0 0,27,249:9:0 0,30,253:10:0 +17 1144 . A 0 . DP=26;I16=19,7,0,0,1018,40154,0,0,1560,93600,0,0,585,13847,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,205:7:0 0,27,250:9:0 0,30,255:10:0 +17 1145 . T 0 . DP=26;I16=19,7,0,0,1016,39852,0,0,1560,93600,0,0,584,13866,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,206:7:0 0,27,250:9:0 0,30,249:10:0 +17 1146 . G 0 . DP=26;I16=19,7,0,0,1011,39743,0,0,1560,93600,0,0,582,13856,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,210:7:0 0,27,246:9:0 0,30,254:10:0 +17 1147 . T 0 . DP=27;I16=20,6,0,0,1010,39730,0,0,1560,93600,0,0,579,13815,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,207:8:0 0,24,234:8:0 0,30,255:10:0 +17 1148 . T 0 . DP=26;I16=20,6,0,0,1002,39214,0,0,1560,93600,0,0,576,13690,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,196:8:0 0,24,237:8:0 0,30,255:10:0 +17 1149 . T 0 . DP=26;I16=20,6,0,0,1022,40532,0,0,1560,93600,0,0,573,13579,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,205:8:0 0,24,231:8:0 0,30,255:10:0 +17 1150 . T 0 . DP=26;I16=20,6,0,0,1032,41212,0,0,1560,93600,0,0,569,13433,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,208:8:0 0,24,236:8:0 0,30,255:10:0 +17 1151 . G 0 . DP=26;I16=20,6,0,0,1021,40285,0,0,1560,93600,0,0,565,13303,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,220:8:0 0,24,231:8:0 0,30,248:10:0 +17 1152 . A 0 . DP=27;I16=20,7,0,0,1040,40772,0,0,1620,97200,0,0,561,13189,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,202:8:0 0,24,230:8:0 0,33,255:11:0 +17 1153 . A 0 . DP=27;I16=20,7,0,0,1039,40717,0,0,1620,97200,0,0,557,13043,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,202:8:0 0,24,233:8:0 0,33,255:11:0 +17 1154 . T 0 . DP=28;I16=21,7,0,0,1073,41861,0,0,1680,100800,0,0,552,12866,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,212:9:0 0,24,236:8:0 0,33,255:11:0 +17 1155 . T 0 . DP=27;I16=20,7,0,0,1074,43046,0,0,1620,97200,0,0,549,12707,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,211:8:0 0,24,236:8:0 0,33,255:11:0 +17 1156 . T 0 . DP=28;I16=19,8,0,0,1065,42533,0,0,1620,97200,0,0,520,11892,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,210:8:0 0,24,239:8:0 0,33,255:11:0 +17 1157 . T 0 . DP=28;I16=20,8,0,0,1094,43108,0,0,1680,100800,0,0,541,12299,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,230:9:0 0,24,230:8:0 0,33,255:11:0 +17 1158 . G 0 . DP=28;I16=20,8,0,0,1098,43584,0,0,1680,100800,0,0,536,12056,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,240:9:0 0,24,224:8:0 0,33,255:11:0 +17 1159 . G 0 . DP=28;I16=20,8,0,0,1096,43222,0,0,1680,100800,0,0,530,11790,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,249:9:0 0,24,229:8:0 0,33,255:11:0 +17 1160 . A 0 . DP=30;I16=20,10,0,0,1146,44510,0,0,1800,108000,0,0,524,11552,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,229:9:0 0,24,242:8:0 0,39,255:13:0 +17 1161 . T 0 . DP=30;I16=20,10,0,0,1136,43548,0,0,1800,108000,0,0,520,11344,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,221:9:0 0,24,230:8:0 0,39,255:13:0 +17 1162 . T 0 . DP=30;I16=20,10,0,0,1147,44365,0,0,1800,108000,0,0,516,11168,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,232:9:0 0,24,229:8:0 0,39,255:13:0 +17 1163 . T 0 . DP=31;I16=20,11,0,0,1176,45394,0,0,1860,111600,0,0,511,10975,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,243:10:0 0,24,231:8:0 0,39,255:13:0 +17 1164 . T 0 . DP=31;I16=20,11,0,0,1166,44864,0,0,1860,111600,0,0,506,10768,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,235:10:0 0,24,234:8:0 0,39,255:13:0 +17 1165 . T 0 . DP=31;I16=20,11,0,0,1189,46635,0,0,1860,111600,0,0,501,10599,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,240:10:0 0,24,231:8:0 0,39,255:13:0 +17 1166 . T 0 . DP=30;I16=19,11,0,0,1137,43791,0,0,1800,108000,0,0,497,10467,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,231:9:0 0,24,228:8:0 0,39,255:13:0 +17 1167 . C 0 . DP=28;I16=17,11,0,0,1114,44588,0,0,1680,100800,0,0,495,10369,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,21,216:7:0 0,36,255:12:0 +17 1168 . A 0 . DP=28;I16=17,11,0,0,1074,41862,0,0,1680,100800,0,0,493,10303,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,238:9:0 0,21,203:7:0 0,36,255:12:0 +17 1169 . T 0 . DP=28;I16=17,11,0,0,1089,42589,0,0,1680,100800,0,0,491,10269,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,247:9:0 0,21,212:7:0 0,36,255:12:0 +17 1170 . A 0 . DP=27;I16=16,11,0,0,1033,39891,0,0,1620,97200,0,0,490,10266,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,244:9:0 0,21,214:7:0 0,33,255:11:0 +17 1171 . T 0 . DP=28;I16=17,11,0,0,1086,42472,0,0,1680,100800,0,0,488,10244,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,249:9:0 0,24,223:8:0 0,33,255:11:0 +17 1172 . T 0 . DP=28;I16=17,11,0,0,1086,42598,0,0,1680,100800,0,0,486,10206,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,235:9:0 0,24,228:8:0 0,33,255:11:0 +17 1173 . T 0 . DP=29;I16=18,11,0,0,1126,44348,0,0,1740,104400,0,0,483,10153,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,241:9:0 0,27,241:9:0 0,33,255:11:0 +17 1174 . T 0 . DP=29;I16=18,11,0,0,1098,42352,0,0,1740,104400,0,0,481,10135,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,230:9:0 0,27,238:9:0 0,33,255:11:0 +17 1175 . G 0 . DP=28;I16=18,10,0,0,1063,40975,0,0,1680,100800,0,0,480,10152,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,234:8:0 0,27,234:9:0 0,33,255:11:0 +17 1176 . T 0 . DP=28;I16=18,10,0,0,1045,39823,0,0,1680,100800,0,0,479,10203,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,221:8:0 0,27,233:9:0 0,33,255:11:0 +17 1177 . A 0 . DP=28;I16=18,10,0,0,1040,39006,0,0,1680,100800,0,0,478,10288,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,220:8:0 0,27,228:9:0 0,33,255:11:0 +17 1178 . A 0 . DP=27;I16=17,10,0,0,1006,38238,0,0,1620,97200,0,0,477,10355,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,221:8:0 0,27,227:9:0 0,30,255:10:0 +17 1179 . T 0 . DP=27;I16=17,10,0,0,1012,38396,0,0,1620,97200,0,0,475,10403,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,223:8:0 0,27,224:9:0 0,30,255:10:0 +17 1180 . C 0 . DP=27;I16=16,10,0,0,1006,39508,0,0,1560,93600,0,0,469,10423,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,222:7:0 0,27,224:9:0 0,30,255:10:0 +17 1181 . T 0 . DP=26;I16=16,10,0,0,1021,40581,0,0,1560,93600,0,0,469,10441,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,236:8:0 0,24,229:8:0 0,30,255:10:0 +17 1182 . T 0 . DP=26;I16=14,11,0,0,939,35915,0,0,1500,90000,0,0,457,10347,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,236:9:0 0,21,209:7:0 0,27,255:9:0 +17 1183 . T 0 . DP=25;I16=13,11,0,0,899,34555,0,0,1440,86400,0,0,455,10341,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,239:9:0 0,18,192:6:0 0,27,255:9:0 +17 1184 . G 0 . DP=24;I16=13,11,0,0,916,35398,0,0,1440,86400,0,0,465,10479,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,234:8:0 0,21,201:7:0 0,27,255:9:0 +17 1185 . C 0 . DP=24;I16=13,11,0,0,908,35014,0,0,1440,86400,0,0,465,10541,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,246:8:0 0,21,191:7:0 0,27,250:9:0 +17 1186 . A 0 . DP=24;I16=13,11,0,0,946,37648,0,0,1440,86400,0,0,463,10525,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,240:8:0 0,21,205:7:0 0,27,255:9:0 +17 1187 . G 0 . DP=25;I16=14,11,0,0,908,33870,0,0,1500,90000,0,0,461,10529,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,240:9:0 0,21,205:7:0 0,27,240:9:0 +17 1188 . T 0 . DP=25;I16=14,11,0,0,886,32138,0,0,1500,90000,0,0,461,10553,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,248:10:0 0,21,196:7:0 0,24,216:8:0 +17 1189 . A 0 . DP=25;I16=14,11,0,0,920,34392,0,0,1500,90000,0,0,461,10497,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,174:6:0 0,27,252:9:0 +17 1190 . T 0 . DP=26;I16=14,12,0,0,960,35876,0,0,1560,93600,0,0,462,10462,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,185:6:0 0,27,252:9:0 +17 1191 . A 0 . DP=26;I16=14,12,0,0,928,33922,0,0,1560,93600,0,0,464,10450,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,173:6:0 0,27,245:9:0 +17 1192 . T 0 . DP=26;I16=14,12,0,0,981,37505,0,0,1560,93600,0,0,465,10413,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,191:6:0 0,27,255:9:0 +17 1193 . T 0 . DP=26;I16=14,12,0,0,976,37054,0,0,1560,93600,0,0,466,10402,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,191:6:0 0,27,255:9:0 +17 1194 . T 0 . DP=26;I16=14,12,0,0,951,35219,0,0,1560,93600,0,0,466,10368,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,178:6:0 0,27,249:9:0 +17 1195 . A 0 . DP=26;I16=14,12,0,0,917,33253,0,0,1560,93600,0,0,466,10362,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,177:6:0 0,27,235:9:0 +17 1196 . C 0 . DP=25;I16=13,12,0,0,921,34209,0,0,1500,90000,0,0,466,10334,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,187:6:0 0,27,236:9:0 +17 1197 . C 0 . DP=24;I16=12,12,0,0,906,34862,0,0,1440,86400,0,0,464,10184,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,186:6:0 0,24,233:8:0 +17 1198 . A 0 . DP=24;I16=12,12,0,0,937,36815,0,0,1440,86400,0,0,461,10013,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,190:6:0 0,24,245:8:0 +17 1199 . G 0 . DP=24;I16=12,12,0,0,879,33035,0,0,1440,86400,0,0,457,9821,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,163:6:0 0,24,221:8:0 +17 1200 . T 0 . DP=24;I16=11,12,0,0,895,35141,0,0,1380,82800,0,0,428,9032,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,176:5:0 0,24,247:8:0 +17 1201 . T 0 . DP=24;I16=12,12,0,0,889,33727,0,0,1440,86400,0,0,449,9521,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,177:6:0 0,24,238:8:0 +17 1202 . C 0 . DP=25;I16=13,12,0,0,929,35121,0,0,1500,90000,0,0,445,9413,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,175:6:0 0,24,230:8:0 +17 1203 . A 0 . DP=25;I16=13,12,0,0,943,36107,0,0,1500,90000,0,0,442,9334,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,184:6:0 0,24,241:8:0 +17 1204 . G 0 . DP=24;I16=13,11,0,0,876,33106,0,0,1440,86400,0,0,439,9235,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,174:6:0 0,21,218:7:0 +17 1205 . C 0 . DP=24;I16=13,11,0,0,891,33869,0,0,1440,86400,0,0,436,9166,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,176:6:0 0,21,217:7:0 +17 1206 . A 0 . DP=23;I16=13,10,0,0,846,31744,0,0,1380,82800,0,0,434,9126,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,179:6:0 0,21,212:7:0 +17 1207 . T 0 . DP=23;I16=13,9,0,0,819,30877,0,0,1320,79200,0,0,407,8489,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,254:10:0 0,18,189:6:0 0,18,194:6:0 +17 1208 . C 0 . DP=24;I16=14,10,0,0,910,35236,0,0,1440,86400,0,0,429,9079,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,190:7:0 0,21,217:7:0 +17 1209 . C T, 0 . DP=24;I16=14,9,0,1,869,33481,21,441,1380,82800,60,3600,408,8710,19,361;QS=2.91393,0.0860656,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=1;BQB=1;MQ0F=0 PL:DP:DV 0,30,255,30,255,255:10:0 0,0,153,18,156,166:7:1 0,21,209,21,209,209:7:0 +17 1210 . C 0 . DP=24;I16=14,10,0,0,915,35713,0,0,1440,86400,0,0,425,9091,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,199:7:0 0,21,209:7:0 +17 1211 . T 0 . DP=24;I16=14,10,0,0,905,34669,0,0,1440,86400,0,0,423,9139,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,213:7:0 0,21,214:7:0 +17 1212 . A 0 . DP=24;I16=14,10,0,0,850,30690,0,0,1440,86400,0,0,421,9215,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,246:10:0 0,21,190:7:0 0,21,204:7:0 +17 1213 . A 0 . DP=24;I16=14,10,0,0,852,31192,0,0,1440,86400,0,0,418,9268,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,253:10:0 0,21,197:7:0 0,21,195:7:0 +17 1214 . C 0 . DP=23;I16=13,10,0,0,851,32099,0,0,1380,82800,0,0,415,9295,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,186:7:0 0,18,184:6:0 +17 1215 . T 0 . DP=23;I16=13,9,0,0,839,32475,0,0,1320,79200,0,0,386,8668,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,211:7:0 0,15,172:5:0 +17 1216 . C 0 . DP=23;I16=13,10,0,0,863,32923,0,0,1380,82800,0,0,406,9260,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,196:7:0 0,18,172:6:0 +17 1217 . A 0 . DP=22;I16=12,10,0,0,820,30926,0,0,1320,79200,0,0,402,9244,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,172:6:0 0,18,191:6:0 +17 1218 . A 0 . DP=22;I16=12,10,0,0,764,27286,0,0,1320,79200,0,0,398,9244,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,145:6:0 0,18,184:6:0 +17 1219 . A 0 . DP=21;I16=12,9,0,0,803,31119,0,0,1260,75600,0,0,395,9259,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,175:6:0 0,15,173:5:0 +17 1220 . A 0 . DP=21;I16=12,9,0,0,752,27700,0,0,1260,75600,0,0,392,9288,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,253:10:0 0,18,167:6:0 0,15,167:5:0 +17 1221 . A 0 . DP=20;I16=12,8,0,0,722,26564,0,0,1200,72000,0,0,390,9330,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,147:5:0 0,15,157:5:0 +17 1222 . T 0 . DP=18;I16=10,8,0,0,666,25034,0,0,1080,64800,0,0,389,9333,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,245:9:0 0,15,143:5:0 0,12,142:4:0 +17 1223 . T 0 . DP=17;I16=9,7,0,0,574,21262,0,0,960,57600,0,0,364,8720,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,232:9:0 0,12,122:4:0 0,9,120:3:0 +17 1224 . C 0 . DP=19;I16=10,7,0,0,639,24429,0,0,1020,61200,0,0,364,8740,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,128:4:0 0,9,112:3:0 +17 1225 . A 0 . DP=19;I16=10,9,0,0,713,27139,0,0,1109,65641,0,0,395,9419,0,0;QS=3,0;MQSB=0.920044;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,137:5:0 0,12,145:4:0 +17 1226 . A 0 . DP=19;I16=10,9,0,0,688,25468,0,0,1109,65641,0,0,397,9469,0,0;QS=3,0;MQSB=0.920044;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,127:5:0 0,12,147:4:0 +17 1227 . A 0 . DP=19;I16=10,9,0,0,698,26104,0,0,1109,65641,0,0,399,9531,0,0;QS=3,0;MQSB=0.920044;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,133:5:0 0,12,146:4:0 +17 1228 . A 0 . DP=19;I16=10,9,0,0,705,26721,0,0,1109,65641,0,0,399,9505,0,0;QS=3,0;MQSB=0.920044;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,143:5:0 0,12,145:4:0 +17 1229 . A 0 . DP=18;I16=10,8,0,0,693,26891,0,0,1049,62041,0,0,400,9490,0,0;QS=3,0;MQSB=0.906029;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,123:4:0 0,12,138:4:0 +17 1230 . T 0 . DP=18;I16=10,8,0,0,643,23601,0,0,1049,62041,0,0,401,9485,0,0;QS=3,0;MQSB=0.906029;MQ0F=0 PL:DP:DV 0,30,245:10:0 0,12,115:4:0 0,12,144:4:0 +17 1231 . C 0 . DP=18;I16=10,7,0,0,663,26041,0,0,1020,61200,0,0,390,9320,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,98:3:0 0,12,138:4:0 +17 1232 . T 0 . DP=18;I16=10,8,0,0,683,26261,0,0,1049,62041,0,0,401,9409,0,0;QS=3,0;MQSB=0.906029;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,133:4:0 0,12,129:4:0 +17 1233 . G 0 . DP=18;I16=10,8,0,0,657,24509,0,0,1049,62041,0,0,401,9389,0,0;QS=3,0;MQSB=0.906029;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,124:4:0 0,12,129:4:0 +17 1234 . A 0 . DP=19;I16=10,8,0,0,677,26177,0,0,1080,64800,0,0,386,9134,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,101:3:0 0,12,144:4:0 +17 1235 . A 0 . DP=19;I16=10,9,0,0,697,26363,0,0,1109,65641,0,0,400,9282,0,0;QS=3,0;MQSB=0.920044;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,129:4:0 0,12,140:4:0 +17 1236 . A 0 . DP=19;I16=10,9,0,0,671,24693,0,0,1109,65641,0,0,398,9148,0,0;QS=3,0;MQSB=0.920044;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,103:4:0 0,12,136:4:0 +17 1237 . T 0 . DP=19;I16=9,9,0,0,649,24061,0,0,1049,62041,0,0,370,8356,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,98:3:0 0,12,135:4:0 +17 1238 . C 0 . DP=20;I16=11,9,0,0,733,27709,0,0,1169,69241,0,0,391,8783,0,0;QS=3,0;MQSB=0.916401;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,104:4:0 0,12,145:4:0 +17 1239 . C 0 . DP=20;I16=10,9,0,0,672,24596,0,0,1109,65641,0,0,363,7981,0,0;QS=3,0;MQSB=0.920044;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,76:3:0 0,12,124:4:0 +17 1240 . C 0 . DP=20;I16=11,9,0,0,723,26895,0,0,1169,69241,0,0,385,8451,0,0;QS=3,0;MQSB=0.916401;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,118:4:0 0,12,129:4:0 +17 1241 . A 0 . DP=20;I16=11,9,0,0,719,26575,0,0,1169,69241,0,0,382,8318,0,0;QS=3,0;MQSB=0.916401;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,104:4:0 0,12,141:4:0 +17 1242 . A 0 . DP=21;I16=12,9,0,0,749,27599,0,0,1229,72841,0,0,379,8207,0,0;QS=3,0;MQSB=0.913101;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,109:4:0 0,15,153:5:0 +17 1243 . A 0 . DP=21;I16=12,9,0,0,738,26862,0,0,1229,72841,0,0,377,8119,0,0;QS=3,0;MQSB=0.913101;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,110:4:0 0,15,158:5:0 +17 1244 . C 0 . DP=21;I16=12,8,0,0,670,22952,0,0,1169,69241,0,0,365,7955,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,101:4:0 0,15,148:5:0 +17 1245 . G 0 . DP=21;I16=12,9,0,0,657,21627,0,0,1229,72841,0,0,373,8015,0,0;QS=3,0;MQSB=0.913101;MQ0F=0 PL:DP:DV 0,36,245:12:0 0,12,95:4:0 0,15,158:5:0 +17 1246 . C 0 . DP=21;I16=12,9,0,0,652,21348,0,0,1229,72841,0,0,370,7948,0,0;QS=3,0;MQSB=0.913101;MQ0F=0 PL:DP:DV 0,36,252:12:0 0,12,95:4:0 0,15,146:5:0 +17 1247 . G 0 . DP=20;I16=11,9,0,0,655,22291,0,0,1169,69241,0,0,367,7853,0,0;QS=3,0;MQSB=0.916401;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,87:4:0 0,15,150:5:0 +17 1248 . C 0 . DP=20;I16=10,8,0,0,659,25037,0,0,1080,64800,0,0,314,6530,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,90:3:0 0,15,156:5:0 +17 1249 . C 0 . DP=21;I16=12,9,0,0,772,28954,0,0,1229,72841,0,0,360,7680,0,0;QS=3,0;MQSB=0.913101;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,111:4:0 0,15,166:5:0 +17 1250 . A 0 . DP=21;I16=12,9,0,0,757,27599,0,0,1229,72841,0,0,356,7554,0,0;QS=3,0;MQSB=0.913101;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,114:4:0 0,15,161:5:0 +17 1251 . A 0 . DP=21;I16=12,9,0,0,758,27890,0,0,1229,72841,0,0,352,7452,0,0;QS=3,0;MQSB=0.913101;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,115:4:0 0,15,174:5:0 +17 1252 . T 0 . DP=21;I16=12,9,0,0,758,27574,0,0,1229,72841,0,0,348,7374,0,0;QS=3,0;MQSB=0.913101;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,124:4:0 0,15,159:5:0 +17 1253 . A 0 . DP=20;I16=12,8,0,0,718,26292,0,0,1169,69241,0,0,345,7319,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,127:4:0 0,12,144:4:0 +17 1254 . A 0 . DP=20;I16=12,8,0,0,781,30817,0,0,1169,69241,0,0,342,7286,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,134:4:0 0,12,156:4:0 +17 1255 . G 0 . DP=21;I16=12,9,0,0,785,30039,0,0,1229,72841,0,0,339,7275,0,0;QS=3,0;MQSB=0.913101;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,128:4:0 0,15,169:5:0 +17 1256 . C 0 . DP=20;I16=12,8,0,0,742,27910,0,0,1169,69241,0,0,338,7286,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,116:4:0 0,15,165:5:0 +17 1257 . A 0 . DP=20;I16=12,8,0,0,745,28017,0,0,1169,69241,0,0,337,7319,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,132:4:0 0,15,167:5:0 +17 1258 . T 0 . DP=20;I16=12,8,0,0,753,28507,0,0,1169,69241,0,0,336,7374,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,126:4:0 0,15,170:5:0 +17 1259 . T 0 . DP=20;I16=12,8,0,0,690,24762,0,0,1169,69241,0,0,335,7451,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,33,236:11:0 0,12,128:4:0 0,15,170:5:0 +17 1260 . C 0 . DP=20;I16=12,8,0,0,719,26541,0,0,1169,69241,0,0,333,7499,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,127:4:0 0,15,155:5:0 +17 1261 . C 0 . DP=18;I16=11,6,0,0,602,22374,0,0,989,58441,0,0,308,6940,0,0;QS=3,0;MQSB=0.85832;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,117:4:0 0,9,109:3:0 +17 1262 . C 0 . DP=18;I16=12,6,0,0,653,24345,0,0,1049,62041,0,0,333,7597,0,0;QS=3,0;MQSB=0.85394;MQ0F=0 PL:DP:DV 0,30,253:10:0 0,15,145:5:0 0,9,114:3:0 +17 1263 . T 0 . DP=17;I16=12,5,0,0,654,25656,0,0,989,58441,0,0,335,7645,0,0;QS=3,0;MQSB=0.818731;MQ0F=0 PL:DP:DV 0,27,238:9:0 0,15,158:5:0 0,9,118:3:0 +17 1264 . T 0 . DP=17;I16=12,5,0,0,615,22855,0,0,989,58441,0,0,336,7658,0,0;QS=3,0;MQSB=0.818731;MQ0F=0 PL:DP:DV 0,27,226:9:0 0,15,149:5:0 0,9,114:3:0 +17 1265 . T 0 . DP=17;I16=12,5,0,0,620,23176,0,0,989,58441,0,0,334,7538,0,0;QS=3,0;MQSB=0.818731;MQ0F=0 PL:DP:DV 0,27,232:9:0 0,15,144:5:0 0,9,114:3:0 +17 1266 . G 0 . DP=18;I16=13,5,0,0,675,25765,0,0,1049,62041,0,0,332,7438,0,0;QS=3,0;MQSB=0.814433;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,145:5:0 0,9,114:3:0 +17 1267 . A 0 . DP=18;I16=13,5,0,0,663,24799,0,0,1049,62041,0,0,331,7359,0,0;QS=3,0;MQSB=0.814433;MQ0F=0 PL:DP:DV 0,30,253:10:0 0,15,138:5:0 0,9,114:3:0 +17 1268 . G 0 . DP=18;I16=13,5,0,0,638,23584,0,0,1049,62041,0,0,329,7251,0,0;QS=3,0;MQSB=0.814433;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,112:5:0 0,9,108:3:0 +17 1269 . C 0 . DP=18;I16=13,5,0,0,592,20458,0,0,1049,62041,0,0,327,7163,0,0;QS=3,0;MQSB=0.814433;MQ0F=0 PL:DP:DV 0,30,224:10:0 0,15,130:5:0 0,9,107:3:0 +17 1270 . G 0 . DP=18;I16=13,5,0,0,537,16775,0,0,1049,62041,0,0,325,7095,0,0;QS=3,0;MQSB=0.814433;MQ0F=0 PL:DP:DV 0,30,206:10:0 0,15,104:5:0 0,9,98:3:0 +17 1271 . T 0 . DP=18;I16=12,5,0,0,620,22824,0,0,989,58441,0,0,298,6422,0,0;QS=3,0;MQSB=0.818731;MQ0F=0 PL:DP:DV 0,27,240:9:0 0,15,138:5:0 0,9,109:3:0 +17 1272 . C 0 . DP=17;I16=11,5,0,0,597,22587,0,0,929,54841,0,0,297,6393,0,0;QS=3,0;MQSB=0.823561;MQ0F=0 PL:DP:DV 0,27,251:9:0 0,12,113:4:0 0,9,110:3:0 +17 1273 . A 0 . DP=18;I16=12,6,0,0,633,23063,0,0,1049,62041,0,0,318,6866,0,0;QS=3,0;MQSB=0.85394;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,109:4:0 0,9,113:3:0 +17 1274 . T 0 . DP=17;I16=10,6,0,0,609,23335,0,0,929,54841,0,0,293,6205,0,0;QS=3,0;MQSB=0.863243;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,67:2:0 0,9,115:3:0 +17 1275 . G 0 . DP=17;I16=11,6,0,0,602,21976,0,0,989,58441,0,0,317,6763,0,0;QS=3,0;MQSB=0.85832;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,87:3:0 0,9,112:3:0 +17 1276 . T 0 . DP=17;I16=11,6,0,0,587,20925,0,0,989,58441,0,0,316,6714,0,0;QS=3,0;MQSB=0.85832;MQ0F=0 PL:DP:DV 0,33,248:11:0 0,9,94:3:0 0,9,110:3:0 +17 1277 . C 0 . DP=18;I16=11,7,0,0,590,20126,0,0,1049,62041,0,0,314,6634,0,0;QS=3,0;MQSB=0.883327;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,85:3:0 0,9,106:3:0 +17 1278 . G 0 . DP=18;I16=11,7,0,0,603,20675,0,0,1049,62041,0,0,313,6575,0,0;QS=3,0;MQSB=0.883327;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,77:3:0 0,9,96:3:0 +17 1279 . G 0 . DP=18;I16=11,7,0,0,646,23662,0,0,1049,62041,0,0,312,6538,0,0;QS=3,0;MQSB=0.883327;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,85:3:0 0,9,113:3:0 +17 1280 . T 0 . DP=18;I16=10,7,0,0,558,19192,0,0,989,58441,0,0,296,6298,0,0;QS=3,0;MQSB=0.887766;MQ0F=0 PL:DP:DV 0,33,249:11:0 0,9,86:3:0 0,9,97:3:0 +17 1281 . G 0 . DP=17;I16=10,6,0,0,564,21244,0,0,929,54841,0,0,270,5658,0,0;QS=3,0;MQSB=0.863243;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,85:3:0 0,9,103:3:0 +17 1282 . C 0 . DP=18;I16=10,8,0,0,654,24308,0,0,1049,62041,0,0,294,6286,0,0;QS=3,0;MQSB=0.906029;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,94:3:0 0,12,131:4:0 +17 1283 . T 0 . DP=18;I16=10,8,0,0,677,26313,0,0,1049,62041,0,0,294,6308,0,0;QS=3,0;MQSB=0.906029;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,83:3:0 0,12,154:4:0 +17 1284 . T 0 . DP=18;I16=10,8,0,0,631,22949,0,0,1049,62041,0,0,293,6301,0,0;QS=3,0;MQSB=0.906029;MQ0F=0 PL:DP:DV 0,33,254:11:0 0,9,92:3:0 0,12,145:4:0 +17 1285 . G 0 . DP=18;I16=10,7,0,0,657,25545,0,0,989,58441,0,0,267,5691,0,0;QS=3,0;MQSB=0.887766;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,94:3:0 0,12,145:4:0 +17 1286 . G 0 . DP=18;I16=10,8,0,0,650,24684,0,0,1049,62041,0,0,291,6353,0,0;QS=3,0;MQSB=0.906029;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,78:3:0 0,12,148:4:0 +17 1287 . A 0 . DP=17;I16=9,8,0,0,609,22229,0,0,989,58441,0,0,291,6411,0,0;QS=3,0;MQSB=0.91051;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,91:3:0 0,12,137:4:0 +17 1288 . A 0 . DP=17;I16=9,8,0,0,605,22315,0,0,989,58441,0,0,290,6438,0,0;QS=3,0;MQSB=0.91051;MQ0F=0 PL:DP:DV 0,30,245:10:0 0,9,103:3:0 0,12,140:4:0 +17 1289 . T 0 . DP=18;I16=10,8,0,0,637,23207,0,0,1049,62041,0,0,289,6483,0,0;QS=3,0;MQSB=0.906029;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,99:3:0 0,12,141:4:0 +17 1290 . G 0 . DP=15;I16=9,6,0,0,559,21163,0,0,869,51241,0,0,292,6544,0,0;QS=3,0;MQSB=0.868815;MQ0F=0 PL:DP:DV 0,27,242:9:0 0,9,97:3:0 0,9,106:3:0 +17 1291 . T 0 . DP=15;I16=9,6,0,0,547,20303,0,0,869,51241,0,0,295,6619,0,0;QS=3,0;MQSB=0.868815;MQ0F=0 PL:DP:DV 0,27,225:9:0 0,9,91:3:0 0,9,117:3:0 +17 1292 . T 0 . DP=15;I16=9,6,0,0,559,21121,0,0,869,51241,0,0,297,6657,0,0;QS=3,0;MQSB=0.868815;MQ0F=0 PL:DP:DV 0,27,236:9:0 0,9,95:3:0 0,9,113:3:0 +17 1293 . T 0 . DP=15;I16=9,6,0,0,578,22428,0,0,869,51241,0,0,299,6707,0,0;QS=3,0;MQSB=0.868815;MQ0F=0 PL:DP:DV 0,27,242:9:0 0,9,100:3:0 0,9,116:3:0 +17 1294 . G 0 . DP=16;I16=9,7,0,0,606,23572,0,0,929,54841,0,0,301,6769,0,0;QS=3,0;MQSB=0.892753;MQ0F=0 PL:DP:DV 0,27,254:9:0 0,12,110:4:0 0,9,119:3:0 +17 1295 . G 0 . DP=16;I16=9,7,0,0,567,21419,0,0,929,54841,0,0,304,6844,0,0;QS=3,0;MQSB=0.892753;MQ0F=0 PL:DP:DV 0,27,244:9:0 0,12,102:4:0 0,9,114:3:0 +17 1296 . G 0 . DP=16;I16=8,7,0,0,518,19300,0,0,869,51241,0,0,294,6740,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,27,227:9:0 0,9,89:3:0 0,9,114:3:0 +17 1297 . G 0 . DP=18;I16=9,8,0,0,551,19323,0,0,958,55682,0,0,322,7444,0,0;QS=3,0;MQSB=0.998843;MQ0F=0 PL:DP:DV 0,30,219:10:0 0,9,86:3:0 0,12,133:4:0 +17 1298 . T 0 . DP=18;I16=10,8,0,0,615,22371,0,0,1018,59282,0,0,336,7638,0,0;QS=3,0;MQSB=0.99606;MQ0F=0 PL:DP:DV 0,30,233:10:0 0,12,105:4:0 0,12,138:4:0 +17 1299 . T 0 . DP=18;I16=9,8,0,0,619,23135,0,0,958,55682,0,0,328,7548,0,0;QS=3,0;MQSB=0.998843;MQ0F=0 PL:DP:DV 0,30,242:10:0 0,9,97:3:0 0,12,136:4:0 +17 1300 . T 0 . DP=18;I16=10,8,0,0,631,23107,0,0,1018,59282,0,0,338,7638,0,0;QS=3,0;MQSB=0.99606;MQ0F=0 PL:DP:DV 0,30,235:10:0 0,12,121:4:0 0,12,136:4:0 +17 1301 . T G, 0 . DP=18;I16=8,8,1,0,599,22623,18,324,929,54841,29,841,314,7040,25,625;QS=2.9434,0.0566038,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.998843;BQB=1;MQ0F=0 PL:DP:DV 0,9,213,24,216,222:9:1 0,12,126,12,126,126:4:0 0,12,135,12,135,135:4:0 +17 1302 . G 0 . DP=17;I16=9,8,0,0,624,23544,0,0,958,55682,0,0,341,7709,0,0;QS=3,0;MQSB=0.998843;MQ0F=0 PL:DP:DV 0,27,240:9:0 0,12,127:4:0 0,12,140:4:0 +17 1303 . G 0 . DP=17;I16=9,8,0,0,582,21200,0,0,958,55682,0,0,342,7718,0,0;QS=3,0;MQSB=0.998843;MQ0F=0 PL:DP:DV 0,27,217:9:0 0,12,125:4:0 0,12,138:4:0 +17 1304 . A 0 . DP=18;I16=10,8,0,0,652,24124,0,0,1018,59282,0,0,343,7741,0,0;QS=3,0;MQSB=0.99606;MQ0F=0 PL:DP:DV 0,27,218:9:0 0,12,131:4:0 0,15,169:5:0 +17 1305 . T 0 . DP=18;I16=10,8,0,0,685,26381,0,0,1018,59282,0,0,345,7779,0,0;QS=3,0;MQSB=0.99606;MQ0F=0 PL:DP:DV 0,27,241:9:0 0,12,122:4:0 0,15,174:5:0 +17 1306 . T 0 . DP=18;I16=9,8,0,0,644,24628,0,0,958,55682,0,0,345,7829,0,0;QS=3,0;MQSB=0.998843;MQ0F=0 PL:DP:DV 0,27,236:9:0 0,9,106:3:0 0,15,168:5:0 +17 1307 . T 0 . DP=17;I16=9,8,0,0,628,23746,0,0,958,55682,0,0,348,7902,0,0;QS=3,0;MQSB=0.998843;MQ0F=0 PL:DP:DV 0,27,226:9:0 0,9,104:3:0 0,15,167:5:0 +17 1308 . A 0 . DP=19;I16=9,10,0,0,690,25500,0,0,1078,62882,0,0,350,7938,0,0;QS=3,0;MQSB=0.999167;MQ0F=0 PL:DP:DV 0,30,236:10:0 0,12,127:4:0 0,15,173:5:0 +17 1309 . C 0 . DP=19;I16=9,9,0,0,698,27148,0,0,1049,62041,0,0,342,7818,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,106:3:0 0,15,169:5:0 +17 1310 . A 0 . DP=19;I16=9,10,0,0,751,29953,0,0,1078,62882,0,0,356,7958,0,0;QS=3,0;MQSB=0.999167;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,132:4:0 0,15,183:5:0 +17 1311 . G 0 . DP=19;I16=9,10,0,0,742,29384,0,0,1078,62882,0,0,359,7995,0,0;QS=3,0;MQSB=0.999167;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,128:4:0 0,15,174:5:0 +17 1312 . C 0 . DP=19;I16=9,10,0,0,717,27783,0,0,1078,62882,0,0,362,8050,0,0;QS=3,0;MQSB=0.999167;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,115:4:0 0,15,166:5:0 +17 1313 . T 0 . DP=19;I16=9,10,0,0,751,30061,0,0,1078,62882,0,0,364,8074,0,0;QS=3,0;MQSB=0.999167;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,135:4:0 0,15,175:5:0 +17 1314 . T 0 . DP=19;I16=9,10,0,0,707,26983,0,0,1078,62882,0,0,366,8118,0,0;QS=3,0;MQSB=0.999167;MQ0F=0 PL:DP:DV 0,30,245:10:0 0,12,134:4:0 0,15,174:5:0 +17 1315 . T 0 . DP=19;I16=9,10,0,0,717,27491,0,0,1078,62882,0,0,367,8131,0,0;QS=3,0;MQSB=0.999167;MQ0F=0 PL:DP:DV 0,30,250:10:0 0,12,132:4:0 0,15,174:5:0 +17 1316 . G 0 . DP=21;I16=10,11,0,0,776,29502,0,0,1198,70082,0,0,368,8162,0,0;QS=3,0;MQSB=0.99938;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,128:4:0 0,18,188:6:0 +17 1317 . G 0 . DP=21;I16=10,11,0,0,751,27855,0,0,1198,70082,0,0,371,8213,0,0;QS=3,0;MQSB=0.99938;MQ0F=0 PL:DP:DV 0,33,253:11:0 0,12,130:4:0 0,18,179:6:0 +17 1318 . G 0 . DP=21;I16=10,11,0,0,749,27663,0,0,1198,70082,0,0,372,8188,0,0;QS=3,0;MQSB=0.99938;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,130:4:0 0,18,184:6:0 +17 1319 . A 0 . DP=21;I16=10,11,0,0,768,28390,0,0,1198,70082,0,0,373,8189,0,0;QS=3,0;MQSB=0.99938;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,124:4:0 0,18,186:6:0 +17 1320 . C 0 . DP=21;I16=10,11,0,0,728,25496,0,0,1198,70082,0,0,373,8165,0,0;QS=3,0;MQSB=0.99938;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,113:4:0 0,18,161:6:0 +17 1321 . G 0 . DP=22;I16=10,12,0,0,762,27412,0,0,1289,76441,0,0,374,8164,0,0;QS=3,0;MQSB=0.924723;MQ0F=0 PL:DP:DV 0,33,244:11:0 0,9,104:3:0 0,24,208:8:0 +17 1322 . C 0 . DP=22;I16=10,12,0,0,852,33528,0,0,1289,76441,0,0,377,8187,0,0;QS=3,0;MQSB=0.924723;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,111:3:0 0,24,225:8:0 +17 1323 . T 0 . DP=22;I16=10,12,0,0,874,35152,0,0,1289,76441,0,0,379,8185,0,0;QS=3,0;MQSB=0.924723;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,112:3:0 0,24,237:8:0 +17 1324 . C 0 . DP=21;I16=9,12,0,0,793,30585,0,0,1229,72841,0,0,381,8157,0,0;QS=3,0;MQSB=0.913101;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,109:3:0 0,24,218:8:0 +17 1325 . A 0 . DP=21;I16=9,12,0,0,782,29430,0,0,1229,72841,0,0,383,8153,0,0;QS=3,0;MQSB=0.913101;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,105:3:0 0,24,218:8:0 +17 1326 . A 0 . DP=21;I16=9,12,0,0,791,30479,0,0,1229,72841,0,0,385,8173,0,0;QS=3,0;MQSB=0.913101;MQ0F=0 PL:DP:DV 0,30,249:10:0 0,9,108:3:0 0,24,230:8:0 +17 1327 . C 0 . DP=23;I16=11,12,0,0,834,31048,0,0,1349,80041,0,0,387,8217,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,99:3:0 0,27,237:9:0 +17 1328 . C 0 . DP=23;I16=11,12,0,0,878,33972,0,0,1349,80041,0,0,391,8287,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,105:3:0 0,27,254:9:0 +17 1329 . T 0 . DP=23;I16=11,12,0,0,882,34756,0,0,1349,80041,0,0,395,8385,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,112:3:0 0,27,255:9:0 +17 1330 . G 0 . DP=23;I16=11,12,0,0,856,32638,0,0,1349,80041,0,0,398,8460,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,101:3:0 0,27,241:9:0 +17 1331 . T 0 . DP=23;I16=11,12,0,0,847,31785,0,0,1349,80041,0,0,400,8512,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,106:3:0 0,27,247:9:0 +17 1332 . A 0 . DP=23;I16=11,12,0,0,826,30264,0,0,1349,80041,0,0,402,8592,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,33,252:11:0 0,9,104:3:0 0,27,238:9:0 +17 1333 . C 0 . DP=23;I16=11,12,0,0,836,30928,0,0,1349,80041,0,0,404,8700,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,101:3:0 0,27,236:9:0 +17 1334 . C 0 . DP=22;I16=11,11,0,0,830,32380,0,0,1289,76441,0,0,405,8733,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,107:3:0 0,27,238:9:0 +17 1335 . T 0 . DP=22;I16=11,11,0,0,877,35371,0,0,1289,76441,0,0,406,8788,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,113:3:0 0,27,253:9:0 +17 1336 . C 0 . DP=25;I16=12,12,0,0,890,33648,0,0,1378,80882,0,0,398,8784,0,0;QS=3,0;MQSB=0.786628;MQ0F=0 PL:DP:DV 0,33,250:11:0 0,12,131:4:0 0,27,237:9:0 +17 1337 . A 0 . DP=26;I16=13,13,0,0,941,34611,0,0,1498,88082,0,0,411,8967,0,0;QS=3,0;MQSB=0.800737;MQ0F=0 PL:DP:DV 0,33,249:11:0 0,15,152:5:0 0,30,247:10:0 +17 1338 . A 0 . DP=26;I16=12,14,0,0,982,37358,0,0,1498,88082,0,0,416,9048,0,0;QS=3,0;MQSB=0.771623;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,153:5:0 0,30,255:10:0 +17 1339 . T 0 . DP=27;I16=12,15,0,0,989,36855,0,0,1558,91682,0,0,422,9160,0,0;QS=3,0;MQSB=0.765017;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,151:5:0 0,33,255:11:0 +17 1340 . A 0 . DP=27;I16=11,15,0,0,937,34141,0,0,1498,88082,0,0,425,9289,0,0;QS=3,0;MQSB=0.738577;MQ0F=0 PL:DP:DV 0,30,250:10:0 0,15,149:5:0 0,33,254:11:0 +17 1341 . A 0 . DP=27;I16=12,14,0,0,929,33961,0,0,1498,88082,0,0,410,8810,0,0;QS=3,0;MQSB=0.771623;MQ0F=0 PL:DP:DV 0,30,245:10:0 0,15,141:5:0 0,33,255:11:0 +17 1342 . A 0 . DP=27;I16=12,15,0,0,951,34575,0,0,1558,91682,0,0,439,9499,0,0;QS=3,0;MQSB=0.765017;MQ0F=0 PL:DP:DV 0,33,254:11:0 0,15,159:5:0 0,33,249:11:0 +17 1343 . C 0 . DP=25;I16=10,15,0,0,902,33364,0,0,1469,87241,0,0,445,9593,0,0;QS=3,0;MQSB=0.9171;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,140:5:0 0,30,233:10:0 +17 1344 . C 0 . DP=26;I16=10,16,0,0,985,37915,0,0,1529,90841,0,0,451,9715,0,0;QS=3,0;MQSB=0.914947;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,163:6:0 0,30,238:10:0 +17 1345 . T 0 . DP=26;I16=10,16,0,0,1004,39262,0,0,1529,90841,0,0,458,9866,0,0;QS=3,0;MQSB=0.914947;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,182:6:0 0,30,242:10:0 +17 1346 . G 0 . DP=26;I16=10,16,0,0,1003,38983,0,0,1529,90841,0,0,465,10047,0,0;QS=3,0;MQSB=0.914947;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,172:6:0 0,30,239:10:0 +17 1347 . A 0 . DP=26;I16=10,16,0,0,995,38409,0,0,1529,90841,0,0,470,10156,0,0;QS=3,0;MQSB=0.914947;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,177:6:0 0,30,243:10:0 +17 1348 . T 0 . DP=26;I16=10,16,0,0,988,38126,0,0,1529,90841,0,0,474,10242,0,0;QS=3,0;MQSB=0.914947;MQ0F=0 PL:DP:DV 0,30,252:10:0 0,18,185:6:0 0,30,251:10:0 +17 1349 . T 0 . DP=26;I16=9,15,0,0,905,34409,0,0,1409,83641,0,0,454,9730,0,0;QS=3,0;MQSB=0.904837;MQ0F=0 PL:DP:DV 0,24,225:8:0 0,18,176:6:0 0,30,248:10:0 +17 1350 . T 0 . DP=26;I16=10,16,0,0,975,36909,0,0,1498,88082,0,0,485,10495,0,0;QS=3,0;MQSB=0.700784;MQ0F=0 PL:DP:DV 0,27,242:9:0 0,21,195:7:0 0,30,249:10:0 +17 1351 . T 0 . DP=26;I16=10,16,0,0,956,35602,0,0,1498,88082,0,0,491,10663,0,0;QS=3,0;MQSB=0.700784;MQ0F=0 PL:DP:DV 0,27,238:9:0 0,21,193:7:0 0,30,240:10:0 +17 1352 . A 0 . DP=26;I16=10,16,0,0,901,31965,0,0,1498,88082,0,0,496,10810,0,0;QS=3,0;MQSB=0.700784;MQ0F=0 PL:DP:DV 0,27,250:9:0 0,21,180:7:0 0,30,211:10:0 +17 1353 . A 0 . DP=26;I16=10,16,0,0,927,33583,0,0,1498,88082,0,0,499,10885,0,0;QS=3,0;MQSB=0.700784;MQ0F=0 PL:DP:DV 0,27,240:9:0 0,21,187:7:0 0,30,224:10:0 +17 1354 . A 0 . DP=26;I16=10,16,0,0,927,33621,0,0,1498,88082,0,0,502,10986,0,0;QS=3,0;MQSB=0.700784;MQ0F=0 PL:DP:DV 0,27,237:9:0 0,21,190:7:0 0,30,223:10:0 +17 1355 . A 0 . DP=26;I16=10,16,0,0,924,33736,0,0,1498,88082,0,0,505,11113,0,0;QS=3,0;MQSB=0.700784;MQ0F=0 PL:DP:DV 0,27,239:9:0 0,21,186:7:0 0,30,227:10:0 +17 1356 . A 0 . DP=25;I16=10,15,0,0,916,34050,0,0,1438,84482,0,0,509,11265,0,0;QS=3,0;MQSB=0.707404;MQ0F=0 PL:DP:DV 0,27,249:9:0 0,21,178:7:0 0,27,226:9:0 +17 1357 . A 0 . DP=25;I16=9,15,0,0,949,38007,0,0,1378,80882,0,0,488,10816,0,0;QS=3,0;MQSB=0.67032;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,21,193:7:0 0,24,217:8:0 +17 1358 . G 0 . DP=25;I16=9,15,0,0,873,32435,0,0,1378,80882,0,0,491,10967,0,0;QS=3,0;MQSB=0.67032;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,21,172:7:0 0,24,188:8:0 +17 1359 . T 0 . DP=25;I16=9,15,0,0,857,31139,0,0,1378,80882,0,0,494,11144,0,0;QS=3,0;MQSB=0.67032;MQ0F=0 PL:DP:DV 0,27,232:9:0 0,21,184:7:0 0,24,196:8:0 +17 1360 . T 0 . DP=25;I16=9,15,0,0,879,32419,0,0,1378,80882,0,0,497,11347,0,0;QS=3,0;MQSB=0.67032;MQ0F=0 PL:DP:DV 0,27,248:9:0 0,21,184:7:0 0,24,192:8:0 +17 1361 . T 0 . DP=27;I16=9,17,0,0,936,34238,0,0,1498,88082,0,0,500,11576,0,0;QS=3,0;MQSB=0.657209;MQ0F=0 PL:DP:DV 0,27,234:9:0 0,24,201:8:0 0,27,206:9:0 +17 1362 . G 0 . DP=26;I16=9,17,0,0,973,36785,0,0,1498,88082,0,0,502,11680,0,0;QS=3,0;MQSB=0.657209;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,24,202:8:0 0,27,207:9:0 +17 1363 . G 0 . DP=25;I16=8,17,0,0,936,35390,0,0,1438,84482,0,0,504,11756,0,0;QS=3,0;MQSB=0.612391;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,21,181:7:0 0,27,202:9:0 +17 1364 . G 0 . DP=25;I16=8,17,0,0,902,32840,0,0,1438,84482,0,0,504,11752,0,0;QS=3,0;MQSB=0.612391;MQ0F=0 PL:DP:DV 0,27,233:9:0 0,21,184:7:0 0,27,200:9:0 +17 1365 . G 0 . DP=26;I16=9,17,0,0,946,35224,0,0,1498,88082,0,0,503,11717,0,0;QS=3,0;MQSB=0.657209;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,24,190:8:0 0,27,202:9:0 +17 1366 . G 0 . DP=25;I16=8,15,0,0,840,31058,0,0,1318,77282,0,0,454,10450,0,0;QS=3,0;MQSB=0.625784;MQ0F=0 PL:DP:DV 0,21,215:7:0 0,21,181:7:0 0,27,199:9:0 +17 1367 . G C, 0 . DP=25;I16=7,16,0,1,836,30888,27,729,1349,80041,60,3600,472,11152,15,225;QS=2.91641,0.0835913,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.864405;BQB=1;MQ0F=0 PL:DP:DV 0,24,236,24,236,236:8:0 0,21,179,21,179,179:7:0 0,0,171,24,174,189:9:1 +17 1368 . A 0 . DP=26;I16=8,17,0,0,869,30839,0,0,1438,84482,0,0,481,11095,0,0;QS=3,0;MQSB=0.612391;MQ0F=0 PL:DP:DV 0,27,240:9:0 0,21,180:7:0 0,27,197:9:0 +17 1369 . T 0 . DP=26;I16=8,18,0,0,902,32160,0,0,1498,88082,0,0,508,11758,0,0;QS=3,0;MQSB=0.606531;MQ0F=0 PL:DP:DV 0,27,242:9:0 0,24,197:8:0 0,27,194:9:0 +17 1370 . T 0 . DP=27;I16=8,17,0,0,926,34736,0,0,1438,84482,0,0,458,10466,0,0;QS=3,0;MQSB=0.612391;MQ0F=0 PL:DP:DV 0,27,238:9:0 0,21,195:7:0 0,27,215:9:0 +17 1371 . C 0 . DP=27;I16=8,19,0,0,929,33255,0,0,1558,91682,0,0,509,11695,0,0;QS=3,0;MQSB=0.601139;MQ0F=0 PL:DP:DV 0,27,241:9:0 0,24,196:8:0 0,30,196:10:0 +17 1372 . C 0 . DP=27;I16=8,19,0,0,954,34882,0,0,1558,91682,0,0,510,11696,0,0;QS=3,0;MQSB=0.601139;MQ0F=0 PL:DP:DV 0,27,251:9:0 0,24,198:8:0 0,30,200:10:0 +17 1373 . C 0 . DP=26;I16=8,17,0,0,892,32692,0,0,1438,84482,0,0,486,11044,0,0;QS=3,0;MQSB=0.612391;MQ0F=0 PL:DP:DV 0,24,243:8:0 0,21,186:7:0 0,30,195:10:0 +17 1374 . C 0 . DP=26;I16=8,17,0,0,953,36553,0,0,1438,84482,0,0,487,11039,0,0;QS=3,0;MQSB=0.612391;MQ0F=0 PL:DP:DV 0,24,249:8:0 0,21,193:7:0 0,30,211:10:0 +17 1375 . T 0 . DP=27;I16=9,18,0,0,1011,38377,0,0,1558,91682,0,0,512,11630,0,0;QS=3,0;MQSB=0.651439;MQ0F=0 PL:DP:DV 0,27,243:9:0 0,24,215:8:0 0,30,215:10:0 +17 1376 . A 0 . DP=27;I16=9,17,0,0,912,32444,0,0,1498,88082,0,0,488,10992,0,0;QS=3,0;MQSB=0.657209;MQ0F=0 PL:DP:DV 0,27,234:9:0 0,21,198:7:0 0,30,195:10:0 +17 1377 . A 0 . DP=26;I16=9,17,0,0,994,38518,0,0,1498,88082,0,0,515,11625,0,0;QS=3,0;MQSB=0.657209;MQ0F=0 PL:DP:DV 0,24,228:8:0 0,24,221:8:0 0,30,228:10:0 +17 1378 . G 0 . DP=26;I16=9,17,0,0,910,33180,0,0,1498,88082,0,0,517,11653,0,0;QS=3,0;MQSB=0.657209;MQ0F=0 PL:DP:DV 0,24,234:8:0 0,24,199:8:0 0,30,197:10:0 +17 1379 . C 0 . DP=26;I16=9,17,0,0,891,31779,0,0,1498,88082,0,0,519,11701,0,0;QS=3,0;MQSB=0.657209;MQ0F=0 PL:DP:DV 0,24,228:8:0 0,24,198:8:0 0,30,193:10:0 +17 1380 . C 0 . DP=26;I16=9,17,0,0,925,33925,0,0,1498,88082,0,0,520,11720,0,0;QS=3,0;MQSB=0.657209;MQ0F=0 PL:DP:DV 0,24,226:8:0 0,24,202:8:0 0,30,209:10:0 +17 1381 . C 0 . DP=28;I16=10,18,0,0,878,28560,0,0,1618,95282,0,0,521,11761,0,0;QS=3,0;MQSB=0.689069;MQ0F=0 PL:DP:DV 0,24,211:8:0 0,24,177:8:0 0,36,208:12:0 +17 1382 . G 0 . DP=28;I16=8,18,0,0,905,32553,0,0,1529,90841,0,0,482,10912,0,0;QS=3,0;MQSB=0.882497;MQ0F=0 PL:DP:DV 0,24,213:8:0 0,18,152:6:0 0,36,243:12:0 +17 1383 . C 0 . DP=27;I16=10,16,0,0,897,32373,0,0,1498,88082,0,0,502,11242,0,0;QS=3,0;MQSB=0.700784;MQ0F=0 PL:DP:DV 0,24,225:8:0 0,21,163:7:0 0,33,241:11:0 +17 1384 . C 0 . DP=28;I16=11,17,0,0,980,35558,0,0,1618,95282,0,0,529,11885,0,0;QS=3,0;MQSB=0.726331;MQ0F=0 PL:DP:DV 0,27,248:9:0 0,24,184:8:0 0,33,239:11:0 +17 1385 . A 0 . DP=30;I16=11,18,0,0,949,33215,0,0,1678,98882,0,0,508,11356,0,0;QS=3,0;MQSB=0.720887;MQ0F=0 PL:DP:DV 0,30,232:10:0 0,27,185:9:0 0,30,234:10:0 +17 1386 . C 0 . DP=30;I16=11,19,0,0,1088,39938,0,0,1738,102482,0,0,537,12011,0,0;QS=3,0;MQSB=0.715831;MQ0F=0 PL:DP:DV 0,30,248:10:0 0,27,218:9:0 0,33,255:11:0 +17 1387 . C 0 . DP=31;I16=12,19,0,0,1101,40297,0,0,1798,106082,0,0,540,12022,0,0;QS=3,0;MQSB=0.743137;MQ0F=0 PL:DP:DV 0,33,250:11:0 0,27,219:9:0 0,33,252:11:0 +17 1388 . C 0 . DP=31;I16=11,19,0,0,999,34081,0,0,1769,105241,0,0,519,11439,0,0;QS=3,0;MQSB=0.91982;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,185:8:0 0,33,211:11:0 +17 1389 . G 0 . DP=31;I16=11,19,0,0,1065,39119,0,0,1738,102482,0,0,535,11941,0,0;QS=3,0;MQSB=0.715831;MQ0F=0 PL:DP:DV 0,27,234:9:0 0,30,234:10:0 0,33,255:11:0 +17 1390 . G 0 . DP=31;I16=12,19,0,0,1152,43744,0,0,1798,106082,0,0,555,12241,0,0;QS=3,0;MQSB=0.743137;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,30,245:10:0 0,33,255:11:0 +17 1391 . A 0 . DP=31;I16=12,19,0,0,1241,50255,0,0,1798,106082,0,0,560,12326,0,0;QS=3,0;MQSB=0.743137;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,30,255:10:0 0,33,255:11:0 +17 1392 . G 0 . DP=31;I16=12,19,0,0,1160,44364,0,0,1798,106082,0,0,564,12392,0,0;QS=3,0;MQSB=0.743137;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,30,250:10:0 0,33,255:11:0 +17 1393 . A 0 . DP=31;I16=12,19,0,0,1123,41811,0,0,1798,106082,0,0,568,12490,0,0;QS=3,0;MQSB=0.743137;MQ0F=0 PL:DP:DV 0,30,228:10:0 0,30,255:10:0 0,33,255:11:0 +17 1394 . C 0 . DP=31;I16=12,19,0,0,1139,42555,0,0,1798,106082,0,0,571,12569,0,0;QS=3,0;MQSB=0.743137;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,30,244:10:0 0,33,255:11:0 +17 1395 . A 0 . DP=31;I16=12,19,0,0,1206,48048,0,0,1798,106082,0,0,575,12677,0,0;QS=3,0;MQSB=0.743137;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,240:9:0 0,33,255:11:0 +17 1396 . G 0 . DP=31;I16=12,19,0,0,1196,46882,0,0,1798,106082,0,0,579,12763,0,0;QS=3,0;MQSB=0.743137;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,249:9:0 0,33,255:11:0 +17 1397 . C 0 . DP=31;I16=12,18,0,0,993,33339,0,0,1738,102482,0,0,579,12775,0,0;QS=3,0;MQSB=0.748022;MQ0F=0 PL:DP:DV 0,30,231:10:0 0,27,205:9:0 0,33,217:11:0 +17 1398 . G 0 . DP=30;I16=12,18,0,0,1055,38309,0,0,1738,102482,0,0,584,12826,0,0;QS=3,0;MQSB=0.748022;MQ0F=0 PL:DP:DV 0,33,250:11:0 0,27,229:9:0 0,30,244:10:0 +17 1399 . G 0 . DP=30;I16=12,18,0,0,1132,43666,0,0,1738,102482,0,0,586,12854,0,0;QS=3,0;MQSB=0.748022;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,239:9:0 0,30,255:10:0 +17 1400 . A 0 . DP=30;I16=11,18,0,0,1101,42271,0,0,1678,98882,0,0,563,12289,0,0;QS=3,0;MQSB=0.720887;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,27,239:9:0 0,30,246:10:0 +17 1401 . T 0 . DP=30;I16=12,18,0,0,1130,44170,0,0,1738,102482,0,0,589,12955,0,0;QS=3,0;MQSB=0.748022;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,251:9:0 0,30,255:10:0 +17 1402 . T 0 . DP=31;I16=13,18,0,0,1152,44058,0,0,1798,106082,0,0,589,12977,0,0;QS=3,0;MQSB=0.771348;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,244:9:0 0,30,255:10:0 +17 1403 . T 0 . DP=31;I16=13,18,0,0,1178,45296,0,0,1798,106082,0,0,590,13032,0,0;QS=3,0;MQSB=0.771348;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,249:9:0 0,30,255:10:0 +17 1404 . C 0 . DP=31;I16=13,18,0,0,1102,40838,0,0,1798,106082,0,0,591,13121,0,0;QS=3,0;MQSB=0.771348;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,236:9:0 0,30,244:10:0 +17 1405 . C 0 . DP=30;I16=12,18,0,0,1154,45216,0,0,1738,102482,0,0,593,13243,0,0;QS=3,0;MQSB=0.748022;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,241:9:0 0,27,229:9:0 +17 1406 . T 0 . DP=30;I16=12,18,0,0,1153,44919,0,0,1738,102482,0,0,595,13397,0,0;QS=3,0;MQSB=0.748022;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,248:9:0 0,27,223:9:0 +17 1407 . T 0 . DP=30;I16=11,18,0,0,1074,40182,0,0,1678,98882,0,0,570,12856,0,0;QS=3,0;MQSB=0.720887;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,231:9:0 0,27,215:9:0 +17 1408 . A 0 . DP=30;I16=12,18,0,0,1131,43363,0,0,1738,102482,0,0,596,13592,0,0;QS=3,0;MQSB=0.748022;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,30,244:10:0 0,27,234:9:0 +17 1409 . G 0 . DP=29;I16=12,17,0,0,1082,40752,0,0,1678,98882,0,0,599,13729,0,0;QS=3,0;MQSB=0.753269;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,237:9:0 0,27,204:9:0 +17 1410 . T 0 . DP=29;I16=12,17,0,0,1084,41030,0,0,1678,98882,0,0,601,13841,0,0;QS=3,0;MQSB=0.753269;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,239:9:0 0,27,218:9:0 +17 1411 . T 0 . DP=29;I16=12,17,0,0,958,32550,0,0,1678,98882,0,0,600,13826,0,0;QS=3,0;MQSB=0.753269;MQ0F=0 PL:DP:DV 0,33,250:11:0 0,27,206:9:0 0,27,194:9:0 +17 1412 . A T, 0 . DP=29;I16=11,17,1,0,924,31586,25,625,1649,98041,29,841,573,13159,24,576;QS=2.90842,0.0915751,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.753269;BQB=1;MQ0F=0 PL:DP:DV 0,33,245,33,245,245:11:0 0,2,171,24,174,187:9:1 0,27,192,27,192,192:9:0 +17 1413 . C 0 . DP=29;I16=12,17,0,0,1067,39941,0,0,1678,98882,0,0,591,13521,0,0;QS=3,0;MQSB=0.753269;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,230:9:0 0,27,209:9:0 +17 1414 . T 0 . DP=29;I16=12,17,0,0,1123,44271,0,0,1678,98882,0,0,585,13335,0,0;QS=3,0;MQSB=0.753269;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,236:9:0 0,27,221:9:0 +17 1415 . T 0 . DP=29;I16=12,17,0,0,1000,35254,0,0,1678,98882,0,0,577,13077,0,0;QS=3,0;MQSB=0.753269;MQ0F=0 PL:DP:DV 0,33,246:11:0 0,27,216:9:0 0,27,208:9:0 +17 1416 . A 0 . DP=30;I16=13,17,0,0,1026,36124,0,0,1738,102482,0,0,569,12847,0,0;QS=3,0;MQSB=0.776389;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,208:9:0 0,27,199:9:0 +17 1417 . C 0 . DP=29;I16=13,16,0,0,1111,42941,0,0,1678,98882,0,0,563,12645,0,0;QS=3,0;MQSB=0.781802;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,235:9:0 0,24,211:8:0 +17 1418 . T 0 . DP=29;I16=13,16,0,0,1111,43021,0,0,1678,98882,0,0,557,12471,0,0;QS=3,0;MQSB=0.781802;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,231:9:0 0,24,207:8:0 +17 1419 . A 0 . DP=29;I16=13,16,0,0,1039,38191,0,0,1678,98882,0,0,551,12325,0,0;QS=3,0;MQSB=0.781802;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,222:9:0 0,24,199:8:0 +17 1420 . T 0 . DP=29;I16=13,16,0,0,1039,37885,0,0,1678,98882,0,0,544,12158,0,0;QS=3,0;MQSB=0.781802;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,234:9:0 0,24,185:8:0 +17 1421 . G 0 . DP=31;I16=13,18,0,0,1129,41649,0,0,1798,106082,0,0,536,11970,0,0;QS=3,0;MQSB=0.771348;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,30,247:10:0 0,24,191:8:0 +17 1422 . C 0 . DP=29;I16=13,16,0,0,1075,40645,0,0,1678,98882,0,0,532,11810,0,0;QS=3,0;MQSB=0.781802;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,30,239:10:0 0,18,180:6:0 +17 1423 . T 0 . DP=31;I16=14,17,0,0,1179,45767,0,0,1798,106082,0,0,528,11678,0,0;QS=3,0;MQSB=0.79638;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,36,255:12:0 0,18,183:6:0 +17 1424 . C 0 . DP=30;I16=13,17,0,0,1086,40448,0,0,1738,102482,0,0,527,11575,0,0;QS=3,0;MQSB=0.776389;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,36,255:12:0 0,18,174:6:0 +17 1425 . C 0 . DP=30;I16=13,17,0,0,1124,42974,0,0,1738,102482,0,0,525,11453,0,0;QS=3,0;MQSB=0.776389;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,36,255:12:0 0,18,180:6:0 +17 1426 . T 0 . DP=32;I16=15,17,0,0,1218,47130,0,0,1858,109682,0,0,523,11363,0,0;QS=3,0;MQSB=0.813784;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,36,255:12:0 0,18,188:6:0 +17 1427 . T 0 . DP=32;I16=14,18,0,0,1126,40772,0,0,1827,106923,0,0,524,11306,0,0;QS=3,0;MQSB=0.916401;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,36,255:12:0 0,18,176:6:0 +17 1428 . G 0 . DP=33;I16=15,18,0,0,1188,43596,0,0,1887,110523,0,0,525,11233,0,0;QS=3,0;MQSB=0.930476;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,36,255:12:0 0,18,166:6:0 +17 1429 . G 0 . DP=33;I16=14,18,0,0,1070,37720,0,0,1858,109682,0,0,507,10795,0,0;QS=3,0;MQSB=0.997118;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,33,243:11:0 0,18,148:6:0 +17 1430 . C 0 . DP=33;I16=15,18,0,0,1145,40795,0,0,1887,110523,0,0,529,11193,0,0;QS=3,0;MQSB=0.930476;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,36,247:12:0 0,18,157:6:0 +17 1431 . C 0 . DP=33;I16=15,18,0,0,1160,41686,0,0,1887,110523,0,0,531,11227,0,0;QS=3,0;MQSB=0.930476;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,36,253:12:0 0,18,167:6:0 +17 1432 . A 0 . DP=33;I16=15,18,0,0,1118,39032,0,0,1887,110523,0,0,533,11297,0,0;QS=3,0;MQSB=0.930476;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,36,255:12:0 0,18,169:6:0 +17 1433 . T 0 . DP=34;I16=15,19,0,0,1238,45602,0,0,1947,114123,0,0,535,11403,0,0;QS=3,0;MQSB=0.923533;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,36,255:12:0 0,18,174:6:0 +17 1434 . T 0 . DP=35;I16=15,20,0,0,1269,46757,0,0,2007,117723,0,0,537,11495,0,0;QS=3,0;MQSB=0.916855;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,36,255:12:0 0,18,179:6:0 +17 1435 . T 0 . DP=35;I16=14,20,0,0,1256,46868,0,0,1947,114123,0,0,515,10999,0,0;QS=3,0;MQSB=0.901704;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,36,255:12:0 0,18,180:6:0 +17 1436 . C 0 . DP=34;I16=14,20,0,0,1250,46978,0,0,1947,114123,0,0,544,11790,0,0;QS=3,0;MQSB=0.901704;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,36,255:12:0 0,18,165:6:0 +17 1437 . T 0 . DP=32;I16=13,19,0,0,1222,47206,0,0,1858,109682,0,0,548,11892,0,0;QS=3,0;MQSB=0.993397;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,33,255:11:0 0,15,161:5:0 +17 1438 . C 0 . DP=30;I16=13,17,0,0,1132,43284,0,0,1738,102482,0,0,554,12028,0,0;QS=3,0;MQSB=0.996503;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,30,251:10:0 0,15,159:5:0 +17 1439 . T 0 . DP=30;I16=13,17,0,0,1110,41602,0,0,1738,102482,0,0,560,12196,0,0;QS=3,0;MQSB=0.996503;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,30,255:10:0 0,15,156:5:0 +17 1440 . A 0 . DP=30;I16=12,16,0,0,1062,41028,0,0,1618,95282,0,0,550,12106,0,0;QS=3,0;MQSB=0.995699;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,27,255:9:0 0,12,144:4:0 +17 1441 . G 0 . DP=30;I16=13,17,0,0,1138,44104,0,0,1738,102482,0,0,574,12576,0,0;QS=3,0;MQSB=0.996503;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,30,244:10:0 0,12,137:4:0 +17 1442 . G 0 . DP=30;I16=13,17,0,0,1064,38534,0,0,1738,102482,0,0,580,12740,0,0;QS=3,0;MQSB=0.996503;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,30,242:10:0 0,12,128:4:0 +17 1443 . T 0 . DP=30;I16=12,17,0,0,1013,36225,0,0,1678,98882,0,0,568,12598,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,30,230:10:0 0,12,133:4:0 +17 1444 . A 0 . DP=30;I16=12,17,0,0,968,33936,0,0,1678,98882,0,0,569,12627,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,27,205:9:0 0,12,132:4:0 +17 1445 . T 0 . DP=30;I16=14,15,0,0,1053,39129,0,0,1678,98882,0,0,585,13161,0,0;QS=3,0;MQSB=0.999762;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,27,237:9:0 0,15,169:5:0 +17 1446 . T 0 . DP=30;I16=13,16,0,0,1051,38675,0,0,1678,98882,0,0,579,12951,0,0;QS=3,0;MQSB=0.997839;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,229:8:0 0,15,164:5:0 +17 1447 . G 0 . DP=30;I16=14,16,0,0,1110,42692,0,0,1738,102482,0,0,606,13612,0,0;QS=3,0;MQSB=0.999136;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,27,229:9:0 0,15,157:5:0 +17 1448 . G 0 . DP=30;I16=13,16,0,0,1037,37759,0,0,1678,98882,0,0,585,13151,0,0;QS=3,0;MQSB=0.997839;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,217:8:0 0,15,150:5:0 +17 1449 . T 0 . DP=30;I16=14,16,0,0,1051,37869,0,0,1738,102482,0,0,612,13870,0,0;QS=3,0;MQSB=0.999136;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,27,230:9:0 0,15,152:5:0 +17 1450 . A 0 . DP=29;I16=13,15,0,0,1039,38785,0,0,1649,98041,0,0,604,13842,0,0;QS=3,0;MQSB=0.956162;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,24,224:8:0 0,15,165:5:0 +17 1451 . T 0 . DP=29;I16=13,16,0,0,1046,38586,0,0,1709,101641,0,0,616,14042,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,228:8:0 0,15,158:5:0 +17 1452 . A 0 . DP=31;I16=14,16,0,0,1066,38696,0,0,1769,105241,0,0,604,13924,0,0;QS=3,0;MQSB=0.958545;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,218:8:0 0,15,147:5:0 +17 1453 . T 0 . DP=31;I16=13,17,0,0,1107,42059,0,0,1769,105241,0,0,592,13444,0,0;QS=3,0;MQSB=0.963674;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,199:7:0 0,15,165:5:0 +17 1454 . T 0 . DP=31;I16=14,17,0,0,1139,42711,0,0,1829,108841,0,0,617,14045,0,0;QS=3,0;MQSB=0.962133;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,24,234:8:0 0,15,166:5:0 +17 1455 . G 0 . DP=31;I16=13,17,0,0,1107,41765,0,0,1769,105241,0,0,592,13420,0,0;QS=3,0;MQSB=0.963674;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,197:7:0 0,15,148:5:0 +17 1456 . T 0 . DP=31;I16=14,17,0,0,1139,42717,0,0,1829,108841,0,0,617,14069,0,0;QS=3,0;MQSB=0.962133;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,24,215:8:0 0,15,170:5:0 +17 1457 . G 0 . DP=31;I16=14,17,0,0,1129,42071,0,0,1829,108841,0,0,615,14019,0,0;QS=3,0;MQSB=0.962133;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,24,212:8:0 0,15,164:5:0 +17 1458 . T 0 . DP=31;I16=14,17,0,0,1101,40243,0,0,1829,108841,0,0,613,13997,0,0;QS=3,0;MQSB=0.962133;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,24,220:8:0 0,15,165:5:0 +17 1459 . C A, 0 . DP=31;I16=14,16,0,1,1164,45842,24,576,1769,105241,60,3600,608,13948,2,4;QS=2.87234,0.12766,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.962133;BQB=1;MQ0F=0 PL:DP:DV 0,54,255,54,255,255:18:0 0,24,224,24,224,224:8:0 9,0,135,21,138,152:5:1 +17 1460 . T 0 . DP=32;I16=15,17,0,0,1243,48813,0,0,1889,112441,0,0,605,13833,0,0;QS=3,0;MQSB=0.960687;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,24,240:8:0 0,15,170:5:0 +17 1461 . G 0 . DP=32;I16=15,17,0,0,1171,44033,0,0,1889,112441,0,0,600,13692,0,0;QS=3,0;MQSB=0.960687;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,24,224:8:0 0,15,157:5:0 +17 1462 . C 0 . DP=30;I16=14,15,0,0,1102,42216,0,0,1709,101641,0,0,579,13241,0,0;QS=3,0;MQSB=0.954405;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,202:7:0 0,9,112:3:0 +17 1463 . T 0 . DP=30;I16=15,15,0,0,1128,43348,0,0,1769,105241,0,0,592,13396,0,0;QS=3,0;MQSB=0.952765;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,209:7:0 0,12,139:4:0 +17 1464 . G 0 . DP=31;I16=14,16,0,0,1095,40557,0,0,1769,105241,0,0,563,12665,0,0;QS=3,0;MQSB=0.958545;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,186:6:0 0,15,144:5:0 +17 1465 . T 0 . DP=31;I16=15,16,0,0,1143,42557,0,0,1829,108841,0,0,584,13164,0,0;QS=3,0;MQSB=0.957006;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,204:7:0 0,15,166:5:0 +17 1466 . G 0 . DP=31;I16=15,16,0,0,1122,42294,0,0,1829,108841,0,0,580,13018,0,0;QS=3,0;MQSB=0.957006;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,206:7:0 0,15,163:5:0 +17 1467 . A 0 . DP=31;I16=14,16,0,0,1031,36341,0,0,1769,105241,0,0,569,12803,0,0;QS=3,0;MQSB=0.958545;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,195:7:0 0,15,155:5:0 +17 1468 . A 0 . DP=30;I16=15,15,0,0,991,34477,0,0,1769,105241,0,0,573,12717,0,0;QS=3,0;MQSB=0.952765;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,177:7:0 0,15,158:5:0 +17 1469 . C T, 0 . DP=31;I16=13,15,1,0,1013,37887,38,1444,1649,98041,60,3600,536,12106,9,81;QS=2.94025,0.0597484,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.954405;BQB=1;MQ0F=0 PL:DP:DV 0,16,255,51,255,255:18:1 0,18,178,18,178,178:6:0 0,15,160,15,160,160:5:0 +17 1470 . T 0 . DP=31;I16=16,15,0,0,1110,41070,0,0,1829,108841,0,0,567,12489,0,0;QS=3,0;MQSB=0.951229;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,210:7:0 0,15,165:5:0 +17 1471 . G 0 . DP=30;I16=16,14,0,0,1051,38425,0,0,1769,105241,0,0,564,12348,0,0;QS=3,0;MQSB=0.946202;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,192:7:0 0,12,128:4:0 +17 1472 . T 0 . DP=30;I16=16,14,0,0,1049,38097,0,0,1769,105241,0,0,561,12237,0,0;QS=3,0;MQSB=0.946202;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,200:7:0 0,12,134:4:0 +17 1473 . C 0 . DP=30;I16=16,14,0,0,1058,38526,0,0,1769,105241,0,0,558,12156,0,0;QS=3,0;MQSB=0.946202;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,175:7:0 0,12,140:4:0 +17 1474 . C 0 . DP=30;I16=16,14,0,0,1120,42756,0,0,1769,105241,0,0,555,12105,0,0;QS=3,0;MQSB=0.946202;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,202:7:0 0,12,141:4:0 +17 1475 . T 0 . DP=29;I16=14,14,0,0,1047,40395,0,0,1649,98041,0,0,537,11827,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,208:7:0 0,12,155:4:0 +17 1476 . T G, 0 . DP=31;I16=15,15,1,0,1056,37884,14,196,1769,105241,60,3600,566,12614,10,100;QS=2.944,0.056,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.951229;BQB=1;MQ0F=0 PL:DP:DV 0,57,255,57,255,255:19:0 0,9,177,21,180,183:8:1 0,12,140,12,140,140:4:0 +17 1477 . G 0 . DP=31;I16=16,15,0,0,1150,43390,0,0,1829,108841,0,0,574,12700,0,0;QS=3,0;MQSB=0.951229;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,24,217:8:0 0,12,138:4:0 +17 1478 . G 0 . DP=31;I16=14,15,0,0,1008,36638,0,0,1709,101641,0,0,542,11982,0,0;QS=3,0;MQSB=0.954405;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,24,208:8:0 0,9,109:3:0 +17 1479 . C 0 . DP=30;I16=15,15,0,0,1061,38671,0,0,1769,105241,0,0,564,12556,0,0;QS=3,0;MQSB=0.952765;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,24,211:8:0 0,9,106:3:0 +17 1480 . C 0 . DP=30;I16=15,15,0,0,1083,40355,0,0,1769,105241,0,0,561,12531,0,0;QS=3,0;MQSB=0.952765;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,24,220:8:0 0,9,103:3:0 +17 1481 . T 0 . DP=30;I16=15,15,0,0,1102,41308,0,0,1769,105241,0,0,558,12532,0,0;QS=3,0;MQSB=0.952765;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,24,235:8:0 0,9,105:3:0 +17 1482 . G 0 . DP=29;I16=15,14,0,0,1044,38550,0,0,1709,101641,0,0,556,12558,0,0;QS=3,0;MQSB=0.947838;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,24,210:8:0 0,6,75:2:0 +17 1483 . T 0 . DP=31;I16=14,16,0,0,1042,37190,0,0,1769,105241,0,0,521,11919,0,0;QS=3,0;MQSB=0.958545;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,21,215:7:0 0,9,100:3:0 +17 1484 . T 0 . DP=31;I16=15,16,0,0,1067,37837,0,0,1829,108841,0,0,547,12587,0,0;QS=3,0;MQSB=0.957006;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,24,216:8:0 0,9,106:3:0 +17 1485 . T 0 . DP=30;I16=15,15,0,0,1027,35863,0,0,1769,105241,0,0,549,12659,0,0;QS=3,0;MQSB=0.952765;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,24,209:8:0 0,9,93:3:0 +17 1486 . G 0 . DP=29;I16=15,14,0,0,1089,41679,0,0,1709,101641,0,0,551,12707,0,0;QS=3,0;MQSB=0.947838;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,198:7:0 0,9,108:3:0 +17 1487 . G 0 . DP=28;I16=14,14,0,0,973,34723,0,0,1649,98041,0,0,554,12778,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,196:7:0 0,9,97:3:0 +17 1488 . T 0 . DP=28;I16=13,14,0,0,928,32432,0,0,1589,94441,0,0,532,12246,0,0;QS=3,0;MQSB=0.951472;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,176:6:0 0,9,102:3:0 +17 1489 . G 0 . DP=27;I16=13,14,0,0,958,35292,0,0,1589,94441,0,0,535,12361,0,0;QS=3,0;MQSB=0.951472;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,174:6:0 0,9,93:3:0 +17 1490 . A 0 . DP=27;I16=13,14,0,0,928,33108,0,0,1589,94441,0,0,538,12446,0,0;QS=3,0;MQSB=0.951472;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,160:5:0 0,9,94:3:0 +17 1491 . C 0 . DP=27;I16=12,13,0,0,798,26812,0,0,1469,87241,0,0,499,11587,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,12,108:4:0 0,9,79:3:0 +17 1492 . G 0 . DP=27;I16=13,14,0,0,893,30927,0,0,1589,94441,0,0,543,12527,0,0;QS=3,0;MQSB=0.951472;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,136:5:0 0,9,100:3:0 +17 1493 . G 0 . DP=27;I16=13,13,0,0,907,32761,0,0,1529,90841,0,0,520,11948,0,0;QS=3,0;MQSB=0.945959;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,155:5:0 0,9,106:3:0 +17 1494 . G 0 . DP=27;I16=13,14,0,0,939,33599,0,0,1589,94441,0,0,547,12639,0,0;QS=3,0;MQSB=0.951472;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,156:5:0 0,9,107:3:0 +17 1495 . T 0 . DP=26;I16=12,13,0,0,814,27700,0,0,1469,87241,0,0,524,12048,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,143:5:0 0,9,105:3:0 +17 1496 . G 0 . DP=26;I16=13,13,0,0,969,36751,0,0,1529,90841,0,0,550,12674,0,0;QS=3,0;MQSB=0.945959;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,157:5:0 0,9,107:3:0 +17 1497 . A 0 . DP=27;I16=12,14,0,0,904,32740,0,0,1529,90841,0,0,525,12019,0,0;QS=3,0;MQSB=0.953497;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,166:5:0 0,9,113:3:0 +17 1498 . G 0 . DP=27;I16=13,14,0,0,1002,37852,0,0,1589,94441,0,0,551,12635,0,0;QS=3,0;MQSB=0.951472;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,153:5:0 0,9,112:3:0 +17 1499 . G 0 . DP=28;I16=14,14,0,0,973,34891,0,0,1649,98041,0,0,551,12599,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,15,146:5:0 0,9,108:3:0 +17 1500 . A 0 . DP=28;I16=14,14,0,0,1023,38115,0,0,1649,98041,0,0,552,12588,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,15,165:5:0 0,9,115:3:0 +17 1501 . G 0 . DP=28;I16=14,14,0,0,1051,40105,0,0,1649,98041,0,0,551,12505,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,15,163:5:0 0,9,100:3:0 +17 1502 . C 0 . DP=27;I16=13,14,0,0,963,35241,0,0,1589,94441,0,0,549,12351,0,0;QS=3,0;MQSB=0.951472;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,140:5:0 0,9,105:3:0 +17 1503 . A 0 . DP=28;I16=14,14,0,0,1026,38252,0,0,1649,98041,0,0,546,12176,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,15,171:5:0 0,9,109:3:0 +17 1504 . G 0 . DP=28;I16=13,14,0,0,1052,41226,0,0,1589,94441,0,0,523,11591,0,0;QS=3,0;MQSB=0.951472;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,163:5:0 0,9,111:3:0 +17 1505 . G 0 . DP=28;I16=14,13,0,0,959,35545,0,0,1589,94441,0,0,517,11295,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,155:5:0 0,9,114:3:0 +17 1506 . G 0 . DP=28;I16=14,14,0,0,1013,37355,0,0,1649,98041,0,0,540,11840,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,15,139:5:0 0,9,112:3:0 +17 1507 . A 0 . DP=28;I16=14,14,0,0,987,35217,0,0,1649,98041,0,0,538,11792,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,15,162:5:0 0,9,114:3:0 +17 1508 . C 0 . DP=28;I16=14,14,0,0,1033,38663,0,0,1649,98041,0,0,535,11727,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,15,137:5:0 0,9,112:3:0 +17 1509 . A 0 . DP=28;I16=15,13,0,0,1028,38610,0,0,1649,98041,0,0,529,11493,0,0;QS=3,0;MQSB=0.942064;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,12,128:4:0 0,9,122:3:0 +17 1510 . G 0 . DP=28;I16=15,13,0,0,1064,40824,0,0,1649,98041,0,0,524,11288,0,0;QS=3,0;MQSB=0.942064;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,12,132:4:0 0,9,111:3:0 +17 1511 . A 0 . DP=28;I16=15,13,0,0,976,34794,0,0,1649,98041,0,0,519,11113,0,0;QS=3,0;MQSB=0.942064;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,12,136:4:0 0,9,110:3:0 +17 1512 . A 0 . DP=28;I16=15,12,0,0,998,37460,0,0,1589,94441,0,0,489,10343,0,0;QS=3,0;MQSB=0.935229;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,12,142:4:0 0,9,110:3:0 +17 1513 . G 0 . DP=28;I16=14,13,0,0,1014,38940,0,0,1589,94441,0,0,497,10709,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,12,134:4:0 0,9,108:3:0 +17 1514 . G 0 . DP=28;I16=15,13,0,0,1054,39954,0,0,1649,98041,0,0,504,10768,0,0;QS=3,0;MQSB=0.942064;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,12,134:4:0 0,9,108:3:0 +17 1515 . G 0 . DP=28;I16=14,13,0,0,948,34152,0,0,1589,94441,0,0,488,10564,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,12,133:4:0 0,9,101:3:0 +17 1516 . T 0 . DP=27;I16=12,13,0,0,811,27385,0,0,1469,87241,0,0,472,10338,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,12,117:4:0 0,9,106:3:0 +17 1517 . C 0 . DP=27;I16=13,13,0,0,943,35153,0,0,1529,90841,0,0,478,10380,0,0;QS=3,0;MQSB=0.945959;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,12,134:4:0 0,9,97:3:0 +17 1518 . C 0 . DP=28;I16=13,12,0,0,908,33852,0,0,1469,87241,0,0,427,9261,0,0;QS=3,0;MQSB=0.939413;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,12,132:4:0 0,9,96:3:0 +17 1519 . T 0 . DP=28;I16=15,13,0,0,988,35808,0,0,1649,98041,0,0,475,10337,0,0;QS=3,0;MQSB=0.942064;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,15,154:5:0 0,9,110:3:0 +17 1520 . G 0 . DP=29;I16=16,13,0,0,1005,36307,0,0,1709,101641,0,0,470,10328,0,0;QS=3,0;MQSB=0.940317;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,18,150:6:0 0,9,104:3:0 +17 1521 . C 0 . DP=28;I16=16,12,0,0,900,30324,0,0,1649,98041,0,0,466,10300,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,164:6:0 0,9,88:3:0 +17 1522 . G 0 . DP=27;I16=15,10,0,0,784,25144,0,0,1469,87241,0,0,442,9956,0,0;QS=3,0;MQSB=0.9171;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,110:5:0 0,9,91:3:0 +17 1523 . T 0 . DP=27;I16=16,11,0,0,921,32001,0,0,1589,94441,0,0,457,10189,0,0;QS=3,0;MQSB=0.925036;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,136:5:0 0,9,108:3:0 +17 1524 . G 0 . DP=27;I16=16,10,0,0,932,34140,0,0,1529,90841,0,0,453,10153,0,0;QS=3,0;MQSB=0.914947;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,12,108:4:0 0,9,103:3:0 +17 1525 . C 0 . DP=27;I16=16,11,0,0,972,35704,0,0,1589,94441,0,0,473,10719,0,0;QS=3,0;MQSB=0.925036;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,12,113:4:0 0,9,112:3:0 +17 1526 . C 0 . DP=25;I16=14,11,0,0,883,31843,0,0,1469,87241,0,0,470,10684,0,0;QS=3,0;MQSB=0.929204;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,12,109:4:0 0,9,106:3:0 +17 1527 . C 0 . DP=24;I16=14,10,0,0,867,31999,0,0,1440,86400,0,0,466,10572,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,107:4:0 0,9,112:3:0 +17 1528 . T 0 . DP=23;I16=13,10,0,0,869,33133,0,0,1380,82800,0,0,463,10483,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,114:4:0 0,9,113:3:0 +17 1529 . G 0 . DP=23;I16=13,10,0,0,812,29432,0,0,1380,82800,0,0,459,10365,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,108:4:0 0,9,104:3:0 +17 1530 . C 0 . DP=24;I16=13,10,0,0,819,30073,0,0,1380,82800,0,0,446,10186,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,137:5:0 0,9,106:3:0 +17 1531 . C 0 . DP=24;I16=13,11,0,0,877,32969,0,0,1440,86400,0,0,452,10190,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,144:5:0 0,9,105:3:0 +17 1532 . T 0 . DP=24;I16=13,11,0,0,887,33721,0,0,1440,86400,0,0,449,10135,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,165:5:0 0,9,120:3:0 +17 1533 . T 0 . DP=23;I16=13,10,0,0,793,27987,0,0,1380,82800,0,0,447,10101,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,146:5:0 0,9,107:3:0 +17 1534 . C 0 . DP=23;I16=14,9,0,0,847,31627,0,0,1380,82800,0,0,446,10086,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,153:5:0 0,9,109:3:0 +17 1535 . A 0 . DP=23;I16=14,9,0,0,770,26604,0,0,1380,82800,0,0,444,9990,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,144:5:0 0,9,99:3:0 +17 1536 . C 0 . DP=24;I16=15,9,0,0,826,28984,0,0,1440,86400,0,0,442,9914,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,138:5:0 0,9,110:3:0 +17 1537 . A 0 . DP=24;I16=14,9,0,0,844,31384,0,0,1380,82800,0,0,416,9234,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,149:5:0 0,9,115:3:0 +17 1538 . A 0 . DP=24;I16=15,9,0,0,909,34727,0,0,1440,86400,0,0,440,9826,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,154:5:0 0,9,112:3:0 +17 1539 . G 0 . DP=24;I16=15,9,0,0,913,35327,0,0,1440,86400,0,0,439,9815,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,149:5:0 0,9,117:3:0 +17 1540 . C 0 . DP=23;I16=15,8,0,0,828,30260,0,0,1380,82800,0,0,438,9776,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,146:5:0 0,9,102:3:0 +17 1541 . C 0 . DP=23;I16=15,8,0,0,823,30615,0,0,1380,82800,0,0,437,9759,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,142:5:0 0,9,108:3:0 +17 1542 . C 0 . DP=25;I16=16,8,0,0,893,33843,0,0,1440,86400,0,0,435,9715,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,147:5:0 0,12,131:4:0 +17 1543 . C 0 . DP=25;I16=16,8,0,0,880,33206,0,0,1440,86400,0,0,434,9696,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,141:5:0 0,12,136:4:0 +17 1544 . T 0 . DP=25;I16=16,8,0,0,899,34405,0,0,1440,86400,0,0,431,9603,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,150:5:0 0,12,148:4:0 +17 1545 . G 0 . DP=25;I16=16,8,0,0,874,32636,0,0,1440,86400,0,0,428,9536,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,146:5:0 0,12,129:4:0 +17 1546 . G 0 . DP=24;I16=15,8,0,0,796,28796,0,0,1380,82800,0,0,425,9443,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,130:5:0 0,9,110:3:0 +17 1547 . A 0 . DP=23;I16=15,8,0,0,837,30945,0,0,1380,82800,0,0,448,9996,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,176:6:0 0,9,112:3:0 +17 1548 . A 0 . DP=23;I16=14,8,0,0,812,30830,0,0,1320,79200,0,0,421,9319,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,173:5:0 0,9,115:3:0 +17 1549 . G 0 . DP=23;I16=15,8,0,0,870,33642,0,0,1380,82800,0,0,444,9912,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,174:6:0 0,9,114:3:0 +17 1550 . G 0 . DP=23;I16=15,8,0,0,790,28502,0,0,1380,82800,0,0,442,9900,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,154:6:0 0,9,109:3:0 +17 1551 . A 0 . DP=23;I16=15,8,0,0,802,28596,0,0,1380,82800,0,0,440,9908,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,173:6:0 0,9,107:3:0 +17 1552 . A 0 . DP=21;I16=14,7,0,0,792,30156,0,0,1260,75600,0,0,438,9836,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,196:6:0 0,9,110:3:0 +17 1553 . A 0 . DP=21;I16=13,7,0,0,738,28112,0,0,1200,72000,0,0,411,9159,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,251:11:0 0,18,192:6:0 0,9,115:3:0 +17 1554 . G 0 . DP=21;I16=14,7,0,0,763,28221,0,0,1260,75600,0,0,434,9752,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,171:6:0 0,9,101:3:0 +17 1555 . T 0 . DP=21;I16=14,7,0,0,726,26234,0,0,1260,75600,0,0,432,9740,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,252:12:0 0,18,169:6:0 0,9,108:3:0 +17 1556 . T 0 . DP=21;I16=14,7,0,0,745,26971,0,0,1260,75600,0,0,429,9697,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,253:12:0 0,18,177:6:0 0,9,110:3:0 +17 1557 . G 0 . DP=22;I16=15,7,0,0,801,29689,0,0,1320,79200,0,0,426,9672,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,166:6:0 0,9,101:3:0 +17 1558 . T 0 . DP=22;I16=15,6,0,0,720,25620,0,0,1260,75600,0,0,404,9244,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,131:5:0 0,9,112:3:0 +17 1559 . T 0 . DP=22;I16=15,7,0,0,712,24690,0,0,1320,79200,0,0,417,9439,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,248:13:0 0,18,158:6:0 0,9,103:3:0 +17 1560 . T 0 . DP=21;I16=14,7,0,0,736,26560,0,0,1260,75600,0,0,412,9284,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,251:12:0 0,18,170:6:0 0,9,112:3:0 +17 1561 . T 0 . DP=21;I16=14,7,0,0,706,24776,0,0,1260,75600,0,0,406,9102,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,241:12:0 0,18,174:6:0 0,9,106:3:0 +17 1562 . G 0 . DP=21;I16=14,7,0,0,765,28655,0,0,1260,75600,0,0,399,8893,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,181:6:0 0,9,108:3:0 +17 1563 . G 0 . DP=22;I16=13,7,0,0,713,26255,0,0,1200,72000,0,0,360,8176,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,147:5:0 0,9,108:3:0 +17 1564 . G 0 . DP=22;I16=13,8,0,0,721,25457,0,0,1260,75600,0,0,368,8218,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,173:6:0 0,9,95:3:0 +17 1565 . A 0 . DP=21;I16=14,7,0,0,724,25888,0,0,1260,75600,0,0,380,8352,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,162:6:0 0,6,71:2:0 +17 1566 . T 0 . DP=21;I16=13,7,0,0,698,25286,0,0,1200,72000,0,0,364,8086,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,143:5:0 0,6,78:2:0 +17 1567 . C 0 . DP=20;I16=12,6,0,0,652,24422,0,0,1080,64800,0,0,351,7881,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,104:3:0 0,6,72:2:0 +17 1568 . T 0 . DP=20;I16=13,7,0,0,711,26125,0,0,1200,72000,0,0,363,7871,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,157:5:0 0,6,74:2:0 +17 1569 . C 0 . DP=19;I16=12,6,0,0,676,25850,0,0,1080,64800,0,0,351,7669,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,128:4:0 0,6,76:2:0 +17 1570 . T 0 . DP=19;I16=12,7,0,0,700,26750,0,0,1140,68400,0,0,353,7583,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,149:5:0 0,6,71:2:0 +17 1571 . G 0 . DP=19;I16=12,6,0,0,639,23361,0,0,1080,64800,0,0,343,7441,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,125:4:0 0,6,70:2:0 +17 1572 . C 0 . DP=19;I16=11,6,0,0,640,24568,0,0,1020,61200,0,0,328,7202,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,125:4:0 0,6,70:2:0 +17 1573 . A 0 . DP=19;I16=11,4,0,0,565,21475,0,0,900,54000,0,0,304,6900,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,132:4:0 0,3,40:1:0 +17 1574 . C 0 . DP=19;I16=12,5,0,0,636,24076,0,0,1020,61200,0,0,318,6948,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,128:4:0 0,3,38:1:0 +17 1575 . C 0 . DP=19;I16=11,6,0,0,610,22742,0,0,1020,61200,0,0,296,6272,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,125:4:0 0,6,71:2:0 +17 1576 . C 0 . DP=19;I16=12,6,0,0,675,25821,0,0,1080,64800,0,0,315,6785,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,133:4:0 0,6,78:2:0 +17 1577 . T 0 . DP=17;I16=11,6,0,0,650,25330,0,0,1020,61200,0,0,310,6692,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,118:3:0 0,6,77:2:0 +17 1578 . C 0 . DP=17;I16=10,6,0,0,622,24364,0,0,960,57600,0,0,279,5943,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,84:2:0 0,6,77:2:0 +17 1579 . A 0 . DP=17;I16=11,6,0,0,596,22326,0,0,1020,61200,0,0,298,6464,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,116:3:0 0,6,80:2:0 +17 1580 . G 0 . DP=17;I16=11,6,0,0,651,25195,0,0,1020,61200,0,0,292,6380,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,109:3:0 0,6,77:2:0 +17 1581 . C 0 . DP=17;I16=11,6,0,0,586,21418,0,0,1020,61200,0,0,286,6316,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,103:3:0 0,6,71:2:0 +17 1582 . C 0 . DP=18;I16=11,7,0,0,639,23491,0,0,1080,64800,0,0,280,6272,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,109:3:0 0,6,75:2:0 +17 1583 . T 0 . DP=16;I16=10,6,0,0,591,22349,0,0,960,57600,0,0,276,6196,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,112:3:0 0,6,74:2:0 +17 1584 . G 0 . DP=15;I16=10,5,0,0,563,21283,0,0,900,54000,0,0,272,6086,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,105:3:0 0,3,39:1:0 +17 1585 . G 0 . DP=16;I16=10,5,0,0,494,17160,0,0,900,54000,0,0,251,5703,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,244:11:0 0,9,103:3:0 0,3,30:1:0 +17 1586 . A 0 . DP=15;I16=10,3,0,0,470,17200,0,0,780,46800,0,0,237,5273,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,223:10:0 0,6,79:2:0 0,3,42:1:0 +17 1587 . C 0 . DP=15;I16=11,4,0,0,508,17900,0,0,900,54000,0,0,264,5852,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,247:11:0 0,9,94:3:0 0,3,31:1:0 +17 1588 . A 0 . DP=15;I16=11,4,0,0,511,17939,0,0,900,54000,0,0,262,5806,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,232:11:0 0,9,105:3:0 0,3,41:1:0 +17 1589 . A 0 . DP=15;I16=11,4,0,0,536,19584,0,0,900,54000,0,0,259,5725,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,249:11:0 0,9,106:3:0 0,3,42:1:0 +17 1590 . C 0 . DP=15;I16=10,5,0,0,514,18228,0,0,900,54000,0,0,257,5657,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,231:10:0 0,9,104:3:0 0,6,71:2:0 +17 1591 . T 0 . DP=15;I16=10,5,0,0,515,18559,0,0,900,54000,0,0,256,5602,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,241:10:0 0,9,85:3:0 0,6,73:2:0 +17 1592 . T 0 . DP=15;I16=10,5,0,0,503,17345,0,0,900,54000,0,0,255,5561,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,225:10:0 0,9,107:3:0 0,6,62:2:0 +17 1593 . G 0 . DP=15;I16=10,5,0,0,540,19930,0,0,900,54000,0,0,254,5534,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,250:10:0 0,9,106:3:0 0,6,60:2:0 +17 1594 . T 0 . DP=15;I16=10,5,0,0,535,19445,0,0,900,54000,0,0,252,5472,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,234:10:0 0,9,106:3:0 0,6,80:2:0 +17 1595 . G 0 . DP=15;I16=10,4,0,0,494,17940,0,0,840,50400,0,0,225,4801,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,213:9:0 0,9,105:3:0 0,6,69:2:0 +17 1596 . C 0 . DP=15;I16=10,4,0,0,479,17011,0,0,840,50400,0,0,233,5151,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,200:9:0 0,9,111:3:0 0,6,74:2:0 +17 1597 . C 0 . DP=15;I16=10,5,0,0,489,16941,0,0,900,54000,0,0,245,5285,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,195:9:0 0,12,127:4:0 0,6,73:2:0 +17 1598 . C 0 . DP=15;I16=10,5,0,0,514,18282,0,0,900,54000,0,0,244,5240,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,207:9:0 0,12,133:4:0 0,6,68:2:0 +17 1599 . A 0 . DP=14;I16=8,5,0,0,436,15330,0,0,780,46800,0,0,225,4851,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,182:8:0 0,9,103:3:0 0,6,76:2:0 +17 1600 . T 0 . DP=13;I16=8,5,0,0,456,16430,0,0,780,46800,0,0,226,4876,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,193:8:0 0,9,105:3:0 0,6,79:2:0 +17 1601 . C 0 . DP=13;I16=8,4,0,0,431,15861,0,0,720,43200,0,0,208,4554,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,171:7:0 0,9,108:3:0 0,6,78:2:0 +17 1602 . T 0 . DP=13;I16=7,5,0,0,439,16867,0,0,720,43200,0,0,228,4968,0,0;QS=3,0;MQSB=0.95494;MQ0F=0 PL:DP:DV 0,21,179:7:0 0,9,115:3:0 0,6,85:2:0 +17 1603 . G 0 . DP=12;I16=7,5,0,0,455,17407,0,0,720,43200,0,0,230,5034,0,0;QS=3,0;MQSB=0.95494;MQ0F=0 PL:DP:DV 0,21,202:7:0 0,9,111:3:0 0,6,75:2:0 +17 1604 . G 0 . DP=12;I16=7,5,0,0,362,11620,0,0,720,43200,0,0,232,5112,0,0;QS=3,0;MQSB=0.95494;MQ0F=0 PL:DP:DV 0,21,163:7:0 0,9,84:3:0 0,6,66:2:0 +17 1605 . T 0 . DP=12;I16=7,5,0,0,410,14230,0,0,720,43200,0,0,234,5202,0,0;QS=3,0;MQSB=0.95494;MQ0F=0 PL:DP:DV 0,21,190:7:0 0,9,97:3:0 0,6,61:2:0 +17 1606 . G 0 . DP=12;I16=7,4,0,0,370,12738,0,0,660,39600,0,0,211,4679,0,0;QS=3,0;MQSB=0.964642;MQ0F=0 PL:DP:DV 0,18,165:6:0 0,9,91:3:0 0,6,56:2:0 +17 1607 . A 0 . DP=12;I16=7,4,0,0,337,11369,0,0,660,39600,0,0,226,5222,0,0;QS=3,0;MQSB=0.964642;MQ0F=0 PL:DP:DV 0,21,161:7:0 0,6,70:2:0 0,6,55:2:0 +17 1608 . C 0 . DP=12;I16=7,4,0,0,366,12898,0,0,660,39600,0,0,211,4727,0,0;QS=3,0;MQSB=0.964642;MQ0F=0 PL:DP:DV 0,18,141:6:0 0,9,111:3:0 0,6,62:2:0 +17 1609 . C 0 . DP=11;I16=6,5,0,0,365,12889,0,0,660,39600,0,0,237,5393,0,0;QS=3,0;MQSB=0.950952;MQ0F=0 PL:DP:DV 0,18,149:6:0 0,9,110:3:0 0,6,71:2:0 +17 1610 . C 0 . DP=11;I16=5,5,0,0,313,10713,0,0,600,36000,0,0,213,4819,0,0;QS=3,0;MQSB=0.952347;MQ0F=0 PL:DP:DV 0,15,127:5:0 0,9,106:3:0 0,6,57:2:0 +17 1611 . C 0 . DP=11;I16=6,5,0,0,398,14904,0,0,660,39600,0,0,238,5454,0,0;QS=3,0;MQSB=0.950952;MQ0F=0 PL:DP:DV 0,18,180:6:0 0,9,110:3:0 0,6,67:2:0 +17 1612 . T 0 . DP=11;I16=6,5,0,0,409,15421,0,0,660,39600,0,0,238,5472,0,0;QS=3,0;MQSB=0.950952;MQ0F=0 PL:DP:DV 0,18,174:6:0 0,9,107:3:0 0,6,83:2:0 +17 1613 . C 0 . DP=11;I16=6,5,0,0,372,12904,0,0,660,39600,0,0,238,5498,0,0;QS=3,0;MQSB=0.950952;MQ0F=0 PL:DP:DV 0,18,169:6:0 0,9,99:3:0 0,6,63:2:0 +17 1614 . A 0 . DP=11;I16=6,5,0,0,353,12139,0,0,660,39600,0,0,238,5532,0,0;QS=3,0;MQSB=0.950952;MQ0F=0 PL:DP:DV 0,18,147:6:0 0,9,98:3:0 0,6,69:2:0 +17 1615 . C 0 . DP=11;I16=6,5,0,0,366,13080,0,0,660,39600,0,0,238,5574,0,0;QS=3,0;MQSB=0.950952;MQ0F=0 PL:DP:DV 0,18,171:6:0 0,9,105:3:0 0,6,51:2:0 +17 1616 . T 0 . DP=11;I16=6,3,0,0,348,13606,0,0,540,32400,0,0,187,4323,0,0;QS=3,0;MQSB=0.924584;MQ0F=0 PL:DP:DV 0,15,159:5:0 0,9,105:3:0 0,3,42:1:0 +17 1617 . C 0 . DP=12;I16=6,3,0,0,330,12316,0,0,540,32400,0,0,185,4279,0,0;QS=3,0;MQSB=0.924584;MQ0F=0 PL:DP:DV 0,15,146:5:0 0,9,105:3:0 0,3,42:1:0 +17 1618 . A 0 . DP=12;I16=5,6,0,0,385,14199,0,0,629,36841,0,0,244,5636,0,0;QS=3,0;MQSB=0.891517;MQ0F=0 PL:DP:DV 0,18,151:6:0 0,9,93:3:0 0,6,81:2:0 +17 1619 . G 0 . DP=11;I16=5,6,0,0,377,13119,0,0,629,36841,0,0,242,5544,0,0;QS=3,0;MQSB=0.891517;MQ0F=0 PL:DP:DV 0,18,166:6:0 0,9,84:3:0 0,6,67:2:0 +17 1620 . C 0 . DP=11;I16=5,5,0,0,323,10965,0,0,569,33241,0,0,215,4839,0,0;QS=3,0;MQSB=0.857112;MQ0F=0 PL:DP:DV 0,15,142:5:0 0,9,78:3:0 0,6,56:2:0 +17 1621 . C 0 . DP=12;I16=5,7,0,0,363,11779,0,0,689,40441,0,0,263,6021,0,0;QS=3,0;MQSB=0.896474;MQ0F=0 PL:DP:DV 0,21,174:7:0 0,9,80:3:0 0,6,56:2:0 +17 1622 . A 0 . DP=12;I16=5,7,0,0,365,12105,0,0,689,40441,0,0,261,5965,0,0;QS=3,0;MQSB=0.896474;MQ0F=0 PL:DP:DV 0,21,176:7:0 0,9,81:3:0 0,6,52:2:0 +17 1623 . C 0 . DP=12;I16=5,5,0,0,325,10979,0,0,569,33241,0,0,208,4620,0,0;QS=3,0;MQSB=0.857112;MQ0F=0 PL:DP:DV 0,18,155:6:0 0,9,84:3:0 0,3,37:1:0 +17 1624 . C 0 . DP=12;I16=4,6,0,0,336,11718,0,0,569,33241,0,0,211,4799,0,0;QS=3,0;MQSB=0.895781;MQ0F=0 PL:DP:DV 0,18,162:6:0 0,9,88:3:0 0,3,39:1:0 +17 1625 . A 0 . DP=12;I16=4,7,0,0,375,13503,0,0,629,36841,0,0,234,5386,0,0;QS=3,0;MQSB=0.924449;MQ0F=0 PL:DP:DV 0,18,158:6:0 0,9,93:3:0 0,6,80:2:0 +17 1626 . G 0 . DP=12;I16=5,7,0,0,358,11490,0,0,689,40441,0,0,249,5645,0,0;QS=3,0;MQSB=0.896474;MQ0F=0 PL:DP:DV 0,21,158:7:0 0,9,83:3:0 0,6,63:2:0 +17 1627 . A 0 . DP=12;I16=5,7,0,0,363,11609,0,0,689,40441,0,0,246,5590,0,0;QS=3,0;MQSB=0.896474;MQ0F=0 PL:DP:DV 0,21,165:7:0 0,9,75:3:0 0,6,72:2:0 +17 1628 . C 0 . DP=12;I16=5,7,0,0,357,11583,0,0,689,40441,0,0,243,5545,0,0;QS=3,0;MQSB=0.896474;MQ0F=0 PL:DP:DV 0,21,165:7:0 0,9,80:3:0 0,6,57:2:0 +17 1629 . T 0 . DP=13;I16=6,7,0,0,451,16079,0,0,749,44041,0,0,240,5510,0,0;QS=3,0;MQSB=0.899815;MQ0F=0 PL:DP:DV 0,21,187:7:0 0,12,120:4:0 0,6,79:2:0 +17 1630 . T 0 . DP=13;I16=6,7,0,0,403,13323,0,0,749,44041,0,0,237,5435,0,0;QS=3,0;MQSB=0.899815;MQ0F=0 PL:DP:DV 0,21,169:7:0 0,12,111:4:0 0,6,73:2:0 +17 1631 . C 0 . DP=12;I16=6,5,0,0,354,12046,0,0,660,39600,0,0,210,4744,0,0;QS=3,0;MQSB=0.950952;MQ0F=0 PL:DP:DV 0,21,184:7:0 0,6,67:2:0 0,6,61:2:0 +17 1632 . C 0 . DP=13;I16=6,7,0,0,387,12175,0,0,749,44041,0,0,232,5262,0,0;QS=3,0;MQSB=0.899815;MQ0F=0 PL:DP:DV 0,24,188:8:0 0,9,82:3:0 0,6,61:2:0 +17 1633 . A 0 . DP=13;I16=6,7,0,0,404,13272,0,0,749,44041,0,0,230,5166,0,0;QS=3,0;MQSB=0.899815;MQ0F=0 PL:DP:DV 0,24,183:8:0 0,9,86:3:0 0,6,73:2:0 +17 1634 . C 0 . DP=13;I16=6,6,0,0,328,9716,0,0,689,40441,0,0,203,4457,0,0;QS=3,0;MQSB=0.864013;MQ0F=0 PL:DP:DV 0,21,151:7:0 0,9,80:3:0 0,6,59:2:0 +17 1635 . G 0 . DP=14;I16=6,8,0,0,419,12831,0,0,809,47641,0,0,226,5010,0,0;QS=3,0;MQSB=0.927743;MQ0F=0 PL:DP:DV 0,24,180:8:0 0,12,108:4:0 0,6,59:2:0 +17 1636 . A 0 . DP=14;I16=6,8,0,0,418,13400,0,0,809,47641,0,0,225,4951,0,0;QS=3,0;MQSB=0.927743;MQ0F=0 PL:DP:DV 0,24,179:8:0 0,12,110:4:0 0,6,66:2:0 +17 1637 . C 0 . DP=14;I16=6,8,0,0,422,13498,0,0,809,47641,0,0,224,4906,0,0;QS=3,0;MQSB=0.927743;MQ0F=0 PL:DP:DV 0,24,185:8:0 0,12,110:4:0 0,6,60:2:0 +17 1638 . A 0 . DP=17;I16=9,7,0,0,513,17167,0,0,929,54841,0,0,216,4790,0,0;QS=3,0;MQSB=0.892753;MQ0F=0 PL:DP:DV 0,24,191:8:0 0,18,149:6:0 0,6,78:2:0 +17 1639 . G 0 . DP=17;I16=9,8,0,0,552,18844,0,0,989,58441,0,0,223,4765,0,0;QS=3,0;MQSB=0.91051;MQ0F=0 PL:DP:DV 0,27,228:9:0 0,18,150:6:0 0,6,68:2:0 +17 1640 . G 0 . DP=17;I16=8,6,0,0,414,13296,0,0,809,47641,0,0,171,3467,0,0;QS=3,0;MQSB=0.875173;MQ0F=0 PL:DP:DV 0,18,150:6:0 0,18,151:6:0 0,6,51:2:0 +17 1641 . C 0 . DP=18;I16=9,8,0,0,511,16289,0,0,989,58441,0,0,225,4709,0,0;QS=3,0;MQSB=0.91051;MQ0F=0 PL:DP:DV 0,27,188:9:0 0,18,167:6:0 0,6,65:2:0 +17 1642 . T 0 . DP=17;I16=8,7,0,0,519,18513,0,0,869,51241,0,0,217,4613,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,18,170:6:0 0,18,168:6:0 0,9,102:3:0 +17 1643 . C 0 . DP=16;I16=7,9,0,0,508,16910,0,0,929,54841,0,0,255,5361,0,0;QS=3,0;MQSB=0.933674;MQ0F=0 PL:DP:DV 0,24,193:8:0 0,18,169:6:0 0,6,56:2:0 +17 1644 . C 0 . DP=15;I16=6,9,0,0,514,18056,0,0,869,51241,0,0,259,5401,0,0;QS=3,0;MQSB=0.939413;MQ0F=0 PL:DP:DV 0,21,209:7:0 0,18,165:6:0 0,6,54:2:0 +17 1645 . A 0 . DP=15;I16=6,9,0,0,520,18852,0,0,869,51241,0,0,263,5457,0,0;QS=3,0;MQSB=0.939413;MQ0F=0 PL:DP:DV 0,21,213:7:0 0,18,173:6:0 0,6,49:2:0 +17 1646 . G 0 . DP=15;I16=6,7,0,0,440,15526,0,0,780,46800,0,0,217,4279,0,0;QS=3,0;MQSB=0.961166;MQ0F=0 PL:DP:DV 0,18,185:6:0 0,15,148:5:0 0,6,48:2:0 +17 1647 . C 0 . DP=15;I16=6,9,0,0,433,13883,0,0,869,51241,0,0,271,5617,0,0;QS=3,0;MQSB=0.939413;MQ0F=0 PL:DP:DV 0,21,190:7:0 0,18,139:6:0 0,6,35:2:0 +17 1648 . C 0 . DP=15;I16=6,9,0,0,495,16965,0,0,869,51241,0,0,275,5721,0,0;QS=3,0;MQSB=0.939413;MQ0F=0 PL:DP:DV 0,21,203:7:0 0,18,159:6:0 0,6,44:2:0 +17 1649 . T 0 . DP=15;I16=6,9,0,0,516,18122,0,0,869,51241,0,0,279,5841,0,0;QS=3,0;MQSB=0.939413;MQ0F=0 PL:DP:DV 0,21,187:7:0 0,18,182:6:0 0,6,56:2:0 +17 1650 . C 0 . DP=15;I16=6,7,0,0,405,13551,0,0,749,44041,0,0,240,5028,0,0;QS=3,0;MQSB=0.899815;MQ0F=0 PL:DP:DV 0,18,161:6:0 0,18,169:6:0 0,3,13:1:0 +17 1651 . G 0 . DP=17;I16=5,9,0,0,424,13328,0,0,778,44882,0,0,249,5335,0,0;QS=3,0;MQSB=0.965069;MQ0F=0 PL:DP:DV 0,18,150:6:0 0,15,128:5:0 0,9,86:3:0 +17 1652 . G 0 . DP=18;I16=7,9,0,0,532,18602,0,0,898,52082,0,0,267,5673,0,0;QS=3,0;MQSB=0.994413;MQ0F=0 PL:DP:DV 0,24,212:8:0 0,18,168:6:0 0,6,54:2:0 +17 1653 . C 0 . DP=18;I16=8,10,0,0,581,19565,0,0,1018,59282,0,0,300,6490,0,0;QS=3,0;MQSB=0.99606;MQ0F=0 PL:DP:DV 0,24,208:8:0 0,21,175:7:0 0,9,82:3:0 +17 1654 . A T, 0 . DP=18;I16=8,9,0,1,516,16718,15,225,958,55682,60,3600,285,6219,22,484;QS=2.93213,0.0678733,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.99606;BQB=1;MQ0F=0 PL:DP:DV 0,9,155,21,158,162:8:1 0,21,179,21,179,179:7:0 0,9,78,9,78,78:3:0 +17 1655 . C 0 . DP=18;I16=8,10,0,0,565,19017,0,0,1018,59282,0,0,313,6887,0,0;QS=3,0;MQSB=0.99606;MQ0F=0 PL:DP:DV 0,24,198:8:0 0,21,180:7:0 0,9,79:3:0 +17 1656 . C 0 . DP=19;I16=9,9,0,0,557,18013,0,0,1018,59282,0,0,295,6515,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,202:8:0 0,21,165:7:0 0,9,80:3:0 +17 1657 . T A, 0 . DP=18;I16=8,9,0,1,580,20362,15,225,989,58441,29,841,301,6641,25,625;QS=2.93243,0.0675676,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.99606;BQB=1;MQ0F=0 PL:DP:DV 0,24,206,24,206,206:8:0 0,6,158,18,161,165:7:1 0,9,85,9,85,85:3:0 +17 1658 . T 0 . DP=19;I16=8,10,0,0,573,19127,0,0,1018,59282,0,0,332,7412,0,0;QS=3,0;MQSB=0.99606;MQ0F=0 PL:DP:DV 0,24,187:8:0 0,21,189:7:0 0,9,91:3:0 +17 1659 . C 0 . DP=20;I16=8,10,0,0,609,21517,0,0,1049,62041,0,0,338,7578,0,0;QS=3,0;MQSB=0.906029;MQ0F=0 PL:DP:DV 0,24,219:8:0 0,21,189:7:0 0,9,80:3:0 +17 1660 . A 0 . DP=21;I16=8,11,0,0,641,23219,0,0,1078,62882,0,0,385,8901,0,0;QS=3,0;MQSB=0.992359;MQ0F=0 PL:DP:DV 0,21,172:7:0 0,24,219:8:0 0,12,127:4:0 +17 1661 . G 0 . DP=21;I16=7,13,0,0,639,21739,0,0,1107,63723,0,0,412,9598,0,0;QS=3,0;MQSB=0.999215;MQ0F=0 PL:DP:DV 0,24,209:8:0 0,24,193:8:0 0,12,98:4:0 +17 1662 . C 0 . DP=21;I16=8,12,0,0,641,21423,0,0,1107,63723,0,0,407,9465,0,0;QS=3,0;MQSB=0.988166;MQ0F=0 PL:DP:DV 0,21,192:7:0 0,27,211:9:0 0,12,100:4:0 +17 1663 . C 0 . DP=20;I16=7,11,0,0,577,19507,0,0,1018,59282,0,0,394,9204,0,0;QS=3,0;MQSB=0.983729;MQ0F=0 PL:DP:DV 0,21,178:7:0 0,21,192:7:0 0,12,101:4:0 +17 1664 . A C, 0 . DP=20;I16=6,10,0,1,530,17982,13,169,898,52082,29,841,358,8422,25,625;QS=2.93953,0.0604651,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.998738;BQB=1;MQ0F=0 PL:DP:DV 0,18,167,18,167,167:6:0 0,7,154,18,157,159:7:1 0,12,109,12,109,109:4:0 +17 1665 . T C, 0 . DP=20;I16=7,11,1,1,592,20170,58,1924,1018,59282,89,4441,396,9188,39,821;QS=2.5913,0.408696,0;VDB=0.1;SGB=0.346553;RPB=0.222222;MQB=0.611111;MQSB=0.988166;BQB=0.944444;MQ0F=0 PL:DP:DV 0,21,185,21,185,185:7:0 0,27,222,27,222,222:9:0 35,0,51,41,57,90:4:2 +17 1666 . G 0 . DP=20;I16=8,12,0,0,614,19760,0,0,1107,63723,0,0,435,9947,0,0;QS=3,0;MQSB=0.988166;MQ0F=0 PL:DP:DV 0,21,173:7:0 0,27,206:9:0 0,12,111:4:0 +17 1667 . G 0 . DP=20;I16=8,11,0,0,617,21033,0,0,1078,62882,0,0,410,9276,0,0;QS=3,0;MQSB=0.992359;MQ0F=0 PL:DP:DV 0,21,183:7:0 0,24,195:8:0 0,12,115:4:0 +17 1668 . A 0 . DP=20;I16=7,10,0,0,570,19908,0,0,958,55682,0,0,369,8365,0,0;QS=3,0;MQSB=0.989343;MQ0F=0 PL:DP:DV 0,18,158:6:0 0,21,186:7:0 0,12,124:4:0 +17 1669 . C 0 . DP=20;I16=8,12,0,0,640,21336,0,0,1107,63723,0,0,435,9857,0,0;QS=3,0;MQSB=0.988166;MQ0F=0 PL:DP:DV 0,21,172:7:0 0,27,216:9:0 0,12,115:4:0 +17 1670 . A 0 . DP=23;I16=9,13,0,0,765,27363,0,0,1258,73682,0,0,410,9234,0,0;QS=3,0;MQSB=0.991121;MQ0F=0 PL:DP:DV 0,27,215:9:0 0,27,233:9:0 0,12,129:4:0 +17 1671 . G 0 . DP=23;I16=9,13,0,0,703,23631,0,0,1258,73682,0,0,412,9206,0,0;QS=3,0;MQSB=0.991121;MQ0F=0 PL:DP:DV 0,27,214:9:0 0,27,210:9:0 0,12,106:4:0 +17 1672 . T 0 . DP=23;I16=9,13,0,0,724,24700,0,0,1258,73682,0,0,414,9202,0,0;QS=3,0;MQSB=0.991121;MQ0F=0 PL:DP:DV 0,27,203:9:0 0,27,232:9:0 0,12,111:4:0 +17 1673 . T 0 . DP=25;I16=8,13,0,0,719,25183,0,0,1198,70082,0,0,372,8248,0,0;QS=3,0;MQSB=0.983744;MQ0F=0 PL:DP:DV 0,27,221:9:0 0,24,212:8:0 0,12,112:4:0 +17 1674 . C 0 . DP=25;I16=8,14,0,0,755,26561,0,0,1289,76441,0,0,389,8417,0,0;QS=3,0;MQSB=0.892142;MQ0F=0 PL:DP:DV 0,33,244:11:0 0,21,206:7:0 0,12,96:4:0 +17 1675 . C 0 . DP=25;I16=9,15,0,0,705,22355,0,0,1347,78123,0,0,447,9897,0,0;QS=3,0;MQSB=0.996008;MQ0F=0 PL:DP:DV 0,33,222:11:0 0,30,212:10:0 0,9,65:3:0 +17 1676 . G 0 . DP=25;I16=6,15,0,0,660,21708,0,0,1167,67323,0,0,383,8265,0,0;QS=3,0;MQSB=0.993205;MQ0F=0 PL:DP:DV 0,33,222:11:0 0,21,170:7:0 0,9,96:3:0 +17 1677 . C 0 . DP=25;I16=9,13,0,0,681,22869,0,0,1289,76441,0,0,394,8510,0,0;QS=3,0;MQSB=0.910098;MQ0F=0 PL:DP:DV 0,33,225:11:0 0,24,198:8:0 0,9,74:3:0 +17 1678 . C 0 . DP=25;I16=9,15,0,0,775,26785,0,0,1347,78123,0,0,438,9496,0,0;QS=3,0;MQSB=0.996008;MQ0F=0 PL:DP:DV 0,33,235:11:0 0,30,231:10:0 0,9,83:3:0 +17 1679 . A 0 . DP=25;I16=8,15,0,0,762,27552,0,0,1287,74523,0,0,412,8858,0,0;QS=3,0;MQSB=0.999479;MQ0F=0 PL:DP:DV 0,33,235:11:0 0,27,219:9:0 0,9,106:3:0 +17 1680 . G 0 . DP=26;I16=9,17,0,0,843,29213,0,0,1467,85323,0,0,459,10021,0,0;QS=3,0;MQSB=0.999637;MQ0F=0 PL:DP:DV 0,33,253:11:0 0,33,232:11:0 0,12,108:4:0 +17 1681 . C 0 . DP=26;I16=8,15,0,0,681,21293,0,0,1318,77282,0,0,407,8999,0,0;QS=3,0;MQSB=0.974802;MQ0F=0 PL:DP:DV 0,33,223:11:0 0,27,191:9:0 0,9,69:3:0 +17 1682 . G 0 . DP=25;I16=9,16,0,0,728,22560,0,0,1407,81723,0,0,455,9877,0,0;QS=3,0;MQSB=0.998399;MQ0F=0 PL:DP:DV 0,30,222:10:0 0,33,208:11:0 0,12,98:4:0 +17 1683 . T 0 . DP=25;I16=8,15,0,0,807,29159,0,0,1287,74523,0,0,403,8567,0,0;QS=3,0;MQSB=0.999479;MQ0F=0 PL:DP:DV 0,30,250:10:0 0,30,235:10:0 0,9,91:3:0 +17 1684 . T 0 . DP=25;I16=8,15,0,0,802,28774,0,0,1318,77282,0,0,438,9612,0,0;QS=3,0;MQSB=0.974802;MQ0F=0 PL:DP:DV 0,27,227:9:0 0,30,237:10:0 0,12,107:4:0 +17 1685 . G 0 . DP=24;I16=8,14,0,0,759,27319,0,0,1258,73682,0,0,413,8999,0,0;QS=3,0;MQSB=0.979255;MQ0F=0 PL:DP:DV 0,24,216:8:0 0,30,242:10:0 0,12,110:4:0 +17 1686 . C 0 . DP=24;I16=8,15,0,0,793,28073,0,0,1318,77282,0,0,438,9656,0,0;QS=3,0;MQSB=0.974802;MQ0F=0 PL:DP:DV 0,27,225:9:0 0,30,241:10:0 0,12,103:4:0 +17 1687 . C 0 . DP=24;I16=7,14,0,0,741,26765,0,0,1198,70082,0,0,388,8458,0,0;QS=3,0;MQSB=0.966484;MQ0F=0 PL:DP:DV 0,24,221:8:0 0,27,229:9:0 0,12,106:4:0 +17 1688 . C 0 . DP=24;I16=8,15,0,0,794,28736,0,0,1318,77282,0,0,431,9605,0,0;QS=3,0;MQSB=0.974802;MQ0F=0 PL:DP:DV 0,27,239:9:0 0,30,221:10:0 0,12,120:4:0 +17 1689 . T A, 0 . DP=24;I16=8,15,0,1,805,29443,33,1089,1287,74523,60,3600,421,9311,25,625;QS=2.74419,0.255814,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=1;BQB=1;MQ0F=0 PL:DP:DV 0,27,224,27,224,224:9:0 0,33,255,33,255,255:11:0 21,0,79,30,82,106:4:1 +17 1690 . C 0 . DP=24;I16=8,16,0,0,864,32420,0,0,1347,78123,0,0,445,10033,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,242:9:0 0,33,255:11:0 0,12,95:4:0 +17 1691 . T 0 . DP=22;I16=7,14,0,0,734,27150,0,0,1167,67323,0,0,421,9525,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,225:9:0 0,30,242:10:0 0,6,57:2:0 +17 1692 . G 0 . DP=22;I16=7,13,0,0,678,24110,0,0,1107,63723,0,0,400,9176,0,0;QS=3,0;MQSB=0.999215;MQ0F=0 PL:DP:DV 0,24,218:8:0 0,30,218:10:0 0,6,61:2:0 +17 1693 . T 0 . DP=24;I16=10,13,0,0,795,28363,0,0,1318,77282,0,0,444,10422,0,0;QS=3,0;MQSB=0.995682;MQ0F=0 PL:DP:DV 0,27,227:9:0 0,30,235:10:0 0,12,104:4:0 +17 1694 . T 0 . DP=24;I16=10,13,0,0,771,26775,0,0,1318,77282,0,0,448,10602,0,0;QS=3,0;MQSB=0.995682;MQ0F=0 PL:DP:DV 0,27,221:9:0 0,30,232:10:0 0,12,114:4:0 +17 1695 . C 0 . DP=24;I16=10,14,0,0,811,28517,0,0,1347,78123,0,0,454,10806,0,0;QS=3,0;MQSB=0.98469;MQ0F=0 PL:DP:DV 0,27,227:9:0 0,33,239:11:0 0,12,121:4:0 +17 1696 . T 0 . DP=23;I16=10,13,0,0,825,30819,0,0,1287,74523,0,0,455,10869,0,0;QS=3,0;MQSB=0.976718;MQ0F=0 PL:DP:DV 0,24,219:8:0 0,33,255:11:0 0,12,108:4:0 +17 1697 . G 0 . DP=23;I16=10,13,0,0,767,26757,0,0,1287,74523,0,0,455,10897,0,0;QS=3,0;MQSB=0.976718;MQ0F=0 PL:DP:DV 0,24,208:8:0 0,33,246:11:0 0,12,112:4:0 +17 1698 . C A, 0 . DP=21;I16=10,10,0,1,726,27088,27,729,1169,69241,29,841,451,10903,6,36;QS=2.91148,0.0885246,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.99938;BQB=1;MQ0F=0 PL:DP:DV 0,24,229,24,229,229:8:0 0,0,190,24,193,207:9:1 0,12,111,12,111,111:4:0 +17 1699 . T 0 . DP=21;I16=9,10,0,0,698,25826,0,0,1078,62882,0,0,408,9692,0,0;QS=3,0;MQSB=0.999167;MQ0F=0 PL:DP:DV 0,21,203:7:0 0,24,219:8:0 0,12,115:4:0 +17 1700 . G 0 . DP=20;I16=9,10,0,0,696,25850,0,0,1078,62882,0,0,409,9705,0,0;QS=3,0;MQSB=0.999167;MQ0F=0 PL:DP:DV 0,21,216:7:0 0,24,215:8:0 0,12,110:4:0 +17 1701 . T 0 . DP=20;I16=9,11,0,0,711,25539,0,0,1138,66482,0,0,435,10353,0,0;QS=3,0;MQSB=0.997118;MQ0F=0 PL:DP:DV 0,24,207:8:0 0,24,210:8:0 0,12,125:4:0 +17 1702 . T 0 . DP=20;I16=8,11,0,0,671,24367,0,0,1078,62882,0,0,410,9712,0,0;QS=3,0;MQSB=0.992359;MQ0F=0 PL:DP:DV 0,24,214:8:0 0,21,193:7:0 0,12,115:4:0 +17 1703 . T 0 . DP=20;I16=9,10,0,0,648,22696,0,0,1078,62882,0,0,410,9708,0,0;QS=3,0;MQSB=0.999167;MQ0F=0 PL:DP:DV 0,21,197:7:0 0,24,195:8:0 0,12,114:4:0 +17 1704 . T 0 . DP=20;I16=10,10,0,0,711,25771,0,0,1169,69241,0,0,435,10341,0,0;QS=3,0;MQSB=0.931063;MQ0F=0 PL:DP:DV 0,24,208:8:0 0,21,208:7:0 0,15,128:5:0 +17 1705 . C 0 . DP=20;I16=10,10,0,0,744,28388,0,0,1169,69241,0,0,436,10312,0,0;QS=3,0;MQSB=0.931063;MQ0F=0 PL:DP:DV 0,24,232:8:0 0,21,213:7:0 0,15,120:5:0 +17 1706 . T 0 . DP=20;I16=10,10,0,0,775,30329,0,0,1169,69241,0,0,436,10246,0,0;QS=3,0;MQSB=0.931063;MQ0F=0 PL:DP:DV 0,24,221:8:0 0,21,219:7:0 0,15,145:5:0 +17 1707 . C 0 . DP=21;I16=9,11,0,0,724,26998,0,0,1169,69241,0,0,410,9518,0,0;QS=3,0;MQSB=0.916401;MQ0F=0 PL:DP:DV 0,27,235:9:0 0,18,180:6:0 0,15,134:5:0 +17 1708 . T 0 . DP=21;I16=9,12,0,0,740,27282,0,0,1229,72841,0,0,410,9430,0,0;QS=3,0;MQSB=0.913101;MQ0F=0 PL:DP:DV 0,30,229:10:0 0,18,187:6:0 0,15,132:5:0 +17 1709 . A 0 . DP=21;I16=9,11,0,0,675,23509,0,0,1169,69241,0,0,386,8734,0,0;QS=3,0;MQSB=0.916401;MQ0F=0 PL:DP:DV 0,27,210:9:0 0,18,166:6:0 0,15,131:5:0 +17 1710 . C 0 . DP=22;I16=9,13,0,0,755,26817,0,0,1289,76441,0,0,412,9306,0,0;QS=3,0;MQSB=0.910098;MQ0F=0 PL:DP:DV 0,33,236:11:0 0,18,181:6:0 0,15,128:5:0 +17 1711 . C 0 . DP=22;I16=9,13,0,0,786,28790,0,0,1289,76441,0,0,413,9223,0,0;QS=3,0;MQSB=0.910098;MQ0F=0 PL:DP:DV 0,33,250:11:0 0,18,169:6:0 0,15,138:5:0 +17 1712 . A 0 . DP=22;I16=9,13,0,0,824,31342,0,0,1289,76441,0,0,414,9162,0,0;QS=3,0;MQSB=0.910098;MQ0F=0 PL:DP:DV 0,33,252:11:0 0,18,198:6:0 0,15,136:5:0 +17 1713 . G 0 . DP=23;I16=8,14,0,0,823,31285,0,0,1289,76441,0,0,405,8993,0,0;QS=3,0;MQSB=0.892142;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,189:6:0 0,12,118:4:0 +17 1714 . A 0 . DP=23;I16=9,13,0,0,763,27439,0,0,1289,76441,0,0,402,8818,0,0;QS=3,0;MQSB=0.910098;MQ0F=0 PL:DP:DV 0,36,234:12:0 0,18,190:6:0 0,12,101:4:0 +17 1715 . A 0 . DP=23;I16=9,14,0,0,900,35416,0,0,1349,80041,0,0,414,8878,0,0;QS=3,0;MQSB=0.907354;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,206:6:0 0,15,145:5:0 +17 1716 . G 0 . DP=23;I16=9,14,0,0,844,31500,0,0,1349,80041,0,0,414,8822,0,0;QS=3,0;MQSB=0.907354;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,188:6:0 0,15,129:5:0 +17 1717 . T 0 . DP=24;I16=9,15,0,0,854,30878,0,0,1409,83641,0,0,414,8794,0,0;QS=3,0;MQSB=0.904837;MQ0F=0 PL:DP:DV 0,39,253:13:0 0,18,185:6:0 0,15,122:5:0 +17 1718 . G 0 . DP=24;I16=9,14,0,0,806,29332,0,0,1349,80041,0,0,390,8170,0,0;QS=3,0;MQSB=0.907354;MQ0F=0 PL:DP:DV 0,36,249:12:0 0,18,188:6:0 0,15,124:5:0 +17 1719 . C 0 . DP=26;I16=11,14,0,0,857,30717,0,0,1469,87241,0,0,407,8675,0,0;QS=3,0;MQSB=0.929204;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,173:6:0 0,12,98:4:0 +17 1720 . C 0 . DP=26;I16=11,14,0,0,898,33274,0,0,1469,87241,0,0,409,8645,0,0;QS=3,0;MQSB=0.929204;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,166:6:0 0,12,99:4:0 +17 1721 . C 0 . DP=26;I16=10,14,0,0,846,30642,0,0,1409,83641,0,0,388,8258,0,0;QS=3,0;MQSB=0.919431;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,187:6:0 0,12,119:4:0 +17 1722 . T 0 . DP=25;I16=11,13,0,0,876,33054,0,0,1409,83641,0,0,406,8540,0,0;QS=3,0;MQSB=0.931547;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,174:5:0 0,15,123:5:0 +17 1723 . T 0 . DP=25;I16=11,14,0,0,835,28861,0,0,1469,87241,0,0,420,8728,0,0;QS=3,0;MQSB=0.929204;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,167:5:0 0,15,130:5:0 +17 1724 . C 0 . DP=25;I16=11,14,0,0,903,33735,0,0,1469,87241,0,0,422,8800,0,0;QS=3,0;MQSB=0.929204;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,164:5:0 0,15,139:5:0 +17 1725 . C G, 0 . DP=25;I16=11,13,0,1,835,29699,25,625,1409,83641,60,3600,406,8576,18,324;QS=2.95164,0.0483559,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.929204;BQB=1;MQ0F=0 PL:DP:DV 0,20,255,42,255,255:15:1 0,15,153,15,153,153:5:0 0,15,132,15,132,132:5:0 +17 1726 . C 0 . DP=25;I16=11,14,0,0,932,35588,0,0,1469,87241,0,0,426,9028,0,0;QS=3,0;MQSB=0.929204;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,165:5:0 0,15,122:5:0 +17 1727 . T 0 . DP=25;I16=10,14,0,0,862,32080,0,0,1409,83641,0,0,404,8556,0,0;QS=3,0;MQSB=0.919431;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,167:5:0 0,12,120:4:0 +17 1728 . C 0 . DP=25;I16=11,14,0,0,915,33845,0,0,1469,87241,0,0,429,9173,0,0;QS=3,0;MQSB=0.929204;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,156:5:0 0,15,144:5:0 +17 1729 . C 0 . DP=25;I16=10,14,0,0,919,35797,0,0,1409,83641,0,0,406,8668,0,0;QS=3,0;MQSB=0.919431;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,142:5:0 0,12,128:4:0 +17 1730 . T 0 . DP=24;I16=10,14,0,0,849,30711,0,0,1409,83641,0,0,433,9393,0,0;QS=3,0;MQSB=0.919431;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,138:4:0 0,15,148:5:0 +17 1731 . C 0 . DP=24;I16=10,14,0,0,907,34875,0,0,1409,83641,0,0,434,9472,0,0;QS=3,0;MQSB=0.919431;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,123:4:0 0,15,140:5:0 +17 1732 . A 0 . DP=24;I16=11,13,0,0,816,28582,0,0,1409,83641,0,0,436,9580,0,0;QS=3,0;MQSB=0.931547;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,123:4:0 0,15,143:5:0 +17 1733 . C 0 . DP=25;I16=12,13,0,0,869,31451,0,0,1469,87241,0,0,438,9666,0,0;QS=3,0;MQSB=0.939413;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,116:4:0 0,15,136:5:0 +17 1734 . C 0 . DP=25;I16=12,13,0,0,926,35482,0,0,1469,87241,0,0,440,9730,0,0;QS=3,0;MQSB=0.939413;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,122:4:0 0,15,141:5:0 +17 1735 . T 0 . DP=26;I16=13,13,0,0,935,35169,0,0,1529,90841,0,0,442,9822,0,0;QS=3,0;MQSB=0.945959;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,112:4:0 0,15,148:5:0 +17 1736 . G 0 . DP=25;I16=11,11,0,0,829,31469,0,0,1289,76441,0,0,380,8416,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,72:2:0 0,12,118:4:0 +17 1737 . A 0 . DP=25;I16=12,12,0,0,842,30606,0,0,1409,83641,0,0,422,9312,0,0;QS=3,0;MQSB=0.941765;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,76:2:0 0,15,131:5:0 +17 1738 . C 0 . DP=24;I16=12,12,0,0,835,30251,0,0,1409,83641,0,0,450,10010,0,0;QS=3,0;MQSB=0.941765;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,78:3:0 0,15,130:5:0 +17 1739 . C 0 . DP=23;I16=10,12,0,0,831,32123,0,0,1289,76441,0,0,428,9432,0,0;QS=3,0;MQSB=0.924723;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,55:2:0 0,12,135:4:0 +17 1740 . A 0 . DP=23;I16=11,12,0,0,774,27126,0,0,1349,80041,0,0,456,10126,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,56:2:0 0,15,139:5:0 +17 1741 . C 0 . DP=23;I16=11,12,0,0,850,32314,0,0,1349,80041,0,0,459,10217,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,70:2:0 0,15,136:5:0 +17 1742 . T 0 . DP=23;I16=11,12,0,0,866,33204,0,0,1349,80041,0,0,462,10330,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,72:2:0 0,15,144:5:0 +17 1743 . C 0 . DP=23;I16=11,12,0,0,894,35176,0,0,1349,80041,0,0,464,10414,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,74:2:0 0,15,138:5:0 +17 1744 . T 0 . DP=23;I16=11,11,0,0,857,33579,0,0,1289,76441,0,0,459,10469,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,80:2:0 0,15,156:5:0 +17 1745 . G 0 . DP=23;I16=11,12,0,0,882,34572,0,0,1349,80041,0,0,464,10442,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,78:2:0 0,15,142:5:0 +17 1746 . G 0 . DP=24;I16=12,11,0,0,836,31102,0,0,1349,80041,0,0,456,10312,0,0;QS=3,0;MQSB=0.944319;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,69:2:0 0,18,151:6:0 +17 1747 . G 0 . DP=24;I16=12,11,0,0,839,31729,0,0,1349,80041,0,0,455,10239,0,0;QS=3,0;MQSB=0.944319;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,75:2:0 0,18,154:6:0 +17 1748 . G 0 . DP=24;I16=11,12,0,0,843,31857,0,0,1349,80041,0,0,434,9664,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,3,42:1:0 0,18,154:6:0 +17 1749 . A 0 . DP=25;I16=13,11,0,0,864,31748,0,0,1409,83641,0,0,451,10063,0,0;QS=3,0;MQSB=0.950498;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,72:2:0 0,21,172:7:0 +17 1750 . A 0 . DP=25;I16=13,12,0,0,905,33667,0,0,1469,87241,0,0,451,10013,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,56:2:0 0,21,187:7:0 +17 1751 . A 0 . DP=25;I16=13,12,0,0,908,33658,0,0,1469,87241,0,0,449,9987,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,67:2:0 0,21,183:7:0 +17 1752 . T 0 . DP=23;I16=12,11,0,0,838,31088,0,0,1380,82800,0,0,449,9987,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,71:2:0 0,18,170:6:0 +17 1753 . C 0 . DP=23;I16=12,11,0,0,869,33595,0,0,1380,82800,0,0,448,9960,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,77:2:0 0,18,163:6:0 +17 1754 . C 0 . DP=23;I16=11,11,0,0,830,31628,0,0,1320,79200,0,0,431,9699,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,3,42:1:0 0,18,163:6:0 +17 1755 . C 0 . DP=23;I16=12,11,0,0,856,33082,0,0,1380,82800,0,0,446,9972,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,61:2:0 0,18,165:6:0 +17 1756 . T 0 . DP=22;I16=11,11,0,0,858,33720,0,0,1320,79200,0,0,445,9961,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,77:2:0 0,18,179:6:0 +17 1757 . C 0 . DP=22;I16=11,11,0,0,869,34651,0,0,1320,79200,0,0,444,9972,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,78:2:0 0,18,176:6:0 +17 1758 . A 0 . DP=22;I16=11,11,0,0,865,34205,0,0,1320,79200,0,0,442,9954,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,81:2:0 0,18,177:6:0 +17 1759 . G 0 . DP=22;I16=11,11,0,0,833,31965,0,0,1320,79200,0,0,439,9905,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,77:2:0 0,18,159:6:0 +17 1760 . C 0 . DP=22;I16=11,11,0,0,849,33441,0,0,1320,79200,0,0,436,9874,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,79:2:0 0,18,159:6:0 +17 1761 . A 0 . DP=22;I16=11,11,0,0,730,25766,0,0,1320,79200,0,0,432,9810,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,75:2:0 0,18,153:6:0 +17 1762 . C 0 . DP=21;I16=11,10,0,0,767,28667,0,0,1260,75600,0,0,429,9761,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,76:2:0 0,18,160:6:0 +17 1763 . C 0 . DP=21;I16=11,10,0,0,789,30115,0,0,1260,75600,0,0,426,9726,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,72:2:0 0,18,162:6:0 +17 1764 . C 0 . DP=21;I16=11,10,0,0,821,32443,0,0,1260,75600,0,0,423,9705,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,72:2:0 0,18,167:6:0 +17 1765 . T 0 . DP=21;I16=11,10,0,0,814,31746,0,0,1260,75600,0,0,420,9698,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,83:2:0 0,18,179:6:0 +17 1766 . C 0 . DP=21;I16=11,10,0,0,796,30564,0,0,1260,75600,0,0,417,9705,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,71:2:0 0,18,162:6:0 +17 1767 . C 0 . DP=21;I16=11,10,0,0,779,29559,0,0,1260,75600,0,0,414,9726,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,73:2:0 0,18,163:6:0 +17 1768 . C 0 . DP=21;I16=11,10,0,0,798,30670,0,0,1260,75600,0,0,411,9761,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,68:2:0 0,18,160:6:0 +17 1769 . T 0 . DP=21;I16=11,10,0,0,819,32179,0,0,1260,75600,0,0,406,9712,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,77:2:0 0,18,184:6:0 +17 1770 . G 0 . DP=19;I16=11,8,0,0,699,26453,0,0,1140,68400,0,0,403,9679,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,68:2:0 0,18,158:6:0 +17 1771 . A 0 . DP=18;I16=10,8,0,0,707,27853,0,0,1080,64800,0,0,401,9659,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,3,42:1:0 0,18,177:6:0 +17 1772 . G 0 . DP=18;I16=10,8,0,0,669,25513,0,0,1080,64800,0,0,398,9600,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,3,38:1:0 0,18,159:6:0 +17 1773 . C 0 . DP=17;I16=10,7,0,0,675,26897,0,0,1020,61200,0,0,396,9550,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,3,39:1:0 0,18,172:6:0 +17 1774 . A 0 . DP=17;I16=10,7,0,0,653,25153,0,0,1020,61200,0,0,394,9508,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,3,39:1:0 0,18,172:6:0 +17 1775 . T 0 . DP=17;I16=10,7,0,0,605,22253,0,0,1020,61200,0,0,391,9423,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,3,38:1:0 0,18,156:6:0 +17 1776 . A 0 . DP=17;I16=10,7,0,0,610,22124,0,0,1020,61200,0,0,388,9344,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,254:10:0 0,3,35:1:0 0,18,166:6:0 +17 1777 . C 0 . DP=18;I16=11,7,0,0,661,24975,0,0,1080,64800,0,0,385,9271,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,3,35:1:0 0,18,158:6:0 +17 1778 . C 0 . DP=18;I16=11,7,0,0,680,25970,0,0,1080,64800,0,0,383,9205,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,3,31:1:0 0,18,172:6:0 +17 1779 . C 0 . DP=18;I16=11,7,0,0,703,27663,0,0,1080,64800,0,0,381,9147,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,3,34:1:0 0,18,174:6:0 +17 1780 . T 0 . DP=18;I16=11,7,0,0,672,26000,0,0,1080,64800,0,0,378,9048,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,3,33:1:0 0,18,177:6:0 +17 1781 . A 0 . DP=19;I16=10,6,0,0,579,21377,0,0,960,57600,0,0,328,7804,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,0,0:0:0 0,15,160:5:0 +17 1782 . C 0 . DP=20;I16=11,9,0,0,715,26603,0,0,1200,72000,0,0,382,8892,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,47:2:0 0,18,156:6:0 +17 1783 . T 0 . DP=20;I16=11,9,0,0,755,29057,0,0,1200,72000,0,0,381,8743,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,68:2:0 0,18,184:6:0 +17 1784 . C 0 . DP=20;I16=10,9,0,0,723,28017,0,0,1140,68400,0,0,360,8212,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,62:2:0 0,15,151:5:0 +17 1785 . T 0 . DP=20;I16=10,10,0,0,766,29878,0,0,1200,72000,0,0,359,8089,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,66:2:0 0,15,168:5:0 +17 1786 . G 0 . DP=22;I16=11,11,0,0,841,32323,0,0,1320,79200,0,0,359,7985,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,68:2:0 0,15,158:5:0 +17 1787 . G 0 . DP=22;I16=11,11,0,0,806,30294,0,0,1320,79200,0,0,361,7903,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,68:2:0 0,15,148:5:0 +17 1788 . C 0 . DP=22;I16=11,11,0,0,858,33674,0,0,1320,79200,0,0,362,7796,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,67:2:0 0,15,158:5:0 +17 1789 . A 0 . DP=23;I16=11,12,0,0,797,28705,0,0,1380,82800,0,0,363,7715,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,69:2:0 0,15,157:5:0 +17 1790 . C 0 . DP=23;I16=11,12,0,0,852,31816,0,0,1380,82800,0,0,365,7661,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,63:2:0 0,15,153:5:0 +17 1791 . A 0 . DP=23;I16=11,12,0,0,830,30484,0,0,1380,82800,0,0,367,7635,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,61:2:0 0,15,155:5:0 +17 1792 . A 0 . DP=23;I16=11,12,0,0,862,32760,0,0,1380,82800,0,0,368,7588,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,67:2:0 0,15,161:5:0 +17 1793 . G 0 . DP=23;I16=11,12,0,0,813,29603,0,0,1380,82800,0,0,369,7571,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,61:2:0 0,15,126:5:0 +17 1794 . C 0 . DP=21;I16=9,12,0,0,736,26472,0,0,1260,75600,0,0,370,7484,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,48:2:0 0,9,96:3:0 +17 1795 . C 0 . DP=21;I16=9,12,0,0,763,28807,0,0,1260,75600,0,0,371,7427,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,45:2:0 0,9,100:3:0 +17 1796 . C 0 . DP=21;I16=9,12,0,0,782,29718,0,0,1260,75600,0,0,372,7400,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,52:2:0 0,9,102:3:0 +17 1797 . A 0 . DP=21;I16=9,12,0,0,704,25190,0,0,1260,75600,0,0,373,7403,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,59:2:0 0,9,92:3:0 +17 1798 . C 0 . DP=21;I16=9,12,0,0,759,28119,0,0,1260,75600,0,0,374,7436,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,49:2:0 0,9,99:3:0 +17 1799 . C 0 . DP=22;I16=9,13,0,0,796,29520,0,0,1320,79200,0,0,375,7499,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,56:2:0 0,12,131:4:0 +17 1800 . C 0 . DP=22;I16=9,13,0,0,866,34352,0,0,1320,79200,0,0,376,7542,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,63:2:0 0,12,138:4:0 +17 1801 . T 0 . DP=22;I16=9,13,0,0,838,32282,0,0,1320,79200,0,0,377,7615,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,63:2:0 0,12,150:4:0 +17 1802 . G 0 . DP=22;I16=9,13,0,0,844,32894,0,0,1320,79200,0,0,378,7718,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,60:2:0 0,12,137:4:0 +17 1803 . C 0 . DP=22;I16=9,13,0,0,837,32691,0,0,1320,79200,0,0,377,7751,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,60:2:0 0,12,143:4:0 +17 1804 . A 0 . DP=23;I16=9,14,0,0,793,28517,0,0,1380,82800,0,0,376,7814,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,54:2:0 0,12,144:4:0 +17 1805 . A 0 . DP=23;I16=9,14,0,0,810,29148,0,0,1380,82800,0,0,376,7908,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,67:2:0 0,12,138:4:0 +17 1806 . A 0 . DP=23;I16=9,14,0,0,816,29932,0,0,1380,82800,0,0,376,8034,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,61:2:0 0,12,139:4:0 +17 1807 . G 0 . DP=22;I16=9,13,0,0,837,32299,0,0,1320,79200,0,0,375,8091,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,67:2:0 0,12,142:4:0 +17 1808 . C 0 . DP=21;I16=9,11,0,0,705,25519,0,0,1200,72000,0,0,354,7716,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,53:2:0 0,12,140:4:0 +17 1809 . C 0 . DP=22;I16=10,12,0,0,789,29123,0,0,1320,79200,0,0,371,8091,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,55:2:0 0,12,143:4:0 +17 1810 . C 0 . DP=21;I16=10,11,0,0,754,27902,0,0,1260,75600,0,0,370,8084,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,51:2:0 0,12,145:4:0 +17 1811 . C 0 . DP=22;I16=11,11,0,0,837,32353,0,0,1320,79200,0,0,368,8056,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,61:2:0 0,12,146:4:0 +17 1812 . T 0 . DP=22;I16=11,11,0,0,830,31782,0,0,1320,79200,0,0,365,7955,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,60:2:0 0,12,151:4:0 +17 1813 . G 0 . DP=21;I16=11,10,0,0,789,29971,0,0,1260,75600,0,0,363,7879,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,63:2:0 0,12,135:4:0 +17 1814 . A 0 . DP=21;I16=11,10,0,0,780,29356,0,0,1260,75600,0,0,361,7827,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,63:2:0 0,12,148:4:0 +17 1815 . G 0 . DP=21;I16=11,10,0,0,742,27064,0,0,1260,75600,0,0,358,7748,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,56:2:0 0,12,135:4:0 +17 1816 . G 0 . DP=21;I16=11,10,0,0,702,24670,0,0,1260,75600,0,0,355,7691,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,49:2:0 0,12,124:4:0 +17 1817 . C 0 . DP=20;I16=11,9,0,0,701,25263,0,0,1200,72000,0,0,353,7655,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,58:2:0 0,12,134:4:0 +17 1818 . C 0 . DP=20;I16=11,8,0,0,665,23987,0,0,1140,68400,0,0,326,7014,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,53:2:0 0,12,132:4:0 +17 1819 . C 0 . DP=18;I16=9,9,0,0,580,20092,0,0,1080,64800,0,0,351,7641,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,38:2:0 0,12,124:4:0 +17 1820 . G 0 . DP=18;I16=9,9,0,0,589,19883,0,0,1080,64800,0,0,351,7659,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,58:2:0 0,12,117:4:0 +17 1821 . C 0 . DP=18;I16=9,9,0,0,619,22131,0,0,1080,64800,0,0,351,7693,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,60:2:0 0,12,131:4:0 +17 1822 . C 0 . DP=18;I16=9,9,0,0,655,24177,0,0,1080,64800,0,0,350,7694,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,58:2:0 0,12,131:4:0 +17 1823 . C 0 . DP=19;I16=10,9,0,0,703,26765,0,0,1140,68400,0,0,349,7713,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,62:2:0 0,12,138:4:0 +17 1824 . T 0 . DP=19;I16=10,9,0,0,714,27628,0,0,1140,68400,0,0,349,7751,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,69:2:0 0,12,149:4:0 +17 1825 . G 0 . DP=19;I16=10,9,0,0,682,24804,0,0,1140,68400,0,0,347,7709,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,61:2:0 0,12,129:4:0 +17 1826 . T 0 . DP=19;I16=10,9,0,0,643,22525,0,0,1140,68400,0,0,345,7687,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,62:2:0 0,12,141:4:0 +17 1827 . G 0 . DP=19;I16=10,9,0,0,722,27844,0,0,1140,68400,0,0,343,7685,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,66:2:0 0,12,134:4:0 +17 1828 . G 0 . DP=18;I16=10,8,0,0,619,21719,0,0,1080,64800,0,0,342,7702,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,61:2:0 0,9,100:3:0 +17 1829 . C 0 . DP=19;I16=9,9,0,0,576,19228,0,0,1080,64800,0,0,323,7413,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,59:3:0 0,9,103:3:0 +17 1830 . G 0 . DP=19;I16=9,9,0,0,582,19586,0,0,1080,64800,0,0,321,7379,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,82:3:0 0,9,80:3:0 +17 1831 . T 0 . DP=20;I16=10,8,0,0,605,21015,0,0,1080,64800,0,0,294,6736,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,106:4:0 0,9,101:3:0 +17 1832 . C 0 . DP=19;I16=9,9,0,0,675,25747,0,0,1080,64800,0,0,319,7359,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,110:4:0 0,9,105:3:0 +17 1833 . T 0 . DP=18;I16=8,8,0,0,565,20733,0,0,960,57600,0,0,295,6747,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,248:10:0 0,9,105:3:0 0,9,106:3:0 +17 1834 . C 0 . DP=19;I16=9,9,0,0,654,24424,0,0,1037,61489,0,0,321,7399,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,104:4:0 0,9,107:3:0 +17 1835 . T 0 . DP=18;I16=9,9,0,0,641,23505,0,0,1037,61489,0,0,347,7965,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,123:4:0 0,9,115:3:0 +17 1836 . C 0 . DP=18;I16=9,9,0,0,657,24427,0,0,1037,61489,0,0,350,8016,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,127:4:0 0,9,108:3:0 +17 1837 . C 0 . DP=18;I16=9,9,0,0,586,20044,0,0,1037,61489,0,0,352,8030,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,33,233:11:0 0,12,114:4:0 0,9,108:3:0 +17 1838 . C 0 . DP=18;I16=9,9,0,0,655,24607,0,0,1037,61489,0,0,354,8056,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,120:4:0 0,9,107:3:0 +17 1839 . T 0 . DP=18;I16=9,7,0,0,557,20543,0,0,917,54289,0,0,321,7369,0,0;QS=3,0;MQSB=0.933674;MQ0F=0 PL:DP:DV 0,30,231:10:0 0,9,103:3:0 0,9,119:3:0 +17 1840 . C 0 . DP=18;I16=9,9,0,0,637,23295,0,0,1037,61489,0,0,358,8144,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,116:4:0 0,9,109:3:0 +17 1841 . C 0 . DP=18;I16=9,9,0,0,622,22458,0,0,1037,61489,0,0,360,8206,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,33,252:11:0 0,12,121:4:0 0,9,108:3:0 +17 1842 . C 0 . DP=18;I16=9,9,0,0,672,26064,0,0,1037,61489,0,0,362,8280,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,124:4:0 0,9,108:3:0 +17 1843 . T 0 . DP=18;I16=9,9,0,0,630,22746,0,0,1037,61489,0,0,364,8366,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,33,243:11:0 0,12,131:4:0 0,9,107:3:0 +17 1844 . T 0 . DP=18;I16=9,9,0,0,618,21618,0,0,1037,61489,0,0,366,8464,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,33,240:11:0 0,12,137:4:0 0,9,98:3:0 +17 1845 . G 0 . DP=18;I16=9,9,0,0,644,23976,0,0,1037,61489,0,0,368,8574,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,138:4:0 0,9,82:3:0 +17 1846 . C 0 . DP=18;I16=9,9,0,0,687,26809,0,0,1037,61489,0,0,370,8696,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,129:4:0 0,9,100:3:0 +17 1847 . T 0 . DP=18;I16=9,9,0,0,675,25529,0,0,1037,61489,0,0,373,8829,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,132:4:0 0,6,76:2:0 +17 1848 . G 0 . DP=18;I16=9,9,0,0,597,20845,0,0,1037,61489,0,0,377,8973,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,118:4:0 0,6,64:2:0 +17 1849 . T 0 . DP=20;I16=9,10,0,0,614,20770,0,0,1097,65089,0,0,380,9078,0,0;QS=3,0;MQSB=0.920044;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,119:4:0 0,6,71:2:0 +17 1850 . C 0 . DP=19;I16=8,11,0,0,684,25154,0,0,1097,65089,0,0,409,9769,0,0;QS=3,0;MQSB=0.902014;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,120:4:0 0,3,37:1:0 +17 1851 . A 0 . DP=20;I16=9,11,0,0,738,27838,0,0,1157,68689,0,0,413,9847,0,0;QS=3,0;MQSB=0.916401;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,143:4:0 0,3,41:1:0 +17 1852 . G 0 . DP=19;I16=8,11,0,0,639,22239,0,0,1097,65089,0,0,392,9264,0,0;QS=3,0;MQSB=0.902014;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,117:4:0 0,3,36:1:0 +17 1853 . G 0 . DP=20;I16=9,11,0,0,627,20873,0,0,1157,68689,0,0,396,9322,0,0;QS=3,0;MQSB=0.916401;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,127:5:0 0,3,38:1:0 +17 1854 . A 0 . DP=22;I16=10,11,0,0,674,22428,0,0,1217,72289,0,0,401,9397,0,0;QS=3,0;MQSB=0.927743;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,145:5:0 0,3,38:1:0 +17 1855 . C 0 . DP=22;I16=10,12,0,0,771,27949,0,0,1277,75889,0,0,407,9441,0,0;QS=3,0;MQSB=0.924723;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,132:5:0 0,3,37:1:0 +17 1856 . A 0 . DP=22;I16=10,12,0,0,806,30230,0,0,1277,75889,0,0,412,9456,0,0;QS=3,0;MQSB=0.924723;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,146:5:0 0,3,41:1:0 +17 1857 . G 0 . DP=22;I16=10,12,0,0,699,23919,0,0,1277,75889,0,0,416,9442,0,0;QS=3,0;MQSB=0.924723;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,134:5:0 0,3,35:1:0 +17 1858 . T 0 . DP=23;I16=10,13,0,0,773,26797,0,0,1337,79489,0,0,419,9399,0,0;QS=3,0;MQSB=0.921963;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,148:5:0 0,3,37:1:0 +17 1859 . G 0 . DP=23;I16=10,13,0,0,798,28594,0,0,1337,79489,0,0,423,9379,0,0;QS=3,0;MQSB=0.921963;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,146:5:0 0,3,36:1:0 +17 1860 . G 0 . DP=23;I16=10,13,0,0,726,23842,0,0,1337,79489,0,0,425,9283,0,0;QS=3,0;MQSB=0.921963;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,126:5:0 0,3,33:1:0 +17 1861 . T 0 . DP=23;I16=10,13,0,0,741,24793,0,0,1337,79489,0,0,425,9113,0,0;QS=3,0;MQSB=0.921963;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,143:5:0 0,3,39:1:0 +17 1862 . C 0 . DP=23;I16=10,12,0,0,738,25732,0,0,1277,75889,0,0,403,8487,0,0;QS=3,0;MQSB=0.924723;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,135:5:0 0,3,34:1:0 +17 1863 . C 0 . DP=24;I16=10,13,0,0,804,29186,0,0,1337,79489,0,0,400,8232,0,0;QS=3,0;MQSB=0.921963;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,133:5:0 0,3,36:1:0 +17 1864 . T 0 . DP=24;I16=11,11,0,0,766,27572,0,0,1277,75889,0,0,392,8174,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,125:4:0 0,3,37:1:0 +17 1865 . G 0 . DP=24;I16=11,13,0,0,860,31394,0,0,1397,83089,0,0,425,8621,0,0;QS=3,0;MQSB=0.931547;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,154:5:0 0,3,38:1:0 +17 1866 . G 0 . DP=24;I16=11,13,0,0,795,27503,0,0,1397,83089,0,0,425,8551,0,0;QS=3,0;MQSB=0.931547;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,152:5:0 0,3,36:1:0 +17 1867 . C 0 . DP=24;I16=9,13,0,0,726,24886,0,0,1320,79200,0,0,375,7263,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,122:5:0 0,3,38:1:0 +17 1868 . C 0 . DP=24;I16=11,12,0,0,857,32293,0,0,1337,79489,0,0,411,8311,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,12,118:4:0 0,3,41:1:0 +17 1869 . A T, 0 . DP=24;I16=6,9,5,4,531,19001,268,8660,857,50689,540,32400,273,5667,152,2866;QS=1.4724,1.5276,0;VDB=0.928022;SGB=-11.9537;RPB=0.984127;MQB=0.96464;MQSB=0.931547;BQB=0.359155;MQ0F=0 PL:DP:DV 115,0,224,148,245,255:18:7 16,0,104,28,107,128:5:1 42,3,0,42,3,42:1:1 +17 1870 . C 0 . DP=25;I16=11,13,0,0,804,27826,0,0,1397,83089,0,0,425,8591,0,0;QS=3,0;MQSB=0.931547;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,127:5:0 0,3,36:1:0 +17 1871 . C 0 . DP=25;I16=11,14,0,0,761,24187,0,0,1457,86689,0,0,428,8690,0,0;QS=3,0;MQSB=0.929204;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,128:6:0 0,3,29:1:0 +17 1872 . G 0 . DP=25;I16=10,14,0,0,763,25437,0,0,1397,83089,0,0,425,8803,0,0;QS=3,0;MQSB=0.919431;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,132:6:0 0,3,43:1:0 +17 1873 . G 0 . DP=26;I16=11,15,0,0,790,25548,0,0,1517,90289,0,0,429,8931,0,0;QS=3,0;MQSB=0.927041;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,151:7:0 0,3,43:1:0 +17 1874 . G 0 . DP=27;I16=11,16,0,0,861,29013,0,0,1577,93889,0,0,430,9076,0,0;QS=3,0;MQSB=0.925036;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,24,172:8:0 0,3,43:1:0 +17 1875 . G 0 . DP=26;I16=11,15,0,0,800,26216,0,0,1517,90289,0,0,431,9155,0,0;QS=3,0;MQSB=0.927041;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,168:7:0 0,3,42:1:0 +17 1876 . C 0 . DP=26;I16=10,15,0,0,894,32714,0,0,1457,86689,0,0,432,9268,0,0;QS=3,0;MQSB=0.9171;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,171:7:0 0,3,41:1:0 +17 1877 . T 0 . DP=25;I16=9,15,0,0,848,30804,0,0,1397,83089,0,0,409,8787,0,0;QS=3,0;MQSB=0.904837;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,163:6:0 0,3,42:1:0 +17 1878 . C 0 . DP=25;I16=10,15,0,0,906,33478,0,0,1457,86689,0,0,434,9488,0,0;QS=3,0;MQSB=0.9171;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,166:7:0 0,3,40:1:0 +17 1879 . A 0 . DP=26;I16=10,16,0,0,911,32761,0,0,1517,90289,0,0,433,9543,0,0;QS=3,0;MQSB=0.914947;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,191:8:0 0,3,40:1:0 +17 1880 . C 0 . DP=26;I16=10,16,0,0,790,24876,0,0,1517,90289,0,0,431,9527,0,0;QS=3,0;MQSB=0.914947;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,152:8:0 0,3,31:1:0 +17 1881 . G 0 . DP=27;I16=10,15,0,0,782,25352,0,0,1500,90000,0,0,380,8288,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,144:7:0 0,3,42:1:0 +17 1882 . G 0 . DP=28;I16=12,15,0,0,937,33215,0,0,1577,93889,0,0,406,8952,0,0;QS=3,0;MQSB=0.935229;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,164:7:0 0,3,42:1:0 +17 1883 . A 0 . DP=29;I16=14,15,0,0,998,35394,0,0,1697,101089,0,0,434,9646,0,0;QS=3,0;MQSB=0.947838;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,24,180:8:0 0,3,43:1:0 +17 1884 . G 0 . DP=29;I16=14,15,0,0,1036,37926,0,0,1697,101089,0,0,437,9647,0,0;QS=3,0;MQSB=0.947838;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,24,202:8:0 0,3,42:1:0 +17 1885 . C 0 . DP=28;I16=14,13,0,0,925,32305,0,0,1577,93889,0,0,430,9560,0,0;QS=3,0;MQSB=0.951472;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,182:7:0 0,3,42:1:0 +17 1886 . C 0 . DP=26;I16=13,13,0,0,826,27194,0,0,1517,90289,0,0,447,9745,0,0;QS=3,0;MQSB=0.945959;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,166:8:0 0,3,32:1:0 +17 1887 . G 0 . DP=26;I16=12,13,0,0,798,26554,0,0,1500,90000,0,0,428,9212,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,185:8:0 0,3,40:1:0 +17 1888 . C 0 . DP=26;I16=13,13,0,0,901,32343,0,0,1517,90289,0,0,459,9957,0,0;QS=3,0;MQSB=0.945959;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,178:8:0 0,3,39:1:0 +17 1889 . C 0 . DP=25;I16=13,11,0,0,825,29127,0,0,1397,83089,0,0,444,9612,0,0;QS=3,0;MQSB=0.950498;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,187:7:0 0,3,37:1:0 +17 1890 . C 0 . DP=25;I16=13,12,0,0,913,34029,0,0,1457,86689,0,0,471,10173,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,198:8:0 0,3,40:1:0 +17 1891 . T 0 . DP=25;I16=13,12,0,0,912,34028,0,0,1457,86689,0,0,477,10317,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,212:8:0 0,3,39:1:0 +17 1892 . G 0 . DP=25;I16=12,12,0,0,885,33149,0,0,1397,83089,0,0,458,9860,0,0;QS=3,0;MQSB=0.941765;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,166:7:0 0,3,37:1:0 +17 1893 . T 0 . DP=26;I16=14,12,0,0,920,33494,0,0,1517,90289,0,0,489,10677,0,0;QS=3,0;MQSB=0.953497;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,205:8:0 0,6,72:2:0 +17 1894 . G 0 . DP=26;I16=14,12,0,0,934,35048,0,0,1517,90289,0,0,495,10843,0,0;QS=3,0;MQSB=0.953497;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,188:8:0 0,6,75:2:0 +17 1895 . C 0 . DP=26;I16=13,12,0,0,882,31980,0,0,1500,90000,0,0,476,10408,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,24,180:8:0 0,6,73:2:0 +17 1896 . C 0 . DP=26;I16=14,11,0,0,827,28179,0,0,1457,86689,0,0,482,10622,0,0;QS=3,0;MQSB=0.955682;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,154:7:0 0,6,72:2:0 +17 1897 . G 0 . DP=26;I16=13,11,0,0,763,25169,0,0,1397,83089,0,0,486,10856,0,0;QS=3,0;MQSB=0.950498;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,164:7:0 0,3,27:1:0 +17 1898 . T 0 . DP=27;I16=14,11,0,0,846,29526,0,0,1500,90000,0,0,492,11072,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,24,187:8:0 0,6,62:2:0 +17 1899 . G 0 . DP=27;I16=14,11,0,0,875,32007,0,0,1500,90000,0,0,497,11213,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,24,188:8:0 0,6,61:2:0 +17 1900 . T 0 . DP=26;I16=14,11,0,0,850,29882,0,0,1500,90000,0,0,501,11329,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,24,185:8:0 0,6,69:2:0 +17 1901 . A 0 . DP=27;I16=15,10,0,0,842,29298,0,0,1457,86689,0,0,505,11469,0,0;QS=3,0;MQSB=0.962269;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,190:7:0 0,6,68:2:0 +17 1902 . C 0 . DP=27;I16=15,12,0,0,912,31970,0,0,1577,93889,0,0,537,12267,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,184:8:0 0,6,60:2:0 +17 1903 . C 0 . DP=27;I16=15,12,0,0,959,34645,0,0,1577,93889,0,0,542,12462,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,201:8:0 0,6,63:2:0 +17 1904 . T 0 . DP=27;I16=16,11,0,0,1017,38757,0,0,1577,93889,0,0,548,12682,0,0;QS=3,0;MQSB=0.96384;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,221:8:0 0,6,77:2:0 +17 1905 . C 0 . DP=27;I16=16,11,0,0,985,36561,0,0,1577,93889,0,0,553,12827,0,0;QS=3,0;MQSB=0.96384;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,211:8:0 0,6,69:2:0 +17 1906 . T 0 . DP=27;I16=16,11,0,0,1018,39242,0,0,1577,93889,0,0,558,12998,0,0;QS=3,0;MQSB=0.96384;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,207:8:0 0,6,75:2:0 +17 1907 . G 0 . DP=27;I16=15,11,0,0,935,34679,0,0,1517,90289,0,0,535,12419,0,0;QS=3,0;MQSB=0.960078;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,187:7:0 0,6,68:2:0 +17 1908 . A 0 . DP=28;I16=16,12,0,0,1023,38221,0,0,1637,97489,0,0,561,13063,0,0;QS=3,0;MQSB=0.96195;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,24,215:8:0 0,6,67:2:0 +17 1909 . G 0 . DP=27;I16=15,12,0,0,1002,38398,0,0,1577,93889,0,0,561,12953,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,206:8:0 0,6,73:2:0 +17 1910 . C 0 . DP=27;I16=14,10,0,0,855,31251,0,0,1440,86400,0,0,502,11588,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,179:7:0 0,6,71:2:0 +17 1911 . C 0 . DP=27;I16=15,12,0,0,967,35429,0,0,1577,93889,0,0,561,12793,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,206:8:0 0,6,71:2:0 +17 1912 . C 0 . DP=27;I16=15,12,0,0,1024,39272,0,0,1577,93889,0,0,561,12743,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,217:8:0 0,6,73:2:0 +17 1913 . T 0 . DP=27;I16=15,12,0,0,1028,39768,0,0,1577,93889,0,0,561,12713,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,228:8:0 0,6,77:2:0 +17 1914 . C 0 . DP=27;I16=15,12,0,0,1010,38762,0,0,1577,93889,0,0,561,12703,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,221:8:0 0,6,75:2:0 +17 1915 . T C, 0 . DP=27;I16=14,12,1,0,974,37184,16,256,1560,93600,17,289,543,12389,18,324;QS=2.97351,0.0264901,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.958048;BQB=1;MQ0F=0 PL:DP:DV 0,34,255,48,255,255:17:1 0,24,231,24,231,231:8:0 0,6,60,6,60,60:2:0 +17 1916 . G T, 0 . DP=27;I16=14,12,1,0,991,38291,15,225,1560,93600,17,289,544,12454,17,289;QS=2.97581,0.0241935,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.958048;BQB=1;MQ0F=0 PL:DP:DV 0,35,255,48,255,255:17:1 0,24,226,24,226,226:8:0 0,6,69,6,69,69:2:0 +17 1917 . C 0 . DP=27;I16=15,12,0,0,1030,39740,0,0,1577,93889,0,0,561,12793,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,214:8:0 0,6,73:2:0 +17 1918 . A 0 . DP=27;I16=15,11,0,0,963,36201,0,0,1517,90289,0,0,542,12502,0,0;QS=3,0;MQSB=0.960078;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,217:8:0 0,6,72:2:0 +17 1919 . C 0 . DP=27;I16=15,12,0,0,987,36651,0,0,1577,93889,0,0,560,12902,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,214:8:0 0,6,72:2:0 +17 1920 . A T, 0 . DP=29;I16=15,12,0,1,1007,38337,14,196,1546,91130,60,3600,538,12518,21,441;QS=2.97647,0.0235294,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.999735;BQB=1;MQ0F=0 PL:DP:DV 0,36,255,48,255,255:17:1 0,24,225,24,225,225:8:0 0,9,101,9,101,101:3:0 +17 1921 . G 0 . DP=30;I16=15,14,0,0,1059,39815,0,0,1666,98330,0,0,542,12474,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,182:7:0 0,12,132:4:0 +17 1922 . T 0 . DP=29;I16=14,14,0,0,1013,37513,0,0,1649,98041,0,0,532,12418,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,197:7:0 0,12,134:4:0 +17 1923 . G 0 . DP=28;I16=14,14,0,0,1034,38974,0,0,1606,94730,0,0,545,12629,0,0;QS=3,0;MQSB=0.999736;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,188:7:0 0,12,126:4:0 +17 1924 . C 0 . DP=27;I16=13,13,0,0,965,36587,0,0,1486,87530,0,0,521,12017,0,0;QS=3,0;MQSB=0.999671;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,183:7:0 0,12,116:4:0 +17 1925 . C 0 . DP=27;I16=14,13,0,0,987,37021,0,0,1546,91130,0,0,546,12626,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,187:7:0 0,12,124:4:0 +17 1926 . T 0 . DP=27;I16=14,13,0,0,1031,40057,0,0,1546,91130,0,0,545,12581,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,197:7:0 0,12,141:4:0 +17 1927 . T 0 . DP=27;I16=13,13,0,0,959,35773,0,0,1529,90841,0,0,538,12522,0,0;QS=3,0;MQSB=0.945959;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,191:7:0 0,12,133:4:0 +17 1928 . C 0 . DP=27;I16=13,13,0,0,986,38264,0,0,1529,90841,0,0,538,12532,0,0;QS=3,0;MQSB=0.945959;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,189:7:0 0,12,125:4:0 +17 1929 . T 0 . DP=27;I16=13,13,0,0,990,38630,0,0,1529,90841,0,0,538,12562,0,0;QS=3,0;MQSB=0.945959;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,189:7:0 0,12,139:4:0 +17 1930 . G 0 . DP=26;I16=13,11,0,0,905,34865,0,0,1409,83641,0,0,521,12271,0,0;QS=3,0;MQSB=0.931547;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,179:6:0 0,9,99:3:0 +17 1931 . C 0 . DP=27;I16=15,12,0,0,967,36293,0,0,1546,91130,0,0,540,12578,0,0;QS=3,0;MQSB=0.99881;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,165:6:0 0,12,121:4:0 +17 1932 . T 0 . DP=27;I16=14,13,0,0,998,38154,0,0,1546,91130,0,0,541,12605,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,143:5:0 0,15,146:5:0 +17 1933 . T 0 . DP=27;I16=14,13,0,0,962,35344,0,0,1546,91130,0,0,542,12602,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,142:5:0 0,15,158:5:0 +17 1934 . G 0 . DP=27;I16=13,13,0,0,987,38219,0,0,1529,90841,0,0,543,12569,0,0;QS=3,0;MQSB=0.945959;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,134:5:0 0,15,143:5:0 +17 1935 . C 0 . DP=27;I16=14,12,0,0,963,36627,0,0,1529,90841,0,0,520,11930,0,0;QS=3,0;MQSB=0.937241;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,162:6:0 0,15,154:5:0 +17 1936 . C 0 . DP=27;I16=14,13,0,0,1018,39406,0,0,1589,94441,0,0,547,12561,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,177:6:0 0,15,159:5:0 +17 1937 . T 0 . DP=27;I16=14,13,0,0,1036,40636,0,0,1589,94441,0,0,547,12489,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,182:6:0 0,15,170:5:0 +17 1938 . G 0 . DP=27;I16=14,13,0,0,1001,38377,0,0,1589,94441,0,0,546,12392,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,166:6:0 0,15,155:5:0 +17 1939 . T 0 . DP=27;I16=14,12,0,0,964,36430,0,0,1560,93600,0,0,525,11909,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,167:6:0 0,12,144:4:0 +17 1940 . G 0 . DP=27;I16=14,13,0,0,1003,37937,0,0,1589,94441,0,0,542,12172,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,159:6:0 0,15,155:5:0 +17 1941 . G 0 . DP=27;I16=14,13,0,0,1004,38072,0,0,1589,94441,0,0,540,12098,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,176:6:0 0,15,156:5:0 +17 1942 . C 0 . DP=27;I16=14,12,0,0,996,38790,0,0,1560,93600,0,0,516,11564,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,174:6:0 0,12,140:4:0 +17 1943 . T 0 . DP=27;I16=14,13,0,0,1044,40952,0,0,1589,94441,0,0,536,12022,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,184:6:0 0,15,167:5:0 +17 1944 . T 0 . DP=27;I16=14,13,0,0,987,37237,0,0,1589,94441,0,0,533,11971,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,175:6:0 0,15,170:5:0 +17 1945 . T 0 . DP=27;I16=14,13,0,0,993,37067,0,0,1589,94441,0,0,530,11946,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,174:6:0 0,15,171:5:0 +17 1946 . G 0 . DP=27;I16=14,13,0,0,1013,38617,0,0,1589,94441,0,0,526,11896,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,162:6:0 0,15,162:5:0 +17 1947 . A 0 . DP=26;I16=13,13,0,0,950,35522,0,0,1529,90841,0,0,522,11818,0,0;QS=3,0;MQSB=0.945959;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,167:6:0 0,15,160:5:0 +17 1948 . G C, 0 . DP=27;I16=14,12,0,1,966,36912,16,256,1560,93600,29,841,493,11135,25,625;QS=2.90361,0.0963855,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.94394;BQB=1;MQ0F=0 PL:DP:DV 0,45,255,45,255,255:15:0 0,21,190,21,190,190:7:0 1,0,123,13,126,132:5:1 +17 1949 . A 0 . DP=26;I16=14,11,0,0,871,31325,0,0,1469,87241,0,0,490,11048,0,0;QS=3,0;MQSB=0.929204;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,174:7:0 0,15,155:5:0 +17 1950 . A 0 . DP=27;I16=14,13,0,0,1007,38049,0,0,1589,94441,0,0,511,11559,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,21,205:7:0 0,18,176:6:0 +17 1951 . G 0 . DP=27;I16=14,13,0,0,960,35536,0,0,1589,94441,0,0,509,11469,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,21,180:7:0 0,18,181:6:0 +17 1952 . A 0 . DP=27;I16=14,12,0,0,924,33366,0,0,1529,90841,0,0,483,10779,0,0;QS=3,0;MQSB=0.937241;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,184:7:0 0,18,182:6:0 +17 1953 . A 0 . DP=28;I16=15,12,0,0,925,32719,0,0,1589,94441,0,0,482,10740,0,0;QS=3,0;MQSB=0.935229;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,21,189:7:0 0,18,168:6:0 +17 1954 . A C, 0 . DP=29;I16=14,13,0,1,929,33219,18,324,1620,97200,29,841,475,10679,25,625;QS=2.90217,0.0978261,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.949591;BQB=1;MQ0F=0 PL:DP:DV 0,45,255,45,255,255:15:0 0,21,198,21,198,198:7:0 0,0,130,15,133,141:6:1 +17 1955 . C 0 . DP=29;I16=14,12,0,0,961,36067,0,0,1560,93600,0,0,451,10035,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,21,206:7:0 0,15,165:5:0 +17 1956 . C 0 . DP=29;I16=14,13,0,0,964,35402,0,0,1620,97200,0,0,475,10573,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,196:7:0 0,15,164:5:0 +17 1957 . C 0 . DP=29;I16=14,13,0,0,980,36212,0,0,1620,97200,0,0,472,10420,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,183:7:0 0,15,167:5:0 +17 1958 . C 0 . DP=29;I16=15,13,0,0,1003,37293,0,0,1649,98041,0,0,493,10825,0,0;QS=3,0;MQSB=0.942064;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,191:7:0 0,18,190:6:0 +17 1959 . T 0 . DP=29;I16=16,13,0,0,1112,43258,0,0,1709,101641,0,0,491,10593,0,0;QS=3,0;MQSB=0.940317;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,213:7:0 0,18,193:6:0 +17 1960 . T 0 . DP=30;I16=17,13,0,0,1053,37939,0,0,1769,105241,0,0,485,10339,0,0;QS=3,0;MQSB=0.938685;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,196:7:0 0,18,186:6:0 +17 1961 . C 0 . DP=30;I16=17,13,0,0,1101,41737,0,0,1769,105241,0,0,480,10122,0,0;QS=3,0;MQSB=0.938685;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,195:7:0 0,18,183:6:0 +17 1962 . T 0 . DP=29;I16=17,12,0,0,1134,44582,0,0,1709,101641,0,0,477,9941,0,0;QS=3,0;MQSB=0.931617;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,208:7:0 0,18,198:6:0 +17 1963 . G 0 . DP=28;I16=16,12,0,0,1066,41050,0,0,1649,98041,0,0,476,9794,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,192:7:0 0,18,188:6:0 +17 1964 . G 0 . DP=28;I16=16,12,0,0,970,34764,0,0,1649,98041,0,0,475,9681,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,178:7:0 0,18,169:6:0 +17 1965 . T 0 . DP=29;I16=16,12,0,0,964,34772,0,0,1649,98041,0,0,449,8977,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,196:7:0 0,18,171:6:0 +17 1966 . T 0 . DP=29;I16=16,13,0,0,1029,37027,0,0,1709,101641,0,0,474,9558,0,0;QS=3,0;MQSB=0.940317;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,191:7:0 0,18,181:6:0 +17 1967 . A 0 . DP=29;I16=16,13,0,0,1030,37234,0,0,1709,101641,0,0,474,9550,0,0;QS=3,0;MQSB=0.940317;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,187:7:0 0,18,182:6:0 +17 1968 . T 0 . DP=29;I16=16,13,0,0,1075,40173,0,0,1709,101641,0,0,474,9578,0,0;QS=3,0;MQSB=0.940317;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,195:7:0 0,18,190:6:0 +17 1969 . A 0 . DP=28;I16=16,12,0,0,992,35828,0,0,1649,98041,0,0,474,9592,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,175:6:0 0,18,186:6:0 +17 1970 . C 0 . DP=28;I16=16,12,0,0,1015,37503,0,0,1649,98041,0,0,474,9642,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,170:6:0 0,18,180:6:0 +17 1971 . A 0 . DP=29;I16=16,13,0,0,1073,40273,0,0,1709,101641,0,0,474,9728,0,0;QS=3,0;MQSB=0.940317;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,178:6:0 0,21,206:7:0 +17 1972 . T 0 . DP=30;I16=16,14,0,0,1068,38978,0,0,1769,105241,0,0,475,9851,0,0;QS=3,0;MQSB=0.946202;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,176:6:0 0,21,203:7:0 +17 1973 . A 0 . DP=30;I16=16,13,0,0,1046,38070,0,0,1740,104400,0,0,452,9388,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,172:6:0 0,18,196:6:0 +17 1974 . A 0 . DP=29;I16=16,13,0,0,1086,41474,0,0,1709,101641,0,0,477,10065,0,0;QS=3,0;MQSB=0.940317;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,157:5:0 0,21,214:7:0 +17 1975 . G 0 . DP=28;I16=16,12,0,0,1067,41171,0,0,1649,98041,0,0,478,10156,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,133:4:0 0,21,195:7:0 +17 1976 . A 0 . DP=28;I16=16,12,0,0,981,34839,0,0,1649,98041,0,0,478,10234,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,125:4:0 0,21,199:7:0 +17 1977 . C 0 . DP=28;I16=16,12,0,0,1009,37471,0,0,1649,98041,0,0,477,10297,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,132:4:0 0,21,194:7:0 +17 1978 . A 0 . DP=28;I16=16,12,0,0,1082,42132,0,0,1649,98041,0,0,476,10394,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,144:4:0 0,21,220:7:0 +17 1979 . G 0 . DP=28;I16=16,11,0,0,1019,38927,0,0,1589,94441,0,0,454,10064,0,0;QS=3,0;MQSB=0.925036;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,122:4:0 0,21,208:7:0 +17 1980 . C 0 . DP=27;I16=16,10,0,0,932,34456,0,0,1529,90841,0,0,452,10114,0,0;QS=3,0;MQSB=0.914947;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,107:3:0 0,21,197:7:0 +17 1981 . C 0 . DP=28;I16=16,12,0,0,998,36510,0,0,1649,98041,0,0,469,10479,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,9,101:3:0 0,24,219:8:0 +17 1982 . A 0 . DP=29;I16=16,12,0,0,1035,38815,0,0,1649,98041,0,0,472,10548,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,110:3:0 0,27,254:9:0 +17 1983 . G 0 . DP=28;I16=16,12,0,0,1048,40322,0,0,1649,98041,0,0,477,10599,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,96:3:0 0,27,249:9:0 +17 1984 . A 0 . DP=27;I16=16,11,0,0,1024,39232,0,0,1589,94441,0,0,482,10632,0,0;QS=3,0;MQSB=0.925036;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,70:2:0 0,27,255:9:0 +17 1985 . G 0 . DP=27;I16=16,11,0,0,1009,38449,0,0,1589,94441,0,0,487,10695,0,0;QS=3,0;MQSB=0.925036;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,66:2:0 0,27,231:9:0 +17 1986 . A 0 . DP=27;I16=16,10,0,0,926,33696,0,0,1560,93600,0,0,466,10112,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,76:2:0 0,24,223:8:0 +17 1987 . A 0 . DP=28;I16=17,11,0,0,1034,39088,0,0,1649,98041,0,0,495,10807,0,0;QS=3,0;MQSB=0.923174;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,78:2:0 0,27,247:9:0 +17 1988 . G 0 . DP=28;I16=17,11,0,0,1050,39980,0,0,1649,98041,0,0,499,10855,0,0;QS=3,0;MQSB=0.923174;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,63:2:0 0,27,239:9:0 +17 1989 . G 0 . DP=28;I16=17,10,0,0,994,37610,0,0,1589,94441,0,0,493,10801,0,0;QS=3,0;MQSB=0.912952;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,73:2:0 0,27,237:9:0 +17 1990 . G T, 0 . DP=28;I16=17,9,0,1,965,36359,33,1089,1560,93600,29,841,472,10250,25,625;QS=2.90675,0.0932476,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.912952;BQB=1;MQ0F=0 PL:DP:DV 0,48,255,48,255,255:16:0 0,6,71,6,71,71:2:0 2,0,195,26,198,215:9:1 +17 1991 . A 0 . DP=28;I16=17,11,0,0,1017,38203,0,0,1649,98041,0,0,507,10975,0,0;QS=3,0;MQSB=0.923174;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,60:2:0 0,27,250:9:0 +17 1992 . G 0 . DP=28;I16=17,11,0,0,1028,38852,0,0,1649,98041,0,0,509,11039,0,0;QS=3,0;MQSB=0.923174;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,62:2:0 0,27,231:9:0 +17 1993 . T 0 . DP=28;I16=17,11,0,0,1015,37325,0,0,1649,98041,0,0,511,11131,0,0;QS=3,0;MQSB=0.923174;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,59:2:0 0,27,243:9:0 +17 1994 . T 0 . DP=27;I16=16,11,0,0,942,33698,0,0,1589,94441,0,0,514,11250,0,0;QS=3,0;MQSB=0.925036;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,54:2:0 0,24,216:8:0 +17 1995 . G 0 . DP=28;I16=16,11,0,0,960,35432,0,0,1620,97200,0,0,492,10770,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,66:2:0 0,21,188:7:0 +17 1996 . C 0 . DP=29;I16=17,12,0,0,1022,37426,0,0,1709,101641,0,0,519,11469,0,0;QS=3,0;MQSB=0.931617;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,64:2:0 0,24,192:8:0 +17 1997 . C 0 . DP=29;I16=17,11,0,0,934,32858,0,0,1649,98041,0,0,520,11524,0,0;QS=3,0;MQSB=0.923174;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,70:2:0 0,24,193:8:0 +17 1998 . C 0 . DP=29;I16=17,12,0,0,1027,37843,0,0,1709,101641,0,0,522,11562,0,0;QS=3,0;MQSB=0.931617;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,69:2:0 0,24,222:8:0 +17 1999 . A 0 . DP=28;I16=17,11,0,0,1073,41493,0,0,1649,98041,0,0,525,11627,0,0;QS=3,0;MQSB=0.923174;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,72:2:0 0,21,206:7:0 +17 2000 . G 0 . DP=28;I16=16,11,0,0,1036,40576,0,0,1589,94441,0,0,511,11395,0,0;QS=3,0;MQSB=0.925036;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,72:2:0 0,18,168:6:0 +17 2001 . G 0 . DP=28;I16=15,11,0,0,955,35661,0,0,1529,90841,0,0,489,10853,0,0;QS=3,0;MQSB=0.927041;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,62:2:0 0,18,172:6:0 +17 2002 . G 0 . DP=28;I16=17,10,0,0,907,32227,0,0,1620,97200,0,0,519,11663,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,53:2:0 0,18,163:6:0 +17 2003 . T 0 . DP=28;I16=17,11,0,0,920,31866,0,0,1649,98041,0,0,541,12163,0,0;QS=3,0;MQSB=0.923174;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,49:2:0 0,21,190:7:0 +17 2004 . G 0 . DP=27;I16=16,10,0,0,970,36928,0,0,1560,93600,0,0,530,12110,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,57:2:0 0,18,178:6:0 +17 2005 . G 0 . DP=27;I16=16,10,0,0,868,30936,0,0,1560,93600,0,0,536,12370,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,59:2:0 0,18,153:6:0 +17 2006 . C 0 . DP=27;I16=16,10,0,0,968,37046,0,0,1560,93600,0,0,541,12605,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,73:2:0 0,18,166:6:0 +17 2007 . A 0 . DP=27;I16=16,11,0,0,1000,37396,0,0,1589,94441,0,0,556,12882,0,0;QS=3,0;MQSB=0.925036;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,76:2:0 0,21,193:7:0 +17 2008 . C 0 . DP=26;I16=16,10,0,0,964,36892,0,0,1529,90841,0,0,555,12833,0,0;QS=3,0;MQSB=0.914947;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,73:2:0 0,21,183:7:0 +17 2009 . A 0 . DP=26;I16=16,10,0,0,997,38955,0,0,1529,90841,0,0,554,12802,0,0;QS=3,0;MQSB=0.914947;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,74:2:0 0,21,210:7:0 +17 2010 . G 0 . DP=26;I16=16,9,0,0,936,36208,0,0,1500,90000,0,0,542,12640,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,73:2:0 0,18,169:6:0 +17 2011 . C 0 . DP=26;I16=16,9,0,0,966,37960,0,0,1500,90000,0,0,541,12617,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,74:2:0 0,18,175:6:0 +17 2012 . A 0 . DP=27;I16=16,11,0,0,956,35018,0,0,1589,94441,0,0,548,12676,0,0;QS=3,0;MQSB=0.925036;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,74:2:0 0,21,189:7:0 +17 2013 . C 0 . DP=27;I16=15,10,0,0,876,31370,0,0,1500,90000,0,0,514,11950,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,69:2:0 0,18,160:6:0 +17 2014 . G 0 . DP=27;I16=17,10,0,0,903,31239,0,0,1589,94441,0,0,545,12591,0,0;QS=3,0;MQSB=0.912952;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,9,80:3:0 0,18,160:6:0 +17 2015 . T 0 . DP=27;I16=17,10,0,0,999,37507,0,0,1589,94441,0,0,545,12577,0,0;QS=3,0;MQSB=0.912952;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,9,95:3:0 0,18,178:6:0 +17 2016 . T 0 . DP=27;I16=17,10,0,0,971,35649,0,0,1589,94441,0,0,545,12583,0,0;QS=3,0;MQSB=0.912952;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,9,93:3:0 0,18,178:6:0 +17 2017 . G 0 . DP=28;I16=17,11,0,0,1013,37849,0,0,1649,98041,0,0,545,12609,0,0;QS=3,0;MQSB=0.923174;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,9,91:3:0 0,18,172:6:0 +17 2018 . C 0 . DP=28;I16=17,11,0,0,1060,41414,0,0,1649,98041,0,0,546,12656,0,0;QS=3,0;MQSB=0.923174;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,9,97:3:0 0,18,169:6:0 +17 2019 . T 0 . DP=28;I16=17,11,0,0,1083,42253,0,0,1649,98041,0,0,547,12725,0,0;QS=3,0;MQSB=0.923174;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,9,106:3:0 0,18,187:6:0 +17 2020 . G 0 . DP=29;I16=18,11,0,0,1095,42063,0,0,1678,98882,0,0,548,12816,0,0;QS=3,0;MQSB=0.987702;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,9,85:3:0 0,18,175:6:0 +17 2021 . C 0 . DP=29;I16=18,11,0,0,1081,41535,0,0,1709,101641,0,0,551,12877,0,0;QS=3,0;MQSB=0.969907;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,9,97:3:0 0,15,167:5:0 +17 2022 . C 0 . DP=30;I16=19,11,0,0,1115,42003,0,0,1769,105241,0,0,555,12907,0,0;QS=3,0;MQSB=0.972375;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,9,92:3:0 0,18,177:6:0 +17 2023 . A 0 . DP=30;I16=19,10,0,0,1063,39991,0,0,1709,101641,0,0,549,12837,0,0;QS=3,0;MQSB=0.974027;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,9,96:3:0 0,18,186:6:0 +17 2024 . G 0 . DP=32;I16=20,12,0,0,1168,43872,0,0,1889,112441,0,0,564,12982,0,0;QS=3,0;MQSB=0.973096;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,9,92:3:0 0,24,203:8:0 +17 2025 . T 0 . DP=32;I16=20,12,0,0,1150,42122,0,0,1889,112441,0,0,569,12981,0,0;QS=3,0;MQSB=0.973096;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,9,87:3:0 0,24,226:8:0 +17 2026 . T 0 . DP=32;I16=20,12,0,0,1130,40724,0,0,1889,112441,0,0,572,12908,0,0;QS=3,0;MQSB=0.973096;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,9,94:3:0 0,24,208:8:0 +17 2027 . A 0 . DP=32;I16=19,12,0,0,1121,40871,0,0,1829,108841,0,0,550,12240,0,0;QS=3,0;MQSB=0.970829;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,9,84:3:0 0,21,207:7:0 +17 2028 . C 0 . DP=32;I16=20,12,0,0,1242,48548,0,0,1889,112441,0,0,577,12803,0,0;QS=3,0;MQSB=0.973096;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,9,94:3:0 0,24,228:8:0 +17 2029 . T 0 . DP=32;I16=20,12,0,0,1229,47605,0,0,1889,112441,0,0,578,12724,0,0;QS=3,0;MQSB=0.973096;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,9,102:3:0 0,24,236:8:0 +17 2030 . G 0 . DP=32;I16=20,12,0,0,1222,47140,0,0,1889,112441,0,0,579,12679,0,0;QS=3,0;MQSB=0.973096;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,9,93:3:0 0,24,216:8:0 +17 2031 . C 0 . DP=31;I16=19,12,0,0,1150,43656,0,0,1829,108841,0,0,581,12667,0,0;QS=3,0;MQSB=0.970829;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,9,96:3:0 0,24,204:8:0 +17 2032 . C 0 . DP=31;I16=19,12,0,0,1157,44035,0,0,1829,108841,0,0,583,12687,0,0;QS=3,0;MQSB=0.970829;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,9,90:3:0 0,24,210:8:0 +17 2033 . A 0 . DP=30;I16=19,11,0,0,1091,40223,0,0,1769,105241,0,0,585,12689,0,0;QS=3,0;MQSB=0.972375;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,9,93:3:0 0,21,203:7:0 +17 2034 . T 0 . DP=30;I16=19,11,0,0,1104,41498,0,0,1769,105241,0,0,587,12723,0,0;QS=3,0;MQSB=0.972375;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,9,91:3:0 0,21,208:7:0 +17 2035 . T 0 . DP=29;I16=18,11,0,0,1084,41024,0,0,1709,101641,0,0,589,12739,0,0;QS=3,0;MQSB=0.969907;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,6,69:2:0 0,21,211:7:0 +17 2036 . T 0 . DP=29;I16=18,11,0,0,1080,40612,0,0,1709,101641,0,0,591,12787,0,0;QS=3,0;MQSB=0.969907;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,6,67:2:0 0,21,216:7:0 +17 2037 . T 0 . DP=29;I16=18,11,0,0,1082,40956,0,0,1709,101641,0,0,592,12818,0,0;QS=3,0;MQSB=0.969907;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,6,69:2:0 0,21,217:7:0 +17 2038 . C 0 . DP=29;I16=18,11,0,0,1117,43573,0,0,1709,101641,0,0,592,12832,0,0;QS=3,0;MQSB=0.969907;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,6,69:2:0 0,21,211:7:0 +17 2039 . A 0 . DP=29;I16=18,11,0,0,1067,39581,0,0,1709,101641,0,0,592,12878,0,0;QS=3,0;MQSB=0.969907;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,6,72:2:0 0,21,212:7:0 +17 2040 . C 0 . DP=29;I16=18,11,0,0,1077,40469,0,0,1709,101641,0,0,590,12856,0,0;QS=3,0;MQSB=0.969907;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,6,69:2:0 0,21,196:7:0 +17 2041 . G A, 0 . DP=31;I16=6,5,12,7,389,14023,721,28149,660,39600,1109,65641,235,5607,353,7259;QS=0.917304,2.0827,0;VDB=0.816435;SGB=-4.18892;RPB=0.88473;MQB=0.972375;MQSB=0.968257;BQB=0.311275;MQ0F=0 PL:DP:DV 229,0,212,255,245,255:21:11 32,0,24,35,27,59:2:1 223,21,0,223,21,223:7:7 +17 2042 . G 0 . DP=32;I16=18,14,0,0,1189,45617,0,0,1889,112441,0,0,588,12910,0,0;QS=3,0;MQSB=0.965264;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,9,86:3:0 0,21,206:7:0 +17 2043 . G 0 . DP=32;I16=17,14,0,0,1115,41585,0,0,1829,108841,0,0,581,12891,0,0;QS=3,0;MQSB=0.962133;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,9,90:3:0 0,21,197:7:0 +17 2044 . C 0 . DP=32;I16=18,14,0,0,1213,47029,0,0,1889,112441,0,0,588,13006,0,0;QS=3,0;MQSB=0.965264;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,9,85:3:0 0,21,207:7:0 +17 2045 . A 0 . DP=32;I16=18,14,0,0,1181,44527,0,0,1889,112441,0,0,588,13108,0,0;QS=3,0;MQSB=0.965264;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,9,83:3:0 0,21,213:7:0 +17 2046 . T 0 . DP=32;I16=18,14,0,0,1197,45135,0,0,1889,112441,0,0,587,13195,0,0;QS=3,0;MQSB=0.965264;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,9,103:3:0 0,21,216:7:0 +17 2047 . G 0 . DP=34;I16=17,16,0,0,1248,47798,0,0,1949,116041,0,0,557,12491,0,0;QS=3,0;MQSB=0.959328;MQ0F=0 PL:DP:DV 0,72,255:24:0 0,9,88:3:0 0,18,195:6:0 +17 2048 . A 0 . DP=34;I16=18,16,0,0,1230,45184,0,0,2009,119641,0,0,578,13022,0,0;QS=3,0;MQSB=0.962621;MQ0F=0 PL:DP:DV 0,72,255:24:0 0,9,87:3:0 0,21,206:7:0 +17 2049 . A 0 . DP=33;I16=17,16,0,0,1207,44567,0,0,1949,116041,0,0,575,12963,0,0;QS=3,0;MQSB=0.959328;MQ0F=0 PL:DP:DV 0,72,255:24:0 0,6,74:2:0 0,21,208:7:0 +17 2050 . A 0 . DP=33;I16=16,16,0,0,1169,43313,0,0,1889,112441,0,0,545,12211,0,0;QS=3,0;MQSB=0.955563;MQ0F=0 PL:DP:DV 0,72,255:24:0 0,6,77:2:0 0,18,188:6:0 +17 2051 . T 0 . DP=31;I16=16,15,0,0,1134,42164,0,0,1829,108841,0,0,567,12737,0,0;QS=3,0;MQSB=0.957006;MQ0F=0 PL:DP:DV 0,69,255:23:0 0,6,69:2:0 0,18,170:6:0 +17 2052 . G 0 . DP=31;I16=16,15,0,0,1180,45546,0,0,1829,108841,0,0,564,12664,0,0;QS=3,0;MQSB=0.957006;MQ0F=0 PL:DP:DV 0,69,255:23:0 0,6,74:2:0 0,18,175:6:0 +17 2053 . G T, 0 . DP=31;I16=15,15,0,1,1126,42672,23,529,1769,105241,60,3600,537,11991,25,625;QS=2.97307,0.0269321,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.951229;BQB=1;MQ0F=0 PL:DP:DV 0,46,255,66,255,255:23:1 0,6,71,6,71,71:2:0 0,18,180,18,180,180:6:0 +17 2054 . A 0 . DP=30;I16=15,15,0,0,1123,43027,0,0,1769,105241,0,0,562,12592,0,0;QS=3,0;MQSB=0.952765;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,6,78:2:0 0,18,171:6:0 +17 2055 . G 0 . DP=30;I16=15,15,0,0,1156,45206,0,0,1769,105241,0,0,562,12592,0,0;QS=3,0;MQSB=0.952765;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,6,66:2:0 0,18,168:6:0 +17 2056 . A 0 . DP=30;I16=15,15,0,0,1124,42416,0,0,1769,105241,0,0,560,12518,0,0;QS=3,0;MQSB=0.952765;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,6,71:2:0 0,18,179:6:0 +17 2057 . T 0 . DP=30;I16=15,15,0,0,1094,40082,0,0,1769,105241,0,0,556,12374,0,0;QS=3,0;MQSB=0.952765;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,6,72:2:0 0,18,178:6:0 +17 2058 . A 0 . DP=29;I16=14,15,0,0,1035,37517,0,0,1709,101641,0,0,552,12212,0,0;QS=3,0;MQSB=0.947838;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,6,57:2:0 0,18,179:6:0 +17 2059 . A 0 . DP=29;I16=14,15,0,0,1063,39615,0,0,1709,101641,0,0,548,12082,0,0;QS=3,0;MQSB=0.947838;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,6,66:2:0 0,18,188:6:0 +17 2060 . C 0 . DP=28;I16=12,15,0,0,1015,39057,0,0,1589,94441,0,0,523,11499,0,0;QS=3,0;MQSB=0.935229;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,6,62:2:0 0,15,143:5:0 +17 2061 . A 0 . DP=27;I16=12,14,0,0,950,35084,0,0,1529,90841,0,0,501,11073,0,0;QS=3,0;MQSB=0.937241;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,3,41:1:0 0,15,163:5:0 +17 2062 . A 0 . DP=26;I16=11,15,0,0,973,37349,0,0,1529,90841,0,0,519,11425,0,0;QS=3,0;MQSB=0.927041;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,57:2:0 0,15,164:5:0 +17 2063 . C 0 . DP=26;I16=11,15,0,0,1017,40149,0,0,1529,90841,0,0,517,11405,0,0;QS=3,0;MQSB=0.927041;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,74:2:0 0,15,158:5:0 +17 2064 . A 0 . DP=26;I16=11,15,0,0,1002,38980,0,0,1529,90841,0,0,515,11413,0,0;QS=3,0;MQSB=0.927041;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,75:2:0 0,15,164:5:0 +17 2065 . G 0 . DP=26;I16=12,14,0,0,1030,41232,0,0,1529,90841,0,0,514,11448,0,0;QS=3,0;MQSB=0.937241;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,78:2:0 0,18,167:6:0 +17 2066 . G 0 . DP=26;I16=12,14,0,0,973,37055,0,0,1529,90841,0,0,514,11510,0,0;QS=3,0;MQSB=0.937241;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,75:2:0 0,18,152:6:0 +17 2067 . A 0 . DP=26;I16=12,14,0,0,1005,39095,0,0,1529,90841,0,0,512,11498,0,0;QS=3,0;MQSB=0.937241;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,69:2:0 0,18,187:6:0 +17 2068 . G 0 . DP=26;I16=12,14,0,0,993,39005,0,0,1529,90841,0,0,509,11459,0,0;QS=3,0;MQSB=0.937241;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,53:2:0 0,18,167:6:0 +17 2069 . C 0 . DP=26;I16=12,14,0,0,873,29879,0,0,1529,90841,0,0,506,11442,0,0;QS=3,0;MQSB=0.937241;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,59:2:0 0,18,156:6:0 +17 2070 . G 0 . DP=27;I16=13,14,0,0,932,33090,0,0,1589,94441,0,0,502,11398,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,62:2:0 0,18,145:6:0 +17 2071 . A 0 . DP=27;I16=13,14,0,0,946,33884,0,0,1589,94441,0,0,498,11330,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,53:2:0 0,18,177:6:0 +17 2072 . C 0 . DP=25;I16=13,12,0,0,897,32897,0,0,1469,87241,0,0,496,11288,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,59:2:0 0,15,128:5:0 +17 2073 . C 0 . DP=26;I16=14,12,0,0,874,30184,0,0,1529,90841,0,0,492,11168,0,0;QS=3,0;MQSB=0.953497;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,53:2:0 0,15,133:5:0 +17 2074 . G 0 . DP=26;I16=13,12,0,0,835,29219,0,0,1469,87241,0,0,463,10395,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,67:2:0 0,12,83:4:0 +17 2075 . C 0 . DP=27;I16=15,12,0,0,989,37027,0,0,1589,94441,0,0,484,10896,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,6,69:2:0 0,15,115:5:0 +17 2076 . A 0 . DP=27;I16=14,12,0,0,929,33551,0,0,1529,90841,0,0,470,10676,0,0;QS=3,0;MQSB=0.953497;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,6,76:2:0 0,12,114:4:0 +17 2077 . C 0 . DP=27;I16=15,12,0,0,990,37252,0,0,1589,94441,0,0,478,10724,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,6,65:2:0 0,15,125:5:0 +17 2078 . A 0 . DP=27;I16=15,12,0,0,1023,39089,0,0,1589,94441,0,0,475,10677,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,6,72:2:0 0,15,148:5:0 +17 2079 . G 0 . DP=28;I16=15,13,0,0,1042,39694,0,0,1649,98041,0,0,471,10605,0,0;QS=3,0;MQSB=0.956162;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,6,72:2:0 0,15,133:5:0 +17 2080 . G 0 . DP=28;I16=14,13,0,0,968,35328,0,0,1589,94441,0,0,453,10333,0,0;QS=3,0;MQSB=0.951472;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,6,67:2:0 0,12,108:4:0 +17 2081 . C 0 . DP=26;I16=14,12,0,0,937,35303,0,0,1529,90841,0,0,467,10535,0,0;QS=3,0;MQSB=0.953497;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,63:2:0 0,15,110:5:0 +17 2082 . T 0 . DP=24;I16=12,12,0,0,901,34287,0,0,1409,83641,0,0,468,10532,0,0;QS=3,0;MQSB=0.941765;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,71:2:0 0,12,112:4:0 +17 2083 . G 0 . DP=24;I16=12,12,0,0,887,33597,0,0,1409,83641,0,0,469,10547,0,0;QS=3,0;MQSB=0.941765;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,68:2:0 0,12,113:4:0 +17 2084 . C 0 . DP=25;I16=13,12,0,0,938,35868,0,0,1469,87241,0,0,470,10580,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,61:2:0 0,12,115:4:0 +17 2085 . T 0 . DP=25;I16=13,12,0,0,932,35282,0,0,1469,87241,0,0,472,10632,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,64:2:0 0,12,130:4:0 +17 2086 . G 0 . DP=25;I16=13,12,0,0,932,35400,0,0,1469,87241,0,0,474,10704,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,6,61:2:0 0,12,129:4:0 +17 2087 . A 0 . DP=24;I16=12,12,0,0,903,34391,0,0,1409,83641,0,0,476,10746,0,0;QS=3,0;MQSB=0.941765;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,66:2:0 0,12,126:4:0 +17 2088 . G 0 . DP=24;I16=12,12,0,0,880,33116,0,0,1409,83641,0,0,478,10808,0,0;QS=3,0;MQSB=0.941765;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,70:2:0 0,12,121:4:0 +17 2089 . C 0 . DP=25;I16=13,12,0,0,817,27419,0,0,1469,87241,0,0,480,10890,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,64:2:0 0,15,138:5:0 +17 2090 . G 0 . DP=25;I16=12,12,0,0,802,27940,0,0,1409,83641,0,0,457,10319,0,0;QS=3,0;MQSB=0.941765;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,63:2:0 0,12,99:4:0 +17 2091 . C 0 . DP=25;I16=12,12,0,0,800,27346,0,0,1440,86400,0,0,458,10346,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,61:2:0 0,15,125:5:0 +17 2092 . G 0 . DP=26;I16=13,12,0,0,838,29188,0,0,1469,87241,0,0,461,10487,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,64:2:0 0,18,133:6:0 +17 2093 . T G, 0 . DP=26;I16=13,12,1,0,905,33415,17,289,1500,90000,29,841,459,10371,25,625;QS=2.97424,0.0257576,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.953497;BQB=1;MQ0F=0 PL:DP:DV 0,36,255,51,255,255:18:1 0,6,67,6,67,67:2:0 0,18,153,18,153,153:6:0 +17 2094 . C 0 . DP=26;I16=14,12,0,0,949,35501,0,0,1529,90841,0,0,485,11047,0,0;QS=3,0;MQSB=0.953497;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,69:2:0 0,18,142:6:0 +17 2095 . A 0 . DP=25;I16=14,11,0,0,879,31219,0,0,1469,87241,0,0,487,11123,0,0;QS=3,0;MQSB=0.955682;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,72:2:0 0,18,154:6:0 +17 2096 . C 0 . DP=24;I16=13,11,0,0,878,32734,0,0,1409,83641,0,0,487,11073,0,0;QS=3,0;MQSB=0.950498;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,65:2:0 0,18,161:6:0 +17 2097 . A 0 . DP=24;I16=13,11,0,0,849,30671,0,0,1409,83641,0,0,487,11047,0,0;QS=3,0;MQSB=0.950498;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,56:2:0 0,18,172:6:0 +17 2098 . C 0 . DP=24;I16=13,11,0,0,781,26113,0,0,1409,83641,0,0,486,10996,0,0;QS=3,0;MQSB=0.950498;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,58:2:0 0,18,139:6:0 +17 2099 . G 0 . DP=23;I16=12,10,0,0,719,25109,0,0,1289,76441,0,0,460,10294,0,0;QS=3,0;MQSB=0.947103;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,3,24:1:0 0,18,129:6:0 +17 2100 . C 0 . DP=25;I16=13,11,0,0,873,32759,0,0,1409,83641,0,0,457,10141,0,0;QS=3,0;MQSB=0.950498;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,87:3:0 0,18,160:6:0 +17 2101 . A 0 . DP=25;I16=12,12,0,0,907,34671,0,0,1440,86400,0,0,455,9965,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,135:4:0 0,18,161:6:0 +17 2102 . G 0 . DP=25;I16=13,12,0,0,930,35596,0,0,1469,87241,0,0,478,10442,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,118:4:0 0,18,151:6:0 +17 2103 . C 0 . DP=25;I16=11,12,0,0,842,31630,0,0,1380,82800,0,0,432,9336,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,106:4:0 0,15,146:5:0 +17 2104 . C 0 . DP=24;I16=12,12,0,0,869,32463,0,0,1409,83641,0,0,454,9810,0,0;QS=3,0;MQSB=0.941765;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,126:4:0 0,15,147:5:0 +17 2105 . A 0 . DP=25;I16=11,12,0,0,836,30696,0,0,1380,82800,0,0,429,9201,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,138:4:0 0,15,130:5:0 +17 2106 . T 0 . DP=25;I16=12,13,0,0,897,33087,0,0,1469,87241,0,0,473,10211,0,0;QS=3,0;MQSB=0.939413;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,129:4:0 0,15,146:5:0 +17 2107 . C 0 . DP=25;I16=11,12,0,0,783,27185,0,0,1380,82800,0,0,425,9113,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,100:3:0 0,15,133:5:0 +17 2108 . G 0 . DP=25;I16=11,13,0,0,829,29703,0,0,1440,86400,0,0,448,9730,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,122:4:0 0,15,111:5:0 +17 2109 . C 0 . DP=25;I16=11,13,0,0,781,26717,0,0,1440,86400,0,0,446,9746,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,109:4:0 0,15,125:5:0 +17 2110 . G 0 . DP=25;I16=12,12,0,0,804,28134,0,0,1440,86400,0,0,418,9110,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,92:3:0 0,15,117:5:0 +17 2111 . C 0 . DP=25;I16=12,13,0,0,925,35081,0,0,1500,90000,0,0,441,9747,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,134:4:0 0,15,140:5:0 +17 2112 . A 0 . DP=24;I16=12,12,0,0,885,33445,0,0,1440,86400,0,0,440,9782,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,129:4:0 0,15,140:5:0 +17 2113 . G 0 . DP=24;I16=12,12,0,0,871,32641,0,0,1440,86400,0,0,439,9839,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,128:4:0 0,15,134:5:0 +17 2114 . C 0 . DP=24;I16=12,11,0,0,844,32052,0,0,1380,82800,0,0,413,9293,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,103:3:0 0,15,126:5:0 +17 2115 . T 0 . DP=23;I16=11,11,0,0,821,30869,0,0,1320,79200,0,0,412,9342,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,78:2:0 0,15,143:5:0 +17 2116 . C 0 . DP=23;I16=11,12,0,0,890,34892,0,0,1380,82800,0,0,435,9985,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,102:3:0 0,15,152:5:0 +17 2117 . A 0 . DP=23;I16=11,11,0,0,833,32121,0,0,1320,79200,0,0,432,9924,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,118:3:0 0,15,156:5:0 +17 2118 . G 0 . DP=23;I16=12,11,0,0,842,31502,0,0,1380,82800,0,0,429,9835,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,125:4:0 0,15,147:5:0 +17 2119 . G 0 . DP=23;I16=12,11,0,0,823,30553,0,0,1380,82800,0,0,426,9768,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,135:4:0 0,15,137:5:0 +17 2120 . G 0 . DP=24;I16=13,11,0,0,864,32028,0,0,1440,86400,0,0,423,9723,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,137:4:0 0,15,140:5:0 +17 2121 . A 0 . DP=22;I16=11,10,0,0,734,26712,0,0,1260,75600,0,0,398,9074,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,135:4:0 0,12,122:4:0 +17 2122 . T 0 . DP=22;I16=11,10,0,0,752,27278,0,0,1260,75600,0,0,396,8972,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,136:4:0 0,12,123:4:0 +17 2123 . A 0 . DP=22;I16=12,10,0,0,758,27024,0,0,1320,79200,0,0,419,9519,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,120:4:0 0,15,137:5:0 +17 2124 . T 0 . DP=22;I16=12,10,0,0,789,28741,0,0,1320,79200,0,0,417,9465,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,128:4:0 0,15,136:5:0 +17 2125 . T 0 . DP=20;I16=11,8,0,0,696,25704,0,0,1140,68400,0,0,401,9177,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,106:3:0 0,9,93:3:0 +17 2126 . A 0 . DP=20;I16=11,9,0,0,717,25979,0,0,1200,72000,0,0,415,9319,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,133:4:0 0,9,95:3:0 +17 2127 . C 0 . DP=21;I16=11,10,0,0,706,24426,0,0,1260,75600,0,0,413,9221,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,107:4:0 0,9,95:3:0 +17 2128 . G 0 . DP=21;I16=11,10,0,0,677,22633,0,0,1260,75600,0,0,411,9091,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,116:4:0 0,9,72:3:0 +17 2129 . T 0 . DP=21;I16=11,10,0,0,782,29386,0,0,1260,75600,0,0,409,8981,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,140:4:0 0,9,83:3:0 +17 2130 . G 0 . DP=21;I16=11,10,0,0,766,28562,0,0,1260,75600,0,0,407,8891,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,135:4:0 0,9,87:3:0 +17 2131 . T 0 . DP=21;I16=11,10,0,0,732,26216,0,0,1260,75600,0,0,405,8821,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,136:4:0 0,9,79:3:0 +17 2132 . A 0 . DP=21;I16=11,10,0,0,743,26733,0,0,1260,75600,0,0,403,8771,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,135:4:0 0,9,88:3:0 +17 2133 . A 0 . DP=21;I16=11,10,0,0,787,29651,0,0,1260,75600,0,0,401,8741,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,141:4:0 0,9,96:3:0 +17 2134 . C 0 . DP=21;I16=11,10,0,0,804,31100,0,0,1260,75600,0,0,399,8731,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,138:4:0 0,9,86:3:0 +17 2135 . T 0 . DP=22;I16=11,11,0,0,831,32197,0,0,1320,79200,0,0,397,8741,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,153:4:0 0,12,119:4:0 +17 2136 . C 0 . DP=22;I16=11,11,0,0,760,26892,0,0,1320,79200,0,0,395,8721,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,124:4:0 0,12,127:4:0 +17 2137 . G 0 . DP=22;I16=11,11,0,0,745,26047,0,0,1320,79200,0,0,393,8721,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,121:4:0 0,12,102:4:0 +17 2138 . A 0 . DP=22;I16=11,11,0,0,816,30934,0,0,1320,79200,0,0,391,8741,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,128:4:0 0,12,139:4:0 +17 2139 . C 0 . DP=22;I16=11,11,0,0,839,32237,0,0,1320,79200,0,0,389,8781,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,138:4:0 0,12,125:4:0 +17 2140 . A 0 . DP=22;I16=11,11,0,0,826,31300,0,0,1320,79200,0,0,387,8841,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,140:4:0 0,12,138:4:0 +17 2141 . T 0 . DP=21;I16=11,10,0,0,792,30156,0,0,1260,75600,0,0,385,8871,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,137:4:0 0,12,137:4:0 +17 2142 . G 0 . DP=19;I16=11,8,0,0,724,27784,0,0,1140,68400,0,0,385,8919,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,113:3:0 0,12,129:4:0 +17 2143 . T 0 . DP=19;I16=11,8,0,0,650,23454,0,0,1140,68400,0,0,384,8932,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,113:3:0 0,12,120:4:0 +17 2144 . C 0 . DP=19;I16=11,8,0,0,739,29003,0,0,1140,68400,0,0,383,8959,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,108:3:0 0,12,125:4:0 +17 2145 . A 0 . DP=20;I16=12,8,0,0,760,29304,0,0,1200,72000,0,0,381,8951,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,133:4:0 0,12,139:4:0 +17 2146 . G 0 . DP=20;I16=12,8,0,0,745,28105,0,0,1200,72000,0,0,379,8909,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,139:4:0 0,12,127:4:0 +17 2147 . C 0 . DP=20;I16=13,6,0,0,674,24296,0,0,1140,68400,0,0,379,8881,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,127:4:0 0,12,130:4:0 +17 2148 . G 0 . DP=20;I16=12,7,0,0,630,21274,0,0,1140,68400,0,0,365,8537,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,250:11:0 0,12,112:4:0 0,12,120:4:0 +17 2149 . A 0 . DP=20;I16=12,7,0,0,702,26212,0,0,1140,68400,0,0,367,8529,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,138:4:0 0,12,127:4:0 +17 2150 . T 0 . DP=20;I16=13,7,0,0,675,23943,0,0,1200,72000,0,0,383,8713,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,247:11:0 0,12,138:4:0 0,15,139:5:0 +17 2151 . T 0 . DP=20;I16=13,7,0,0,690,24274,0,0,1200,72000,0,0,383,8661,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,251:11:0 0,12,133:4:0 0,15,142:5:0 +17 2152 . G 0 . DP=20;I16=13,7,0,0,693,24713,0,0,1200,72000,0,0,383,8629,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,131:4:0 0,15,146:5:0 +17 2153 . T 0 . DP=19;I16=13,6,0,0,671,24571,0,0,1140,68400,0,0,383,8565,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,230:10:0 0,12,134:4:0 0,15,162:5:0 +17 2154 . C 0 . DP=19;I16=13,6,0,0,703,26955,0,0,1140,68400,0,0,382,8468,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,251:10:0 0,12,131:4:0 0,15,159:5:0 +17 2155 . A 0 . DP=19;I16=13,6,0,0,693,25727,0,0,1140,68400,0,0,381,8389,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,245:10:0 0,12,135:4:0 0,15,156:5:0 +17 2156 . C 0 . DP=19;I16=13,6,0,0,702,26214,0,0,1140,68400,0,0,380,8328,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,125:4:0 0,15,154:5:0 +17 2157 . A 0 . DP=19;I16=13,6,0,0,722,28058,0,0,1140,68400,0,0,379,8285,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,250:10:0 0,12,141:4:0 0,15,173:5:0 +17 2158 . G 0 . DP=19;I16=13,6,0,0,713,27567,0,0,1140,68400,0,0,378,8260,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,136:4:0 0,15,144:5:0 +17 2159 . G 0 . DP=19;I16=12,6,0,0,662,24744,0,0,1080,64800,0,0,366,8104,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,247:9:0 0,12,126:4:0 0,15,153:5:0 +17 2160 . C 0 . DP=19;I16=12,6,0,0,651,24005,0,0,1080,64800,0,0,364,8038,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,244:9:0 0,12,119:4:0 0,15,154:5:0 +17 2161 . A 0 . DP=19;I16=13,6,0,0,695,25883,0,0,1140,68400,0,0,369,8005,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,248:10:0 0,12,121:4:0 0,15,164:5:0 +17 2162 . C 0 . DP=20;I16=13,7,0,0,742,27834,0,0,1200,72000,0,0,365,7911,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,127:4:0 0,15,155:5:0 +17 2163 . T 0 . DP=20;I16=13,7,0,0,763,29517,0,0,1200,72000,0,0,362,7838,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,131:4:0 0,15,175:5:0 +17 2164 . G 0 . DP=20;I16=13,7,0,0,715,26301,0,0,1200,72000,0,0,359,7787,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,116:4:0 0,15,156:5:0 +17 2165 . C 0 . DP=20;I16=13,7,0,0,753,28781,0,0,1200,72000,0,0,355,7709,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,136:4:0 0,15,151:5:0 +17 2166 . T 0 . DP=19;I16=12,7,0,0,711,27211,0,0,1140,68400,0,0,352,7654,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,142:4:0 0,12,140:4:0 +17 2167 . A 0 . DP=19;I16=12,6,0,0,650,23760,0,0,1080,64800,0,0,327,7137,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,254:11:0 0,12,133:4:0 0,9,111:3:0 +17 2168 . C 0 . DP=19;I16=12,7,0,0,685,25039,0,0,1140,68400,0,0,345,7561,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,130:4:0 0,12,124:4:0 +17 2169 . T 0 . DP=19;I16=12,7,0,0,702,26940,0,0,1140,68400,0,0,341,7525,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,140:4:0 0,12,142:4:0 +17 2170 . C 0 . DP=18;I16=11,7,0,0,665,24861,0,0,1080,64800,0,0,338,7512,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,132:4:0 0,12,135:4:0 +17 2171 . C 0 . DP=20;I16=11,9,0,0,750,28368,0,0,1200,72000,0,0,333,7419,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,136:4:0 0,12,138:4:0 +17 2172 . T 0 . DP=20;I16=11,9,0,0,732,27540,0,0,1200,72000,0,0,330,7346,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,149:4:0 0,12,147:4:0 +17 2173 . G 0 . DP=19;I16=10,9,0,0,704,26534,0,0,1140,68400,0,0,327,7243,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,142:4:0 0,12,133:4:0 +17 2174 . G 0 . DP=19;I16=10,9,0,0,674,24372,0,0,1140,68400,0,0,324,7158,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,126:4:0 0,12,129:4:0 +17 2175 . G 0 . DP=18;I16=9,9,0,0,639,23059,0,0,1080,64800,0,0,322,7090,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,123:4:0 0,12,126:4:0 +17 2176 . G 0 . DP=18;I16=9,9,0,0,621,21815,0,0,1080,64800,0,0,318,6940,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,247:10:0 0,12,121:4:0 0,12,123:4:0 +17 2177 . T 0 . DP=18;I16=9,9,0,0,547,18051,0,0,1080,64800,0,0,314,6810,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,239:10:0 0,12,83:4:0 0,12,108:4:0 +17 2178 . T 0 . DP=18;I16=9,9,0,0,579,19659,0,0,1080,64800,0,0,310,6700,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,234:10:0 0,12,110:4:0 0,12,118:4:0 +17 2179 . T 0 . DP=18;I16=9,9,0,0,591,20403,0,0,1080,64800,0,0,307,6609,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,239:10:0 0,12,97:4:0 0,12,135:4:0 +17 2180 . T 0 . DP=18;I16=9,9,0,0,616,21524,0,0,1080,64800,0,0,305,6537,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,236:10:0 0,12,122:4:0 0,12,133:4:0 +17 2181 . C 0 . DP=18;I16=9,8,0,0,611,22485,0,0,1020,61200,0,0,293,6385,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,224:9:0 0,12,129:4:0 0,12,150:4:0 +17 2182 . C 0 . DP=18;I16=9,9,0,0,665,24877,0,0,1080,64800,0,0,301,6453,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,125:4:0 0,12,145:4:0 +17 2183 . A 0 . DP=18;I16=9,9,0,0,646,23624,0,0,1080,64800,0,0,299,6441,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,247:10:0 0,12,123:4:0 0,12,144:4:0 +17 2184 . T 0 . DP=17;I16=8,9,0,0,610,22250,0,0,1020,61200,0,0,298,6448,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,224:9:0 0,12,134:4:0 0,12,136:4:0 +17 2185 . C 0 . DP=16;I16=8,8,0,0,569,20761,0,0,960,57600,0,0,297,6423,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,211:8:0 0,12,128:4:0 0,12,137:4:0 +17 2186 . A 0 . DP=16;I16=8,8,0,0,576,21314,0,0,960,57600,0,0,296,6416,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,204:8:0 0,12,134:4:0 0,12,145:4:0 +17 2187 . A 0 . DP=16;I16=8,8,0,0,562,20396,0,0,960,57600,0,0,295,6427,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,201:8:0 0,12,136:4:0 0,12,135:4:0 +17 2188 . A 0 . DP=17;I16=9,8,0,0,569,19925,0,0,1020,61200,0,0,293,6405,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,214:9:0 0,12,133:4:0 0,12,123:4:0 +17 2189 . C 0 . DP=19;I16=9,10,0,0,645,22647,0,0,1097,65089,0,0,292,6400,0,0;QS=3,0;MQSB=0.934728;MQ0F=0 PL:DP:DV 0,30,230:10:0 0,12,133:4:0 0,15,142:5:0 +17 2190 . C 0 . DP=19;I16=9,10,0,0,604,20072,0,0,1097,65089,0,0,294,6414,0,0;QS=3,0;MQSB=0.934728;MQ0F=0 PL:DP:DV 0,33,238:11:0 0,12,119:4:0 0,12,107:4:0 +17 2191 . C 0 . DP=19;I16=9,10,0,0,647,23007,0,0,1097,65089,0,0,297,6449,0,0;QS=3,0;MQSB=0.934728;MQ0F=0 PL:DP:DV 0,33,251:11:0 0,12,129:4:0 0,12,119:4:0 +17 2192 . T 0 . DP=19;I16=9,10,0,0,659,23723,0,0,1097,65089,0,0,300,6506,0,0;QS=3,0;MQSB=0.934728;MQ0F=0 PL:DP:DV 0,33,253:11:0 0,12,136:4:0 0,12,120:4:0 +17 2193 . C 0 . DP=18;I16=8,10,0,0,642,23934,0,0,1037,61489,0,0,303,6535,0,0;QS=3,0;MQSB=0.938795;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,128:4:0 0,9,87:3:0 +17 2194 . A 0 . DP=18;I16=8,9,0,0,617,22683,0,0,1020,61200,0,0,301,6561,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,247:10:0 0,12,134:4:0 0,9,98:3:0 +17 2195 . A 0 . DP=18;I16=8,10,0,0,635,23271,0,0,1037,61489,0,0,309,6659,0,0;QS=3,0;MQSB=0.938795;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,128:4:0 0,9,101:3:0 +17 2196 . G 0 . DP=19;I16=8,11,0,0,703,26383,0,0,1097,65089,0,0,312,6754,0,0;QS=3,0;MQSB=0.946915;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,117:4:0 0,12,120:4:0 +17 2197 . A 0 . DP=19;I16=8,11,0,0,735,28599,0,0,1097,65089,0,0,314,6770,0,0;QS=3,0;MQSB=0.946915;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,141:4:0 0,12,125:4:0 +17 2198 . G 0 . DP=19;I16=8,10,0,0,650,24206,0,0,1080,64800,0,0,307,6725,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,129:4:0 0,12,107:4:0 +17 2199 . C 0 . DP=19;I16=8,11,0,0,701,26735,0,0,1097,65089,0,0,318,6862,0,0;QS=3,0;MQSB=0.946915;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,128:4:0 0,12,116:4:0 +17 2200 . T 0 . DP=19;I16=8,11,0,0,710,26768,0,0,1097,65089,0,0,320,6938,0,0;QS=3,0;MQSB=0.946915;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,129:4:0 0,12,114:4:0 +17 2201 . G 0 . DP=17;I16=7,10,0,0,628,23764,0,0,977,57889,0,0,324,7032,0,0;QS=3,0;MQSB=0.943335;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,66:2:0 0,12,119:4:0 +17 2202 . G 0 . DP=17;I16=7,10,0,0,557,19249,0,0,977,57889,0,0,327,7093,0,0;QS=3,0;MQSB=0.943335;MQ0F=0 PL:DP:DV 0,33,245:11:0 0,6,57:2:0 0,12,115:4:0 +17 2203 . G 0 . DP=17;I16=7,10,0,0,588,21184,0,0,977,57889,0,0,329,7123,0,0;QS=3,0;MQSB=0.943335;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,47:2:0 0,12,116:4:0 +17 2204 . C 0 . DP=17;I16=7,10,0,0,538,18568,0,0,977,57889,0,0,331,7173,0,0;QS=3,0;MQSB=0.943335;MQ0F=0 PL:DP:DV 0,33,246:11:0 0,6,61:2:0 0,12,99:4:0 +17 2205 . C 0 . DP=18;I16=7,11,0,0,628,22918,0,0,1037,61489,0,0,332,7192,0,0;QS=3,0;MQSB=0.951002;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,68:2:0 0,12,109:4:0 +17 2206 . T 0 . DP=19;I16=7,12,0,0,677,25237,0,0,1097,65089,0,0,334,7230,0,0;QS=3,0;MQSB=0.957193;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,77:2:0 0,12,115:4:0 +17 2207 . G 0 . DP=19;I16=7,11,0,0,663,24717,0,0,1080,64800,0,0,319,6965,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,67:2:0 0,12,110:4:0 +17 2208 . G 0 . DP=21;I16=7,14,0,0,726,26038,0,0,1217,72289,0,0,340,7370,0,0;QS=3,0;MQSB=0.966484;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,110:4:0 0,12,122:4:0 +17 2209 . G 0 . DP=22;I16=8,13,0,0,715,25133,0,0,1237,73369,0,0,325,7075,0,0;QS=3,0;MQSB=0.895122;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,128:5:0 0,12,117:4:0 +17 2210 . G C, 0 . DP=21;I16=7,13,0,1,648,22186,25,625,1177,69769,17,289,331,7165,21,441;QS=2.95442,0.0455764,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.975265;BQB=1;MQ0F=0 PL:DP:DV 0,19,234,33,237,241:12:1 0,15,127,15,127,127:5:0 0,12,113,12,113,113:4:0 +17 2211 . T 0 . DP=21;I16=7,13,0,0,724,27000,0,0,1177,69769,0,0,336,7230,0,0;QS=3,0;MQSB=0.875769;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,141:5:0 0,12,124:4:0 +17 2212 . C 0 . DP=22;I16=8,14,0,0,791,29201,0,0,1254,73658,0,0,364,7850,0,0;QS=3,0;MQSB=0.985548;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,148:5:0 0,12,111:4:0 +17 2213 . A 0 . DP=22;I16=8,14,0,0,767,27327,0,0,1254,73658,0,0,371,8015,0,0;QS=3,0;MQSB=0.985548;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,153:5:0 0,12,112:4:0 +17 2214 . A 0 . DP=22;I16=8,14,0,0,756,26836,0,0,1254,73658,0,0,377,8159,0,0;QS=3,0;MQSB=0.985548;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,153:5:0 0,12,117:4:0 +17 2215 . C 0 . DP=22;I16=8,14,0,0,815,31121,0,0,1254,73658,0,0,381,8229,0,0;QS=3,0;MQSB=0.985548;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,162:5:0 0,12,124:4:0 +17 2216 . T 0 . DP=22;I16=8,14,0,0,815,31233,0,0,1254,73658,0,0,384,8272,0,0;QS=3,0;MQSB=0.985548;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,166:5:0 0,12,124:4:0 +17 2217 . T 0 . DP=22;I16=8,13,0,0,741,26855,0,0,1237,73369,0,0,362,7712,0,0;QS=3,0;MQSB=0.895122;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,155:5:0 0,12,118:4:0 +17 2218 . C 0 . DP=21;I16=7,14,0,0,753,27973,0,0,1194,70058,0,0,391,8423,0,0;QS=3,0;MQSB=0.975265;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,138:4:0 0,12,119:4:0 +17 2219 . C 0 . DP=21;I16=7,13,0,0,757,29125,0,0,1177,69769,0,0,370,7904,0,0;QS=3,0;MQSB=0.875769;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,141:4:0 0,12,122:4:0 +17 2220 . G A, 0 . DP=21;I16=6,2,1,11,256,8364,474,19128,457,26569,720,43200,141,2959,233,5071;QS=0.886504,2.1135,0;VDB=0.532753;SGB=-3.51597;RPB=0.964198;MQB=0.898397;MQSB=0.875769;BQB=0.0354359;MQ0F=0 PL:DP:DV 139,0,130,157,148,255:12:6 69,0,46,75,52,119:4:2 131,12,0,131,12,131:4:4 +17 2221 . G 0 . DP=21;I16=7,13,0,0,738,27922,0,0,1177,69769,0,0,376,8078,0,0;QS=3,0;MQSB=0.875769;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,132:4:0 0,12,120:4:0 +17 2222 . C 0 . DP=21;I16=7,14,0,0,746,28098,0,0,1194,70058,0,0,401,8675,0,0;QS=3,0;MQSB=0.975265;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,135:4:0 0,12,107:4:0 +17 2223 . C 0 . DP=21;I16=7,14,0,0,796,30632,0,0,1194,70058,0,0,401,8671,0,0;QS=3,0;MQSB=0.975265;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,135:4:0 0,12,122:4:0 +17 2224 . T 0 . DP=21;I16=7,14,0,0,811,31599,0,0,1194,70058,0,0,401,8691,0,0;QS=3,0;MQSB=0.975265;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,144:4:0 0,12,123:4:0 +17 2225 . G 0 . DP=21;I16=7,14,0,0,778,29396,0,0,1194,70058,0,0,401,8735,0,0;QS=3,0;MQSB=0.975265;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,133:4:0 0,12,121:4:0 +17 2226 . G 0 . DP=21;I16=7,14,0,0,727,26485,0,0,1194,70058,0,0,401,8803,0,0;QS=3,0;MQSB=0.975265;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,128:4:0 0,12,113:4:0 +17 2227 . G 0 . DP=20;I16=7,12,0,0,663,23985,0,0,1117,66169,0,0,377,8269,0,0;QS=3,0;MQSB=0.879351;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,123:4:0 0,12,114:4:0 +17 2228 . G C, 0 . DP=19;I16=5,12,0,1,643,24791,16,256,1020,61200,17,289,360,8020,25,625;QS=2.9603,0.0397022,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.970092;BQB=1;MQ0F=0 PL:DP:DV 0,17,255,30,255,255:11:1 0,9,95,9,95,95:3:0 0,12,121,12,121,121:4:0 +17 2229 . A 0 . DP=20;I16=6,14,0,0,757,28857,0,0,1134,66458,0,0,406,9138,0,0;QS=3,0;MQSB=0.959189;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,138:4:0 0,12,122:4:0 +17 2230 . A 0 . DP=20;I16=6,14,0,0,729,26985,0,0,1134,66458,0,0,409,9291,0,0;QS=3,0;MQSB=0.959189;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,141:4:0 0,12,119:4:0 +17 2231 . A 0 . DP=20;I16=6,13,0,0,712,26990,0,0,1117,66169,0,0,386,8790,0,0;QS=3,0;MQSB=0.850016;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,144:4:0 0,12,124:4:0 +17 2232 . C 0 . DP=20;I16=6,14,0,0,751,28657,0,0,1134,66458,0,0,412,9508,0,0;QS=3,0;MQSB=0.959189;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,130:4:0 0,12,107:4:0 +17 2233 . T 0 . DP=20;I16=6,14,0,0,774,30432,0,0,1134,66458,0,0,413,9619,0,0;QS=3,0;MQSB=0.959189;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,150:4:0 0,12,117:4:0 +17 2234 . G 0 . DP=20;I16=6,14,0,0,719,26621,0,0,1134,66458,0,0,412,9646,0,0;QS=3,0;MQSB=0.959189;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,145:4:0 0,12,107:4:0 +17 2235 . G 0 . DP=20;I16=6,14,0,0,728,27036,0,0,1134,66458,0,0,410,9636,0,0;QS=3,0;MQSB=0.959189;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,139:4:0 0,12,104:4:0 +17 2236 . G 0 . DP=19;I16=6,13,0,0,705,26985,0,0,1074,62858,0,0,409,9637,0,0;QS=3,0;MQSB=0.965977;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,142:4:0 0,9,84:3:0 +17 2237 . G 0 . DP=19;I16=6,12,0,0,684,26576,0,0,1057,62569,0,0,383,9023,0,0;QS=3,0;MQSB=0.85394;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,141:4:0 0,9,86:3:0 +17 2238 . C 0 . DP=19;I16=5,13,0,0,648,24496,0,0,1037,61489,0,0,381,8993,0,0;QS=3,0;MQSB=0.970092;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,108:3:0 0,9,78:3:0 +17 2239 . A 0 . DP=19;I16=6,11,0,0,634,24178,0,0,997,58969,0,0,373,8935,0,0;QS=3,0;MQSB=0.85832;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,133:4:0 0,6,77:2:0 +17 2240 . A 0 . DP=19;I16=6,13,0,0,731,28595,0,0,1074,62858,0,0,402,9582,0,0;QS=3,0;MQSB=0.965977;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,135:4:0 0,9,101:3:0 +17 2241 . G 0 . DP=19;I16=6,12,0,0,683,26433,0,0,1057,62569,0,0,375,8951,0,0;QS=3,0;MQSB=0.85394;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,126:4:0 0,9,88:3:0 +17 2242 . T 0 . DP=20;I16=5,13,0,0,635,22949,0,0,1057,62569,0,0,370,8944,0,0;QS=3,0;MQSB=0.814433;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,91:3:0 0,9,95:3:0 +17 2243 . A 0 . DP=19;I16=5,14,0,0,704,26274,0,0,1074,62858,0,0,395,9585,0,0;QS=3,0;MQSB=0.933727;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,107:3:0 0,9,99:3:0 +17 2244 . T 0 . DP=19;I16=5,14,0,0,681,25263,0,0,1074,62858,0,0,395,9609,0,0;QS=3,0;MQSB=0.933727;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,89:3:0 0,9,98:3:0 +17 2245 . C 0 . DP=19;I16=5,14,0,0,722,27846,0,0,1074,62858,0,0,394,9592,0,0;QS=3,0;MQSB=0.933727;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,98:3:0 0,9,88:3:0 +17 2246 . A 0 . DP=18;I16=5,12,0,0,597,21693,0,0,997,58969,0,0,367,8861,0,0;QS=3,0;MQSB=0.818731;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,95:3:0 0,6,72:2:0 +17 2247 . C 0 . DP=17;I16=4,13,0,0,639,24373,0,0,954,55658,0,0,391,9391,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,105:3:0 0,6,71:2:0 +17 2248 . C 0 . DP=17;I16=4,13,0,0,669,26863,0,0,954,55658,0,0,390,9306,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,90:3:0 0,6,75:2:0 +17 2249 . A 0 . DP=17;I16=4,13,0,0,677,27371,0,0,954,55658,0,0,389,9231,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,116:3:0 0,6,80:2:0 +17 2250 . G 0 . DP=17;I16=4,13,0,0,654,25800,0,0,954,55658,0,0,388,9166,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,100:3:0 0,6,78:2:0 +17 2251 . A 0 . DP=17;I16=4,13,0,0,673,27327,0,0,954,55658,0,0,387,9111,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,112:3:0 0,6,80:2:0 +17 2252 . G 0 . DP=17;I16=4,12,0,0,647,26249,0,0,937,55369,0,0,361,8441,0,0;QS=3,0;MQSB=0.767432;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,113:3:0 0,6,73:2:0 +17 2253 . A 0 . DP=17;I16=4,13,0,0,641,24643,0,0,954,55658,0,0,385,9031,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,111:3:0 0,6,73:2:0 +17 2254 . T 0 . DP=17;I16=4,12,0,0,615,23821,0,0,937,55369,0,0,358,8332,0,0;QS=3,0;MQSB=0.767432;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,112:3:0 0,6,73:2:0 +17 2255 . G 0 . DP=17;I16=4,13,0,0,677,27243,0,0,954,55658,0,0,380,8844,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,115:3:0 0,6,71:2:0 +17 2256 . A 0 . DP=17;I16=4,13,0,0,656,26088,0,0,954,55658,0,0,377,8741,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,110:3:0 0,6,78:2:0 +17 2257 . G 0 . DP=17;I16=4,12,0,0,627,24863,0,0,937,55369,0,0,349,8023,0,0;QS=3,0;MQSB=0.767432;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,115:3:0 0,6,74:2:0 +17 2258 . C 0 . DP=17;I16=4,13,0,0,667,26403,0,0,954,55658,0,0,371,8565,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,109:3:0 0,6,70:2:0 +17 2259 . T 0 . DP=17;I16=4,13,0,0,646,25334,0,0,954,55658,0,0,368,8492,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,116:3:0 0,6,79:2:0 +17 2260 . T 0 . DP=17;I16=4,13,0,0,638,24178,0,0,954,55658,0,0,365,8429,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,115:3:0 0,6,72:2:0 +17 2261 . T 0 . DP=17;I16=4,13,0,0,633,23799,0,0,954,55658,0,0,362,8376,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,105:3:0 0,6,73:2:0 +17 2262 . A 0 . DP=17;I16=4,13,0,0,628,23438,0,0,954,55658,0,0,359,8333,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,36,253:12:0 0,9,112:3:0 0,6,74:2:0 +17 2263 . T 0 . DP=17;I16=4,13,0,0,631,23673,0,0,954,55658,0,0,355,8251,0,0;QS=3,0;MQSB=0.90252;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,112:3:0 0,6,74:2:0 +17 2264 . A 0 . DP=17;I16=4,12,0,0,623,24371,0,0,937,55369,0,0,326,7556,0,0;QS=3,0;MQSB=0.767432;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,114:3:0 0,6,75:2:0 +17 2265 . A 0 . DP=18;I16=4,13,0,0,642,24718,0,0,997,58969,0,0,320,7400,0,0;QS=3,0;MQSB=0.762744;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,113:3:0 0,6,75:2:0 +17 2266 . A 0 . DP=19;I16=5,14,0,0,656,23962,0,0,1074,62858,0,0,337,7745,0,0;QS=3,0;MQSB=0.933727;MQ0F=0 PL:DP:DV 0,39,252:13:0 0,12,128:4:0 0,6,75:2:0 +17 2267 . A 0 . DP=20;I16=6,14,0,0,712,26052,0,0,1134,66458,0,0,332,7582,0,0;QS=3,0;MQSB=0.959189;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,134:4:0 0,9,102:3:0 +17 2268 . A 0 . DP=20;I16=6,14,0,0,741,27841,0,0,1134,66458,0,0,327,7391,0,0;QS=3,0;MQSB=0.959189;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,135:4:0 0,9,100:3:0 +17 2269 . T 0 . DP=20;I16=6,13,0,0,681,24751,0,0,1074,62858,0,0,318,7206,0,0;QS=3,0;MQSB=0.965977;MQ0F=0 PL:DP:DV 0,36,246:12:0 0,12,137:4:0 0,9,111:3:0 +17 2270 . A 0 . DP=19;I16=6,12,0,0,652,24154,0,0,1057,62569,0,0,300,6750,0,0;QS=3,0;MQSB=0.85394;MQ0F=0 PL:DP:DV 0,33,244:11:0 0,12,134:4:0 0,9,112:3:0 +17 2271 . A 0 . DP=17;I16=6,11,0,0,654,25406,0,0,954,55658,0,0,316,6944,0,0;QS=3,0;MQSB=0.980001;MQ0F=0 PL:DP:DV 0,30,243:10:0 0,12,142:4:0 0,9,111:3:0 +17 2272 . T 0 . DP=17;I16=6,10,0,0,604,22908,0,0,937,55369,0,0,297,6525,0,0;QS=3,0;MQSB=0.863243;MQ0F=0 PL:DP:DV 0,27,238:9:0 0,12,137:4:0 0,9,111:3:0 +17 2273 . G 0 . DP=17;I16=6,10,0,0,581,22129,0,0,937,55369,0,0,295,6411,0,0;QS=3,0;MQSB=0.863243;MQ0F=0 PL:DP:DV 0,27,240:9:0 0,12,123:4:0 0,9,115:3:0 +17 2274 . G 0 . DP=18;I16=6,11,0,0,621,23109,0,0,997,58969,0,0,293,6313,0,0;QS=3,0;MQSB=0.85832;MQ0F=0 PL:DP:DV 0,30,248:10:0 0,12,132:4:0 0,9,110:3:0 +17 2275 . T 0 . DP=18;I16=6,11,0,0,624,23152,0,0,997,58969,0,0,292,6232,0,0;QS=3,0;MQSB=0.85832;MQ0F=0 PL:DP:DV 0,30,249:10:0 0,12,126:4:0 0,9,113:3:0 +17 2276 . G 0 . DP=20;I16=7,12,0,0,710,26848,0,0,1074,62858,0,0,303,6313,0,0;QS=3,0;MQSB=0.985816;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,129:4:0 0,9,110:3:0 +17 2277 . C 0 . DP=21;I16=8,13,0,0,797,30699,0,0,1194,70058,0,0,303,6247,0,0;QS=3,0;MQSB=0.989565;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,151:5:0 0,12,143:4:0 +17 2278 . T 0 . DP=21;I16=7,13,0,0,736,27790,0,0,1157,68689,0,0,279,5581,0,0;QS=3,0;MQSB=0.962269;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,133:4:0 0,12,148:4:0 +17 2279 . A 0 . DP=20;I16=8,12,0,0,723,27047,0,0,1134,66458,0,0,306,6190,0,0;QS=3,0;MQSB=0.993326;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,155:5:0 0,12,144:4:0 +17 2280 . G 0 . DP=21;I16=8,12,0,0,766,29776,0,0,1177,69769,0,0,299,6085,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,166:5:0 0,12,144:4:0 +17 2281 . C 0 . DP=22;I16=8,13,0,0,784,29748,0,0,1237,73369,0,0,301,6037,0,0;QS=3,0;MQSB=0.895122;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,165:5:0 0,12,140:4:0 +17 2282 . T 0 . DP=22;I16=8,14,0,0,789,29699,0,0,1254,73658,0,0,310,6054,0,0;QS=3,0;MQSB=0.985548;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,162:5:0 0,12,150:4:0 +17 2283 . G 0 . DP=22;I16=8,14,0,0,798,29774,0,0,1254,73658,0,0,312,6054,0,0;QS=3,0;MQSB=0.985548;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,158:5:0 0,12,142:4:0 +17 2284 . G 0 . DP=22;I16=7,14,0,0,760,28408,0,0,1194,70058,0,0,294,5664,0,0;QS=3,0;MQSB=0.975265;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,130:4:0 0,12,141:4:0 +17 2285 . G 0 . DP=23;I16=9,14,0,0,844,31592,0,0,1314,77258,0,0,311,5909,0,0;QS=3,0;MQSB=0.992095;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,152:5:0 0,12,144:4:0 +17 2286 . C 0 . DP=23;I16=9,14,0,0,854,32244,0,0,1314,77258,0,0,311,5869,0,0;QS=3,0;MQSB=0.992095;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,155:5:0 0,12,130:4:0 +17 2287 . A 0 . DP=23;I16=9,14,0,0,818,30288,0,0,1314,77258,0,0,311,5869,0,0;QS=3,0;MQSB=0.992095;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,166:5:0 0,12,143:4:0 +17 2288 . T 0 . DP=22;I16=8,14,0,0,794,29190,0,0,1254,73658,0,0,312,5908,0,0;QS=3,0;MQSB=0.985548;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,158:5:0 0,12,142:4:0 +17 2289 . G 0 . DP=21;I16=8,13,0,0,723,25835,0,0,1237,73369,0,0,314,5984,0,0;QS=3,0;MQSB=0.895122;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,154:5:0 0,12,126:4:0 +17 2290 . G 0 . DP=20;I16=7,13,0,0,748,28318,0,0,1177,69769,0,0,318,6094,0,0;QS=3,0;MQSB=0.875769;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,149:5:0 0,9,114:3:0 +17 2291 . T 0 . DP=20;I16=7,13,0,0,731,27165,0,0,1177,69769,0,0,322,6186,0,0;QS=3,0;MQSB=0.875769;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,151:5:0 0,9,112:3:0 +17 2292 . G 0 . DP=20;I16=7,13,0,0,749,28747,0,0,1177,69769,0,0,325,6259,0,0;QS=3,0;MQSB=0.875769;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,156:5:0 0,9,109:3:0 +17 2293 . G 0 . DP=20;I16=7,13,0,0,739,27903,0,0,1177,69769,0,0,327,6311,0,0;QS=3,0;MQSB=0.875769;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,156:5:0 0,9,112:3:0 +17 2294 . C 0 . DP=21;I16=7,14,0,0,775,29453,0,0,1237,73369,0,0,329,6391,0,0;QS=3,0;MQSB=0.872525;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,169:5:0 0,9,114:3:0 +17 2295 . T 0 . DP=21;I16=7,14,0,0,773,29209,0,0,1237,73369,0,0,331,6451,0,0;QS=3,0;MQSB=0.872525;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,164:5:0 0,9,115:3:0 +17 2296 . T 0 . DP=21;I16=7,14,0,0,756,27780,0,0,1237,73369,0,0,333,6543,0,0;QS=3,0;MQSB=0.872525;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,160:5:0 0,9,106:3:0 +17 2297 . G 0 . DP=20;I16=7,13,0,0,736,27692,0,0,1177,69769,0,0,336,6666,0,0;QS=3,0;MQSB=0.875769;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,165:5:0 0,6,74:2:0 +17 2298 . C 0 . DP=21;I16=7,14,0,0,778,29300,0,0,1237,73369,0,0,339,6819,0,0;QS=3,0;MQSB=0.872525;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,139:5:0 0,9,106:3:0 +17 2299 . A 0 . DP=21;I16=7,14,0,0,714,25282,0,0,1237,73369,0,0,343,7003,0,0;QS=3,0;MQSB=0.872525;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,128:5:0 0,9,110:3:0 +17 2300 . C 0 . DP=21;I16=7,13,0,0,687,24749,0,0,1177,69769,0,0,326,6768,0,0;QS=3,0;MQSB=0.875769;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,148:5:0 0,9,109:3:0 +17 2301 . C 0 . DP=23;I16=7,15,0,0,802,30292,0,0,1266,74210,0,0,349,7363,0,0;QS=3,0;MQSB=0.970024;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,147:5:0 0,9,116:3:0 +17 2302 . T 0 . DP=23;I16=7,16,0,0,860,32956,0,0,1326,77810,0,0,354,7496,0,0;QS=3,0;MQSB=0.964916;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,166:5:0 0,12,150:4:0 +17 2303 . G 0 . DP=23;I16=7,16,0,0,817,29823,0,0,1326,77810,0,0,356,7604,0,0;QS=3,0;MQSB=0.964916;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,151:5:0 0,12,139:4:0 +17 2304 . T 0 . DP=23;I16=7,16,0,0,802,28628,0,0,1326,77810,0,0,357,7691,0,0;QS=3,0;MQSB=0.964916;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,148:5:0 0,12,140:4:0 +17 2305 . A 0 . DP=22;I16=7,14,0,0,725,25585,0,0,1237,73369,0,0,355,7791,0,0;QS=3,0;MQSB=0.872525;MQ0F=0 PL:DP:DV 0,36,248:12:0 0,15,155:5:0 0,12,129:4:0 +17 2306 . A 0 . DP=21;I16=7,14,0,0,727,26841,0,0,1206,70610,0,0,361,7899,0,0;QS=3,0;MQSB=0.975265;MQ0F=0 PL:DP:DV 0,36,246:12:0 0,15,168:5:0 0,12,130:4:0 +17 2307 . T 0 . DP=21;I16=7,14,0,0,751,27427,0,0,1206,70610,0,0,362,7964,0,0;QS=3,0;MQSB=0.975265;MQ0F=0 PL:DP:DV 0,36,251:12:0 0,15,165:5:0 0,12,141:4:0 +17 2308 . C 0 . DP=21;I16=7,14,0,0,735,26675,0,0,1206,70610,0,0,363,8051,0,0;QS=3,0;MQSB=0.975265;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,144:5:0 0,12,146:4:0 +17 2309 . C A, 0 . DP=19;I16=7,11,0,1,604,21364,16,256,1057,62569,29,841,358,8094,8,64;QS=2.95676,0.0432432,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.985816;BQB=1;MQ0F=0 PL:DP:DV 0,20,224,33,227,230:12:1 0,9,94,9,94,94:3:0 0,12,138,12,138,138:4:0 +17 2310 . C 0 . DP=18;I16=6,12,0,0,668,25392,0,0,1049,62041,0,0,370,8282,0,0;QS=3,0;MQSB=0.961295;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,80:2:0 0,12,139:4:0 +17 2311 . A 0 . DP=19;I16=7,12,0,0,707,26855,0,0,1109,65641,0,0,373,8371,0,0;QS=3,0;MQSB=0.957193;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,78:2:0 0,12,137:4:0 +17 2312 . G 0 . DP=20;I16=7,12,0,0,736,29118,0,0,1109,65641,0,0,364,8306,0,0;QS=3,0;MQSB=0.957193;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,82:2:0 0,9,122:3:0 +17 2313 . C 0 . DP=20;I16=7,13,0,0,723,27231,0,0,1169,69241,0,0,382,8596,0,0;QS=3,0;MQSB=0.962269;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,76:2:0 0,12,130:4:0 +17 2314 . A 0 . DP=21;I16=7,12,0,0,630,22184,0,0,1109,65641,0,0,372,8510,0,0;QS=3,0;MQSB=0.957193;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,78:2:0 0,9,115:3:0 +17 2315 . C 0 . DP=23;I16=7,14,0,0,739,26861,0,0,1229,72841,0,0,392,8892,0,0;QS=3,0;MQSB=0.966484;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,71:2:0 0,12,135:4:0 +17 2316 . T 0 . DP=23;I16=8,15,0,0,826,30690,0,0,1349,80041,0,0,408,9102,0,0;QS=3,0;MQSB=0.967216;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,105:3:0 0,15,170:5:0 +17 2317 . T 0 . DP=24;I16=7,16,0,0,766,27014,0,0,1349,80041,0,0,411,9211,0,0;QS=3,0;MQSB=0.973027;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,78:2:0 0,15,170:5:0 +17 2318 . T 0 . DP=24;I16=8,14,0,0,757,27433,0,0,1320,79200,0,0,379,8449,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,91:3:0 0,15,165:5:0 +17 2319 . G 0 . DP=24;I16=6,16,0,0,827,31577,0,0,1289,76441,0,0,398,8882,0,0;QS=3,0;MQSB=0.97584;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,3,43:1:0 0,15,167:5:0 +17 2320 . G 0 . DP=23;I16=7,16,0,0,803,29077,0,0,1349,80041,0,0,435,9675,0,0;QS=3,0;MQSB=0.973027;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,87:3:0 0,15,157:5:0 +17 2321 . G 0 . DP=23;I16=7,16,0,0,804,29368,0,0,1349,80041,0,0,442,9840,0,0;QS=3,0;MQSB=0.973027;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,79:3:0 0,15,169:5:0 +17 2322 . A 0 . DP=24;I16=7,17,0,0,860,32116,0,0,1409,83641,0,0,449,10027,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,95:3:0 0,15,178:5:0 +17 2323 . G 0 . DP=24;I16=7,17,0,0,863,31887,0,0,1409,83641,0,0,457,10237,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,88:3:0 0,15,153:5:0 +17 2324 . G 0 . DP=24;I16=7,16,0,0,786,27932,0,0,1349,80041,0,0,462,10416,0,0;QS=3,0;MQSB=0.973027;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,88:3:0 0,15,161:5:0 +17 2325 . C 0 . DP=24;I16=7,15,0,0,730,25576,0,0,1289,76441,0,0,427,9625,0,0;QS=3,0;MQSB=0.970024;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,102:3:0 0,12,130:4:0 +17 2326 . C 0 . DP=24;I16=7,15,0,0,709,23523,0,0,1320,79200,0,0,426,9498,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,241:15:0 0,9,95:3:0 0,12,133:4:0 +17 2327 . G 0 . DP=24;I16=7,17,0,0,817,29275,0,0,1409,83641,0,0,481,10891,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,81:3:0 0,15,158:5:0 +17 2328 . A 0 . DP=24;I16=6,17,0,0,814,29804,0,0,1349,80041,0,0,461,10427,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,82:3:0 0,15,172:5:0 +17 2329 . G 0 . DP=23;I16=6,16,0,0,755,27641,0,0,1289,76441,0,0,477,11005,0,0;QS=3,0;MQSB=0.97584;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,63:2:0 0,15,160:5:0 +17 2330 . C 0 . DP=24;I16=7,17,0,0,875,33131,0,0,1409,83641,0,0,498,11424,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,87:3:0 0,18,181:6:0 +17 2331 . T 0 . DP=24;I16=7,17,0,0,862,31882,0,0,1409,83641,0,0,505,11635,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,106:3:0 0,18,200:6:0 +17 2332 . A 0 . DP=25;I16=8,17,0,0,926,35412,0,0,1469,87241,0,0,512,11864,0,0;QS=3,0;MQSB=0.973216;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,97:3:0 0,18,204:6:0 +17 2333 . G 0 . DP=26;I16=8,17,0,0,923,35129,0,0,1469,87241,0,0,494,11436,0,0;QS=3,0;MQSB=0.973216;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,97:3:0 0,18,189:6:0 +17 2334 . G 0 . DP=26;I16=8,18,0,0,928,34574,0,0,1529,90841,0,0,527,12277,0,0;QS=3,0;MQSB=0.975611;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,93:3:0 0,21,202:7:0 +17 2335 . A 0 . DP=26;I16=8,18,0,0,967,36793,0,0,1529,90841,0,0,535,12513,0,0;QS=3,0;MQSB=0.975611;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,105:3:0 0,21,214:7:0 +17 2336 . G 0 . DP=26;I16=8,18,0,0,962,36346,0,0,1529,90841,0,0,543,12769,0,0;QS=3,0;MQSB=0.975611;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,92:3:0 0,21,204:7:0 +17 2337 . G 0 . DP=26;I16=7,18,0,0,895,32981,0,0,1469,87241,0,0,527,12465,0,0;QS=3,0;MQSB=0.977814;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,74:2:0 0,21,204:7:0 +17 2338 . A 0 . DP=26;I16=8,18,0,0,892,31758,0,0,1529,90841,0,0,556,13186,0,0;QS=3,0;MQSB=0.975611;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,87:3:0 0,21,194:7:0 +17 2339 . T 0 . DP=26;I16=7,18,0,0,827,28921,0,0,1469,87241,0,0,537,12769,0,0;QS=3,0;MQSB=0.977814;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,55:2:0 0,21,200:7:0 +17 2340 . C 0 . DP=25;I16=7,18,0,0,792,25816,0,0,1469,87241,0,0,541,12893,0,0;QS=3,0;MQSB=0.977814;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,57:2:0 0,21,173:7:0 +17 2341 . G 0 . DP=25;I16=6,17,0,0,771,26477,0,0,1349,80041,0,0,494,11732,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,3,41:1:0 0,21,186:7:0 +17 2342 . T 0 . DP=24;I16=6,17,0,0,863,32711,0,0,1349,80041,0,0,523,12459,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,3,43:1:0 0,21,214:7:0 +17 2343 . T 0 . DP=24;I16=6,16,0,0,770,28230,0,0,1289,76441,0,0,504,12032,0,0;QS=3,0;MQSB=0.97584;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,3,44:1:0 0,21,213:7:0 +17 2344 . T 0 . DP=24;I16=7,17,0,0,843,30483,0,0,1409,83641,0,0,552,13124,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,56:2:0 0,21,202:7:0 +17 2345 . G 0 . DP=24;I16=7,17,0,0,897,34121,0,0,1409,83641,0,0,554,13162,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,77:2:0 0,21,206:7:0 +17 2346 . A 0 . DP=24;I16=7,17,0,0,908,34818,0,0,1409,83641,0,0,556,13212,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,68:2:0 0,21,220:7:0 +17 2347 . G 0 . DP=24;I16=6,17,0,0,824,30406,0,0,1349,80041,0,0,533,12649,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,3,39:1:0 0,21,190:7:0 +17 2348 . T 0 . DP=24;I16=7,16,0,0,745,25653,0,0,1349,80041,0,0,544,13072,0,0;QS=3,0;MQSB=0.973027;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,64:2:0 0,18,183:6:0 +17 2349 . C 0 . DP=24;I16=6,17,0,0,804,29224,0,0,1349,80041,0,0,534,12656,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,3,36:1:0 0,21,200:7:0 +17 2350 . C 0 . DP=25;I16=7,17,0,0,869,31905,0,0,1409,83641,0,0,534,12652,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,63:2:0 0,21,198:7:0 +17 2351 . A 0 . DP=25;I16=8,17,0,0,945,36169,0,0,1469,87241,0,0,559,13237,0,0;QS=3,0;MQSB=0.973216;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,74:2:0 0,21,222:7:0 +17 2352 . G 0 . DP=25;I16=7,17,0,0,893,34005,0,0,1409,83641,0,0,533,12539,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,3,41:1:0 0,21,207:7:0 +17 2353 . C 0 . DP=24;I16=7,17,0,0,866,31864,0,0,1409,83641,0,0,531,12435,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,3,41:1:0 0,21,205:7:0 +17 2354 . A 0 . DP=24;I16=7,17,0,0,880,33206,0,0,1409,83641,0,0,529,12351,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,3,43:1:0 0,21,214:7:0 +17 2355 . G 0 . DP=24;I16=7,17,0,0,871,32261,0,0,1409,83641,0,0,526,12238,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,3,39:1:0 0,21,195:7:0 +17 2356 . T 0 . DP=24;I16=7,17,0,0,887,33305,0,0,1409,83641,0,0,521,12047,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,3,43:1:0 0,21,219:7:0 +17 2357 . T 0 . DP=24;I16=7,17,0,0,899,34225,0,0,1409,83641,0,0,516,11878,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,3,43:1:0 0,21,220:7:0 +17 2358 . T 0 . DP=24;I16=7,17,0,0,913,34891,0,0,1409,83641,0,0,510,11680,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,3,40:1:0 0,21,218:7:0 +17 2359 . G 0 . DP=25;I16=7,17,0,0,898,34048,0,0,1409,83641,0,0,503,11451,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,3,39:1:0 0,21,209:7:0 +17 2360 . A 0 . DP=25;I16=7,18,0,0,959,37113,0,0,1469,87241,0,0,514,11552,0,0;QS=3,0;MQSB=0.977814;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,72:2:0 0,21,222:7:0 +17 2361 . G 0 . DP=25;I16=7,17,0,0,850,30946,0,0,1409,83641,0,0,482,10726,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,67:2:0 0,18,168:6:0 +17 2362 . A 0 . DP=25;I16=7,17,0,0,762,25482,0,0,1409,83641,0,0,475,10547,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,51:2:0 0,18,159:6:0 +17 2363 . C 0 . DP=25;I16=7,18,0,0,875,31837,0,0,1469,87241,0,0,493,11015,0,0;QS=3,0;MQSB=0.977814;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,65:2:0 0,21,187:7:0 +17 2364 . C 0 . DP=25;I16=7,18,0,0,927,34965,0,0,1469,87241,0,0,486,10880,0,0;QS=3,0;MQSB=0.977814;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,64:2:0 0,21,201:7:0 +17 2365 . A 0 . DP=24;I16=7,17,0,0,908,34754,0,0,1409,83641,0,0,479,10717,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,65:2:0 0,21,221:7:0 +17 2366 . G 0 . DP=25;I16=7,17,0,0,912,35074,0,0,1440,86400,0,0,447,9951,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,58:2:0 0,21,206:7:0 +17 2367 . C 0 . DP=25;I16=7,17,0,0,872,32088,0,0,1409,83641,0,0,440,9782,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,3,36:1:0 0,21,197:7:0 +17 2368 . C 0 . DP=24;I16=6,17,0,0,871,33801,0,0,1349,80041,0,0,434,9634,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,3,39:1:0 0,18,180:6:0 +17 2369 . T 0 . DP=24;I16=6,18,0,0,877,33009,0,0,1409,83641,0,0,452,10082,0,0;QS=3,0;MQSB=0.980199;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,49:2:0 0,18,179:6:0 +17 2370 . G 0 . DP=24;I16=6,18,0,0,899,34289,0,0,1409,83641,0,0,445,9927,0,0;QS=3,0;MQSB=0.980199;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,56:2:0 0,18,179:6:0 +17 2371 . G 0 . DP=24;I16=6,18,0,0,880,33088,0,0,1409,83641,0,0,438,9794,0,0;QS=3,0;MQSB=0.980199;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,51:2:0 0,18,177:6:0 +17 2372 . C 0 . DP=24;I16=6,18,0,0,827,29615,0,0,1409,83641,0,0,431,9683,0,0;QS=3,0;MQSB=0.980199;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,47:2:0 0,18,163:6:0 +17 2373 . C 0 . DP=24;I16=6,18,0,0,886,33212,0,0,1409,83641,0,0,424,9594,0,0;QS=3,0;MQSB=0.980199;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,58:2:0 0,18,166:6:0 +17 2374 . A 0 . DP=23;I16=6,17,0,0,844,31230,0,0,1349,80041,0,0,417,9477,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,66:2:0 0,18,177:6:0 +17 2375 . A 0 . DP=23;I16=5,17,0,0,788,28340,0,0,1289,76441,0,0,409,9333,0,0;QS=3,0;MQSB=0.981001;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,64:2:0 0,18,171:6:0 +17 2376 . T 0 . DP=22;I16=5,17,0,0,778,27804,0,0,1289,76441,0,0,401,9161,0,0;QS=3,0;MQSB=0.981001;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,62:2:0 0,18,162:6:0 +17 2377 . A 0 . DP=21;I16=4,17,0,0,704,24488,0,0,1229,72841,0,0,394,9008,0,0;QS=3,0;MQSB=0.984085;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,49:2:0 0,15,135:5:0 +17 2378 . C 0 . DP=20;I16=4,16,0,0,626,20138,0,0,1169,69241,0,0,388,8872,0,0;QS=3,0;MQSB=0.982301;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,3,15:1:0 0,15,108:5:0 +17 2379 . G 0 . DP=20;I16=4,16,0,0,714,25924,0,0,1169,69241,0,0,382,8752,0,0;QS=3,0;MQSB=0.982301;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,3,34:1:0 0,15,140:5:0 +17 2380 . G 0 . DP=19;I16=4,14,0,0,672,25672,0,0,1049,62041,0,0,352,8022,0,0;QS=3,0;MQSB=0.977696;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,18:1:0 0,15,134:5:0 +17 2381 . C 0 . DP=18;I16=4,14,0,0,676,25626,0,0,1049,62041,0,0,373,8555,0,0;QS=3,0;MQSB=0.977696;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,28:1:0 0,15,133:5:0 +17 2382 . A 0 . DP=19;I16=5,14,0,0,669,23995,0,0,1109,65641,0,0,369,8475,0,0;QS=3,0;MQSB=0.97357;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,3,28:1:0 0,15,131:5:0 +17 2383 . A 0 . DP=19;I16=5,14,0,0,686,25162,0,0,1109,65641,0,0,365,8359,0,0;QS=3,0;MQSB=0.97357;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,3,26:1:0 0,15,140:5:0 +17 2384 . A 0 . DP=19;I16=5,14,0,0,649,22943,0,0,1109,65641,0,0,360,8210,0,0;QS=3,0;MQSB=0.97357;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,3,13:1:0 0,15,132:5:0 +17 2385 . A 0 . DP=18;I16=4,14,0,0,643,23235,0,0,1049,62041,0,0,356,8078,0,0;QS=3,0;MQSB=0.977696;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,38:1:0 0,15,134:5:0 +17 2386 . C 0 . DP=18;I16=4,14,0,0,652,24008,0,0,1049,62041,0,0,351,7913,0,0;QS=3,0;MQSB=0.977696;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,25:1:0 0,15,130:5:0 +17 2387 . C 0 . DP=18;I16=4,14,0,0,667,25007,0,0,1049,62041,0,0,345,7717,0,0;QS=3,0;MQSB=0.977696;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,25:1:0 0,15,128:5:0 +17 2388 . C 0 . DP=18;I16=4,14,0,0,691,26659,0,0,1049,62041,0,0,339,7541,0,0;QS=3,0;MQSB=0.977696;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,39:1:0 0,15,134:5:0 +17 2389 . A 0 . DP=19;I16=5,14,0,0,682,24912,0,0,1109,65641,0,0,333,7385,0,0;QS=3,0;MQSB=0.97357;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,3,35:1:0 0,15,140:5:0 +17 2390 . G 0 . DP=18;I16=5,13,0,0,642,23418,0,0,1049,62041,0,0,328,7200,0,0;QS=3,0;MQSB=0.970092;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,27:1:0 0,15,126:5:0 +17 2391 . T 0 . DP=18;I16=5,12,0,0,624,23122,0,0,989,58441,0,0,298,6412,0,0;QS=2,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,0,0:0:0 0,15,140:5:0 +17 2392 . C 0 . DP=18;I16=5,12,0,0,660,25910,0,0,989,58441,0,0,291,6171,0,0;QS=2,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,0,0:0:0 0,15,131:5:0 +17 2393 . T 0 . DP=18;I16=5,13,0,0,669,25099,0,0,1049,62041,0,0,309,6577,0,0;QS=3,0;MQSB=0.970092;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,38:1:0 0,15,134:5:0 +17 2394 . C 0 . DP=17;I16=5,12,0,0,653,25323,0,0,989,58441,0,0,303,6379,0,0;QS=3,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,3,29:1:0 0,15,133:5:0 +17 2395 . T 0 . DP=17;I16=5,12,0,0,613,22621,0,0,989,58441,0,0,297,6201,0,0;QS=3,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,3,19:1:0 0,15,128:5:0 +17 2396 . A 0 . DP=17;I16=5,11,0,0,584,21426,0,0,929,54841,0,0,266,5418,0,0;QS=2,0;MQSB=0.960687;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,0,0:0:0 0,15,130:5:0 +17 2397 . C 0 . DP=18;I16=5,13,0,0,650,24046,0,0,1049,62041,0,0,284,5856,0,0;QS=3,0;MQSB=0.970092;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,18:1:0 0,15,129:5:0 +17 2398 . A 0 . DP=18;I16=5,13,0,0,617,21907,0,0,1049,62041,0,0,278,5692,0,0;QS=3,0;MQSB=0.970092;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,19:1:0 0,15,128:5:0 +17 2399 . A 0 . DP=17;I16=5,11,0,0,592,22176,0,0,929,54841,0,0,248,4926,0,0;QS=2,0;MQSB=0.960687;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,0,0:0:0 0,12,115:4:0 +17 2400 . A 0 . DP=16;I16=5,11,0,0,576,21010,0,0,929,54841,0,0,269,5431,0,0;QS=3,0;MQSB=0.960687;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,26:1:0 0,9,99:3:0 +17 2401 . A 0 . DP=17;I16=6,11,0,0,594,21126,0,0,989,58441,0,0,265,5331,0,0;QS=3,0;MQSB=0.955563;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,3,23:1:0 0,9,98:3:0 +17 2402 . A 0 . DP=17;I16=6,11,0,0,606,21986,0,0,989,58441,0,0,262,5252,0,0;QS=3,0;MQSB=0.955563;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,3,27:1:0 0,9,99:3:0 +17 2403 . A 0 . DP=17;I16=6,11,0,0,608,22130,0,0,989,58441,0,0,259,5195,0,0;QS=3,0;MQSB=0.955563;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,3,21:1:0 0,9,97:3:0 +17 2404 . T 0 . DP=17;I16=6,11,0,0,567,19449,0,0,989,58441,0,0,256,5160,0,0;QS=3,0;MQSB=0.955563;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,3,14:1:0 0,9,87:3:0 +17 2405 . A 0 . DP=18;I16=7,11,0,0,618,21666,0,0,1049,62041,0,0,253,5147,0,0;QS=3,0;MQSB=0.951002;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,3,17:1:0 0,9,88:3:0 +17 2406 . C 0 . DP=18;I16=7,11,0,0,676,25664,0,0,1049,62041,0,0,250,5108,0,0;QS=3,0;MQSB=0.951002;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,3,27:1:0 0,9,90:3:0 +17 2407 . A 0 . DP=19;I16=8,11,0,0,673,24197,0,0,1109,65641,0,0,246,5046,0,0;QS=3,0;MQSB=0.946915;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,3,34:1:0 0,9,89:3:0 +17 2408 . A 0 . DP=18;I16=8,10,0,0,619,21951,0,0,1049,62041,0,0,243,4961,0,0;QS=3,0;MQSB=0.938795;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,3,22:1:0 0,6,73:2:0 +17 2409 . A 0 . DP=17;I16=8,9,0,0,615,22687,0,0,1020,61200,0,0,240,4852,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,3,39:1:0 0,6,74:2:0 +17 2410 . A 0 . DP=17;I16=8,9,0,0,604,21938,0,0,1020,61200,0,0,237,4769,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,3,39:1:0 0,6,73:2:0 +17 2411 . A 0 . DP=16;I16=7,9,0,0,567,20551,0,0,960,57600,0,0,235,4711,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,3,25:1:0 0,6,70:2:0 +17 2412 . A 0 . DP=15;I16=7,8,0,0,527,18903,0,0,900,54000,0,0,234,4676,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,21:1:0 0,6,70:2:0 +17 2413 . C 0 . DP=15;I16=7,8,0,0,559,21161,0,0,900,54000,0,0,233,4663,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,22:1:0 0,6,72:2:0 +17 2414 . A 0 . DP=16;I16=8,8,0,0,570,20822,0,0,929,54841,0,0,232,4672,0,0;QS=3,0;MQSB=0.915545;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,3,25:1:0 0,6,73:2:0 +17 2415 . A 0 . DP=16;I16=9,7,0,0,574,20768,0,0,929,54841,0,0,232,4652,0,0;QS=3,0;MQSB=0.933674;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,3,30:1:0 0,6,64:2:0 +17 2416 . C 0 . DP=17;I16=8,8,0,0,576,21424,0,0,960,57600,0,0,231,4649,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,42:2:0 0,6,68:2:0 +17 2417 . T 0 . DP=17;I16=10,7,0,0,612,22740,0,0,958,55682,0,0,235,4627,0,0;QS=3,0;MQSB=0.79189;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,57:2:0 0,9,92:3:0 +17 2418 . A 0 . DP=17;I16=10,7,0,0,624,23210,0,0,958,55682,0,0,238,4626,0,0;QS=3,0;MQSB=0.79189;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,62:2:0 0,9,105:3:0 +17 2419 . G 0 . DP=19;I16=11,7,0,0,651,24113,0,0,1018,59282,0,0,241,4651,0,0;QS=3,0;MQSB=0.817948;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,51:2:0 0,12,126:4:0 +17 2420 . C 0 . DP=19;I16=11,8,0,0,663,23999,0,0,1078,62882,0,0,246,4704,0,0;QS=3,0;MQSB=0.803979;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,44:2:0 0,12,127:4:0 +17 2421 . C 0 . DP=19;I16=10,8,0,0,657,24779,0,0,1049,62041,0,0,244,4738,0,0;QS=3,0;MQSB=0.938795;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,45:2:0 0,12,126:4:0 +17 2422 . A 0 . DP=18;I16=11,6,0,0,647,24747,0,0,958,55682,0,0,238,4538,0,0;QS=3,0;MQSB=0.833753;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,33:1:0 0,12,137:4:0 +17 2423 . G 0 . DP=18;I16=11,6,0,0,634,24250,0,0,958,55682,0,0,258,4972,0,0;QS=3,0;MQSB=0.833753;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,54:2:0 0,12,126:4:0 +17 2424 . G 0 . DP=18;I16=10,6,0,0,595,22361,0,0,929,54841,0,0,240,4714,0,0;QS=3,0;MQSB=0.948436;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,3,36:1:0 0,12,126:4:0 +17 2425 . C 0 . DP=18;I16=10,7,0,0,596,21716,0,0,989,58441,0,0,260,5074,0,0;QS=3,0;MQSB=0.943335;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,45:2:0 0,12,114:4:0 +17 2426 . G 0 . DP=18;I16=10,7,0,0,550,18088,0,0,989,58441,0,0,263,5171,0,0;QS=3,0;MQSB=0.943335;MQ0F=0 PL:DP:DV 0,33,232:11:0 0,6,59:2:0 0,12,113:4:0 +17 2427 . T 0 . DP=18;I16=11,6,0,0,618,22654,0,0,958,55682,0,0,275,5403,0,0;QS=3,0;MQSB=0.833753;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,62:2:0 0,9,99:3:0 +17 2428 . G 0 . DP=18;I16=11,7,0,0,649,24633,0,0,1018,59282,0,0,281,5535,0,0;QS=3,0;MQSB=0.817948;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,48:2:0 0,12,128:4:0 +17 2429 . G 0 . DP=18;I16=10,7,0,0,553,19057,0,0,989,58441,0,0,269,5459,0,0;QS=3,0;MQSB=0.943335;MQ0F=0 PL:DP:DV 0,33,241:11:0 0,6,55:2:0 0,12,117:4:0 +17 2430 . T A, 0 . DP=18;I16=10,7,1,0,552,18556,21,441,989,58441,29,841,271,5603,16,256;QS=2.94278,0.0572207,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.817948;BQB=1;MQ0F=0 PL:DP:DV 0,15,212,33,215,222:12:1 0,6,60,6,60,60:2:0 0,12,125,12,125,125:4:0 +17 2431 . G 0 . DP=18;I16=11,5,0,0,580,21766,0,0,898,52082,0,0,268,5764,0,0;QS=3,0;MQSB=0.851779;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,37:1:0 0,9,98:3:0 +17 2432 . G 0 . DP=17;I16=10,7,0,0,593,21479,0,0,958,55682,0,0,295,6179,0,0;QS=3,0;MQSB=0.79189;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,53:2:0 0,9,97:3:0 +17 2433 . T 0 . DP=17;I16=10,7,0,0,577,20425,0,0,958,55682,0,0,299,6321,0,0;QS=3,0;MQSB=0.79189;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,57:2:0 0,9,94:3:0 +17 2434 . G 0 . DP=17;I16=10,6,0,0,546,19340,0,0,929,54841,0,0,284,6082,0,0;QS=3,0;MQSB=0.948436;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,46:2:0 0,6,62:2:0 +17 2435 . C 0 . DP=18;I16=12,5,0,0,597,21843,0,0,958,55682,0,0,304,6626,0,0;QS=3,0;MQSB=0.870325;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,6,58:2:0 0,6,60:2:0 +17 2436 . A 0 . DP=18;I16=11,6,0,0,545,18599,0,0,989,58441,0,0,295,6379,0,0;QS=3,0;MQSB=0.955563;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,64:3:0 0,6,61:2:0 +17 2437 . C 0 . DP=18;I16=11,5,0,0,573,21195,0,0,929,54841,0,0,297,6541,0,0;QS=3,0;MQSB=0.960687;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,63:2:0 0,6,63:2:0 +17 2438 . A 0 . DP=19;I16=12,6,0,0,583,20111,0,0,1018,59282,0,0,328,7322,0,0;QS=3,0;MQSB=0.85394;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,65:2:0 0,6,65:2:0 +17 2439 . C 0 . DP=19;I16=11,7,0,0,635,22997,0,0,1049,62041,0,0,314,6974,0,0;QS=3,0;MQSB=0.951002;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,91:3:0 0,6,57:2:0 +17 2440 . C 0 . DP=21;I16=13,7,0,0,701,26195,0,0,1138,66482,0,0,346,7840,0,0;QS=3,0;MQSB=0.857404;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,114:4:0 0,6,66:2:0 +17 2441 . T 0 . DP=21;I16=13,8,0,0,788,29910,0,0,1198,70082,0,0,360,8068,0,0;QS=3,0;MQSB=0.845496;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,164:5:0 0,6,67:2:0 +17 2442 . G 0 . DP=20;I16=12,7,0,0,695,25957,0,0,1109,65641,0,0,342,7596,0,0;QS=3,0;MQSB=0.957193;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,128:4:0 0,6,66:2:0 +17 2443 . T 0 . DP=20;I16=13,7,0,0,697,24685,0,0,1138,66482,0,0,373,8345,0,0;QS=3,0;MQSB=0.857404;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,130:4:0 0,6,64:2:0 +17 2444 . A 0 . DP=21;I16=13,8,0,0,755,27981,0,0,1198,70082,0,0,379,8489,0,0;QS=3,0;MQSB=0.845496;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,140:4:0 0,6,64:2:0 +17 2445 . G 0 . DP=21;I16=12,8,0,0,731,27427,0,0,1169,69241,0,0,359,7927,0,0;QS=3,0;MQSB=0.953497;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,130:4:0 0,6,65:2:0 +17 2446 . T 0 . DP=21;I16=13,8,0,0,723,25707,0,0,1198,70082,0,0,389,8633,0,0;QS=3,0;MQSB=0.845496;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,128:4:0 0,6,65:2:0 +17 2447 . C 0 . DP=22;I16=14,8,0,0,770,27950,0,0,1258,73682,0,0,394,8732,0,0;QS=3,0;MQSB=0.86151;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,127:4:0 0,6,64:2:0 +17 2448 . C 0 . DP=23;I16=14,7,0,0,727,26165,0,0,1167,67323,0,0,388,8674,0,0;QS=3,0;MQSB=0.735784;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,129:5:0 0,6,66:2:0 +17 2449 . C 0 . DP=23;I16=13,8,0,0,727,26415,0,0,1198,70082,0,0,363,7787,0,0;QS=3,0;MQSB=0.845496;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,128:5:0 0,6,62:2:0 +17 2450 . A 0 . DP=22;I16=12,8,0,0,673,24267,0,0,1138,66482,0,0,371,7959,0,0;QS=3,0;MQSB=0.826565;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,143:5:0 0,6,65:2:0 +17 2451 . G 0 . DP=22;I16=14,8,0,0,821,31595,0,0,1227,70923,0,0,429,9401,0,0;QS=3,0;MQSB=0.715049;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,151:5:0 0,6,67:2:0 +17 2452 . C 0 . DP=22;I16=14,8,0,0,743,26557,0,0,1227,70923,0,0,437,9613,0,0;QS=3,0;MQSB=0.715049;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,137:5:0 0,6,66:2:0 +17 2453 . T 0 . DP=22;I16=14,8,0,0,775,28215,0,0,1227,70923,0,0,445,9845,0,0;QS=3,0;MQSB=0.715049;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,143:5:0 0,6,68:2:0 +17 2454 . A 0 . DP=22;I16=14,8,0,0,721,24545,0,0,1227,70923,0,0,453,10097,0,0;QS=3,0;MQSB=0.715049;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,145:5:0 0,6,64:2:0 +17 2455 . C 0 . DP=22;I16=14,8,0,0,776,28212,0,0,1227,70923,0,0,461,10369,0,0;QS=3,0;MQSB=0.715049;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,138:5:0 0,6,65:2:0 +17 2456 . T 0 . DP=24;I16=14,9,0,0,834,30902,0,0,1318,77282,0,0,444,10036,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,168:6:0 0,6,60:2:0 +17 2457 . C 0 . DP=24;I16=15,9,0,0,816,29244,0,0,1347,78123,0,0,478,10924,0,0;QS=3,0;MQSB=0.72325;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,159:6:0 0,6,65:2:0 +17 2458 . A 0 . DP=24;I16=15,9,0,0,869,32555,0,0,1347,78123,0,0,487,11209,0,0;QS=3,0;MQSB=0.72325;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,166:6:0 0,6,65:2:0 +17 2459 . G T, 0 . DP=24;I16=13,9,1,0,822,31186,13,169,1289,76441,29,841,453,10551,17,289;QS=2.92973,0.0702703,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.851535;BQB=1;MQ0F=0 PL:DP:DV 0,45,255,45,255,255:15:0 0,5,138,15,141,144:6:1 0,6,64,6,64,64:2:0 +17 2460 . G 0 . DP=24;I16=14,9,0,0,834,31432,0,0,1318,77282,0,0,477,11065,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,160:6:0 0,6,65:2:0 +17 2461 . A G, 0 . DP=24;I16=14,9,1,0,839,31487,13,169,1318,77282,29,841,489,11521,19,361;QS=2.93401,0.0659898,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.72325;BQB=1;MQ0F=0 PL:DP:DV 0,48,255,48,255,255:16:0 0,5,148,15,151,154:6:1 0,6,67,6,67,67:2:0 +17 2462 . G 0 . DP=25;I16=15,10,0,0,893,33155,0,0,1407,81723,0,0,514,12090,0,0;QS=3,0;MQSB=0.707404;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,165:6:0 0,6,66:2:0 +17 2463 . G T, 0 . DP=25;I16=12,10,1,0,777,28525,14,196,1289,76441,29,841,452,10720,25,625;QS=2.975,0.025,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.825053;BQB=1;MQ0F=0 PL:DP:DV 0,36,255,48,255,255:17:1 0,12,133,12,133,133:4:0 0,6,68,6,68,68:2:0 +17 2464 . C 0 . DP=25;I16=15,10,0,0,904,34194,0,0,1407,81723,0,0,526,12458,0,0;QS=3,0;MQSB=0.707404;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,149:6:0 0,6,67:2:0 +17 2465 . T 0 . DP=25;I16=14,10,0,0,857,32235,0,0,1347,78123,0,0,506,11994,0,0;QS=3,0;MQSB=0.679965;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,163:6:0 0,6,69:2:0 +17 2466 . G 0 . DP=24;I16=14,9,0,0,852,32336,0,0,1318,77282,0,0,509,12025,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,157:6:0 0,6,63:2:0 +17 2467 . A 0 . DP=24;I16=14,9,0,0,829,30725,0,0,1318,77282,0,0,513,12121,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,168:6:0 0,6,67:2:0 +17 2468 . G 0 . DP=24;I16=15,9,0,0,890,34034,0,0,1347,78123,0,0,541,12807,0,0;QS=3,0;MQSB=0.72325;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,169:6:0 0,6,64:2:0 +17 2469 . G 0 . DP=24;I16=15,9,0,0,865,32303,0,0,1347,78123,0,0,544,12882,0,0;QS=3,0;MQSB=0.72325;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,174:6:0 0,6,58:2:0 +17 2470 . G 0 . DP=24;I16=14,9,0,0,829,30785,0,0,1318,77282,0,0,521,12295,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,178:6:0 0,6,58:2:0 +17 2471 . G 0 . DP=24;I16=14,9,0,0,833,31429,0,0,1318,77282,0,0,523,12345,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,170:5:0 0,6,64:2:0 +17 2472 . G 0 . DP=24;I16=13,9,0,0,774,28428,0,0,1289,76441,0,0,499,11733,0,0;QS=3,0;MQSB=0.955854;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,154:5:0 0,6,56:2:0 +17 2473 . A 0 . DP=24;I16=13,9,0,0,775,28137,0,0,1258,73682,0,0,508,12078,0,0;QS=3,0;MQSB=0.834768;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,160:5:0 0,6,63:2:0 +17 2474 . A 0 . DP=25;I16=15,9,0,0,851,31665,0,0,1378,80882,0,0,524,12322,0,0;QS=3,0;MQSB=0.865888;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,160:5:0 0,9,80:3:0 +17 2475 . G 0 . DP=25;I16=15,9,0,0,913,35239,0,0,1378,80882,0,0,525,12323,0,0;QS=3,0;MQSB=0.865888;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,167:5:0 0,9,84:3:0 +17 2476 . G 0 . DP=25;I16=13,9,0,0,776,28584,0,0,1289,76441,0,0,488,11544,0,0;QS=3,0;MQSB=0.955854;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,138:5:0 0,9,82:3:0 +17 2477 . A 0 . DP=25;I16=14,9,0,0,867,34329,0,0,1318,77282,0,0,515,12223,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,178:5:0 0,9,91:3:0 +17 2478 . C 0 . DP=25;I16=14,9,0,0,897,36911,0,0,1318,77282,0,0,517,12289,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,175:5:0 0,9,87:3:0 +17 2479 . T 0 . DP=25;I16=15,9,0,0,921,37957,0,0,1378,80882,0,0,529,12467,0,0;QS=3,0;MQSB=0.865888;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,176:5:0 0,9,97:3:0 +17 2480 . G 0 . DP=25;I16=14,9,0,0,877,35485,0,0,1349,80041,0,0,504,11864,0,0;QS=3,0;MQSB=0.960618;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,176:5:0 0,9,88:3:0 +17 2481 . C 0 . DP=25;I16=13,9,0,0,848,34542,0,0,1289,76441,0,0,496,11838,0,0;QS=3,0;MQSB=0.955854;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,183:5:0 0,9,88:3:0 +17 2482 . T 0 . DP=25;I16=15,9,0,0,905,37331,0,0,1378,80882,0,0,526,12430,0,0;QS=3,0;MQSB=0.865888;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,178:5:0 0,9,96:3:0 +17 2483 . T 0 . DP=25;I16=14,9,0,0,879,36187,0,0,1318,77282,0,0,517,12311,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,180:5:0 0,9,89:3:0 +17 2484 . G 0 . DP=25;I16=14,9,0,0,884,35142,0,0,1349,80041,0,0,494,11604,0,0;QS=3,0;MQSB=0.960618;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,174:5:0 0,9,84:3:0 +17 2485 . A T, 0 . DP=25;I16=14,9,1,0,891,36757,17,289,1349,80041,29,841,490,11502,25,625;QS=2.96926,0.0307414,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.865888;BQB=1;MQ0F=0 PL:DP:DV 0,31,255,45,255,255:16:1 0,15,193,15,193,193:5:0 0,9,93,9,93,93:3:0 +17 2486 . G 0 . DP=25;I16=15,9,0,0,898,36230,0,0,1378,80882,0,0,511,12041,0,0;QS=3,0;MQSB=0.865888;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,153:5:0 0,9,90:3:0 +17 2487 . C 0 . DP=25;I16=14,9,0,0,793,30695,0,0,1349,80041,0,0,482,11346,0,0;QS=3,0;MQSB=0.960618;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,175:5:0 0,9,91:3:0 +17 2488 . C 0 . DP=25;I16=13,9,0,0,841,34597,0,0,1289,76441,0,0,457,10841,0,0;QS=3,0;MQSB=0.955854;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,174:5:0 0,9,93:3:0 +17 2489 . C 0 . DP=23;I16=11,9,0,0,801,34227,0,0,1169,69241,0,0,454,10788,0,0;QS=3,0;MQSB=0.943233;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,187:5:0 0,9,93:3:0 +17 2490 . A 0 . DP=23;I16=11,10,0,0,818,34642,0,0,1229,72841,0,0,451,10695,0,0;QS=3,0;MQSB=0.939898;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,175:5:0 0,12,128:4:0 +17 2491 . G 0 . DP=23;I16=12,10,0,0,845,35143,0,0,1258,73682,0,0,471,11097,0,0;QS=3,0;MQSB=0.804615;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,178:5:0 0,12,121:4:0 +17 2492 . G A, 0 . DP=23;I16=11,10,1,0,845,36207,16,256,1229,72841,29,841,446,10494,21,441;QS=2.96708,0.0329218,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.804615;BQB=1;MQ0F=0 PL:DP:DV 0,22,255,36,255,255:13:1 0,15,187,15,187,187:5:0 0,12,124,12,124,124:4:0 +17 2493 . A G, 0 . DP=23;I16=11,10,1,0,855,37007,13,169,1229,72841,29,841,442,10340,20,400;QS=2.97269,0.0273109,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.804615;BQB=1;MQ0F=0 PL:DP:DV 0,25,255,36,255,255:13:1 0,15,191,15,191,191:5:0 0,12,127,12,127,127:4:0 +17 2494 . G 0 . DP=23;I16=11,10,0,0,802,32720,0,0,1229,72841,0,0,437,10153,0,0;QS=3,0;MQSB=0.939898;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,179:5:0 0,12,118:4:0 +17 2495 . T 0 . DP=23;I16=10,10,0,0,737,29861,0,0,1138,66482,0,0,413,9513,0,0;QS=3,0;MQSB=0.751477;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,172:5:0 0,12,113:4:0 +17 2496 . T 0 . DP=23;I16=12,10,0,0,815,32793,0,0,1258,73682,0,0,442,10026,0,0;QS=3,0;MQSB=0.804615;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,183:5:0 0,12,123:4:0 +17 2497 . T 0 . DP=22;I16=12,9,0,0,807,33723,0,0,1198,70082,0,0,436,9814,0,0;QS=3,0;MQSB=0.815018;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,177:5:0 0,12,131:4:0 +17 2498 . G 0 . DP=22;I16=12,9,0,0,808,33264,0,0,1198,70082,0,0,430,9622,0,0;QS=3,0;MQSB=0.815018;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,173:5:0 0,12,127:4:0 +17 2499 . A 0 . DP=22;I16=12,9,0,0,847,36803,0,0,1198,70082,0,0,424,9450,0,0;QS=3,0;MQSB=0.815018;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,185:5:0 0,12,133:4:0 +17 2500 . G 0 . DP=22;I16=11,9,0,0,772,32546,0,0,1169,69241,0,0,404,9078,0,0;QS=3,0;MQSB=0.943233;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,168:5:0 0,12,129:4:0 +17 2501 . G 0 . DP=22;I16=11,8,0,0,768,33120,0,0,1109,65641,0,0,373,8293,0,0;QS=3,0;MQSB=0.946915;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,146:4:0 0,12,118:4:0 +17 2502 . C 0 . DP=22;I16=12,8,0,0,798,33902,0,0,1138,66482,0,0,378,8270,0,0;QS=3,0;MQSB=0.826565;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,155:4:0 0,12,125:4:0 +17 2503 . T 0 . DP=22;I16=12,9,0,0,851,36841,0,0,1198,70082,0,0,396,8746,0,0;QS=3,0;MQSB=0.815018;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,180:5:0 0,12,139:4:0 +17 2504 . G 0 . DP=22;I16=12,9,0,0,787,31955,0,0,1198,70082,0,0,389,8615,0,0;QS=3,0;MQSB=0.815018;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,171:5:0 0,12,129:4:0 +17 2505 . C 0 . DP=21;I16=11,9,0,0,792,33440,0,0,1138,66482,0,0,383,8501,0,0;QS=3,0;MQSB=0.791547;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,169:5:0 0,12,132:4:0 +17 2506 . T 0 . DP=22;I16=11,10,0,0,798,32868,0,0,1198,70082,0,0,376,8354,0,0;QS=3,0;MQSB=0.780412;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,175:5:0 0,15,169:5:0 +17 2507 . G 0 . DP=21;I16=9,10,0,0,716,30074,0,0,1109,65641,0,0,365,8189,0,0;QS=3,0;MQSB=0.920044;MQ0F=0 PL:DP:DV 0,27,241:9:0 0,15,163:5:0 0,15,153:5:0 +17 2508 . T 0 . DP=21;I16=9,10,0,0,724,30396,0,0,1109,65641,0,0,361,8089,0,0;QS=3,0;MQSB=0.920044;MQ0F=0 PL:DP:DV 0,27,241:9:0 0,15,158:5:0 0,15,162:5:0 +17 2509 . G T, 0 . DP=21;I16=8,10,1,0,710,30408,35,1225,1049,62041,60,3600,330,7282,25,625;QS=2.80663,0.19337,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.920044;BQB=1;MQ0F=0 PL:DP:DV 0,27,253,27,253,253:9:0 20,0,122,32,125,150:5:1 0,15,163,15,163,163:5:0 +17 2510 . A 0 . DP=21;I16=10,10,0,0,778,33128,0,0,1138,66482,0,0,352,7754,0,0;QS=3,0;MQSB=0.751477;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,174:5:0 0,15,161:5:0 +17 2511 . G 0 . DP=21;I16=10,10,0,0,771,32165,0,0,1138,66482,0,0,344,7558,0,0;QS=3,0;MQSB=0.751477;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,161:5:0 0,15,159:5:0 +17 2512 . C 0 . DP=21;I16=10,10,0,0,790,33406,0,0,1138,66482,0,0,336,7386,0,0;QS=3,0;MQSB=0.751477;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,175:5:0 0,15,160:5:0 +17 2513 . T 0 . DP=21;I16=10,10,0,0,755,31503,0,0,1138,66482,0,0,327,7189,0,0;QS=3,0;MQSB=0.751477;MQ0F=0 PL:DP:DV 0,30,246:10:0 0,15,180:5:0 0,15,156:5:0 +17 2514 . G 0 . DP=20;I16=9,10,0,0,702,28002,0,0,1109,65641,0,0,319,7017,0,0;QS=3,0;MQSB=0.920044;MQ0F=0 PL:DP:DV 0,27,228:9:0 0,15,171:5:0 0,15,155:5:0 +17 2515 . T 0 . DP=19;I16=8,10,0,0,642,25888,0,0,1049,62041,0,0,312,6868,0,0;QS=3,0;MQSB=0.906029;MQ0F=0 PL:DP:DV 0,24,182:8:0 0,15,172:5:0 0,15,141:5:0 +17 2516 . G 0 . DP=19;I16=8,10,0,0,685,28155,0,0,1049,62041,0,0,303,6641,0,0;QS=3,0;MQSB=0.906029;MQ0F=0 PL:DP:DV 0,24,211:8:0 0,15,175:5:0 0,15,147:5:0 +17 2517 . A 0 . DP=18;I16=8,9,0,0,660,27600,0,0,989,58441,0,0,295,6435,0,0;QS=3,0;MQSB=0.91051;MQ0F=0 PL:DP:DV 0,24,215:8:0 0,12,139:4:0 0,15,161:5:0 +17 2518 . T 0 . DP=17;I16=6,9,0,0,611,26911,0,0,900,54000,0,0,273,6023,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,188:7:0 0,12,144:4:0 0,12,146:4:0 +17 2519 . C 0 . DP=16;I16=7,8,0,0,531,20111,0,0,900,54000,0,0,282,6078,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,175:7:0 0,12,141:4:0 0,12,125:4:0 +17 2520 . G 0 . DP=15;I16=6,8,0,0,501,19731,0,0,840,50400,0,0,277,5923,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,187:7:0 0,12,129:4:0 0,9,101:3:0 +17 2521 . C 0 . DP=15;I16=6,8,0,0,583,25777,0,0,840,50400,0,0,272,5782,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,214:7:0 0,12,149:4:0 0,9,111:3:0 +17 2522 . A 0 . DP=16;I16=6,8,0,0,516,20930,0,0,840,50400,0,0,266,5606,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,173:7:0 0,12,139:4:0 0,9,114:3:0 +17 2523 . T 0 . DP=16;I16=6,9,0,0,588,25538,0,0,900,54000,0,0,270,5546,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,207:7:0 0,15,157:5:0 0,9,117:3:0 +17 2524 . C 0 . DP=16;I16=5,9,0,0,548,23502,0,0,840,50400,0,0,256,5342,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,182:6:0 0,15,156:5:0 0,9,112:3:0 +17 2525 . A C, 0 . DP=17;I16=6,9,0,1,550,23138,28,784,900,54000,60,3600,248,5174,12,144;QS=2.86,0.14,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=1;BQB=1;MQ0F=0 PL:DP:DV 0,24,168,24,168,168:8:0 13,0,138,25,141,159:5:1 0,9,117,9,117,117:3:0 +17 2526 . C 0 . DP=18;I16=6,11,0,0,677,28649,0,0,1020,61200,0,0,256,5232,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,229:9:0 0,15,183:5:0 0,9,113:3:0 +17 2527 . T 0 . DP=18;I16=6,11,0,0,674,29286,0,0,1020,61200,0,0,252,5118,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,217:9:0 0,15,183:5:0 0,9,119:3:0 +17 2528 . G 0 . DP=18;I16=6,11,0,0,701,30729,0,0,1020,61200,0,0,248,5028,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,234:9:0 0,15,184:5:0 0,9,119:3:0 +17 2529 . C 0 . DP=18;I16=6,11,0,0,676,28974,0,0,1020,61200,0,0,244,4962,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,228:9:0 0,15,175:5:0 0,9,117:3:0 +17 2530 . A 0 . DP=18;I16=6,10,0,0,624,26620,0,0,960,57600,0,0,223,4631,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,209:9:0 0,12,153:4:0 0,9,116:3:0 +17 2531 . T 0 . DP=17;I16=6,10,0,0,641,27911,0,0,960,57600,0,0,236,4852,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,210:8:0 0,15,175:5:0 0,9,122:3:0 +17 2532 . T 0 . DP=17;I16=6,10,0,0,634,27460,0,0,960,57600,0,0,230,4708,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,212:8:0 0,15,173:5:0 0,9,117:3:0 +17 2533 . C 0 . DP=18;I16=6,11,0,0,614,24196,0,0,1020,61200,0,0,224,4588,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,212:9:0 0,15,159:5:0 0,9,104:3:0 +17 2534 . C 0 . DP=16;I16=5,10,0,0,595,25141,0,0,900,54000,0,0,221,4491,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,202:8:0 0,12,144:4:0 0,9,110:3:0 +17 2535 . A 0 . DP=16;I16=5,10,0,0,617,27711,0,0,900,54000,0,0,218,4416,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,204:8:0 0,12,136:4:0 0,9,123:3:0 +17 2536 . G 0 . DP=15;I16=4,10,0,0,543,23023,0,0,840,50400,0,0,216,4362,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,195:8:0 0,9,102:3:0 0,9,117:3:0 +17 2537 . C 0 . DP=15;I16=4,10,0,0,555,24075,0,0,840,50400,0,0,213,4279,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,195:8:0 0,9,113:3:0 0,9,115:3:0 +17 2538 . C 0 . DP=15;I16=5,9,0,0,510,21070,0,0,840,50400,0,0,211,4217,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,157:7:0 0,9,129:3:0 0,12,126:4:0 +17 2539 . C 0 . DP=15;I16=5,9,0,0,464,16896,0,0,840,50400,0,0,209,4125,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,146:7:0 0,9,122:3:0 0,12,111:4:0 +17 2540 . G 0 . DP=16;I16=6,9,0,0,548,21860,0,0,900,54000,0,0,207,4053,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,189:7:0 0,12,139:4:0 0,12,110:4:0 +17 2541 . G 0 . DP=15;I16=5,9,0,0,535,22527,0,0,840,50400,0,0,207,4001,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,170:7:0 0,9,117:3:0 0,12,140:4:0 +17 2542 . T 0 . DP=15;I16=4,9,0,0,527,23207,0,0,780,46800,0,0,203,3953,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,183:7:0 0,9,125:3:0 0,9,109:3:0 +17 2543 . G 0 . DP=15;I16=5,9,0,0,540,23004,0,0,840,50400,0,0,207,3957,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,196:7:0 0,9,117:3:0 0,12,117:4:0 +17 2544 . A 0 . DP=16;I16=6,9,0,0,569,24139,0,0,900,54000,0,0,207,3965,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,202:8:0 0,9,119:3:0 0,12,132:4:0 +17 2545 . C 0 . DP=16;I16=6,9,0,0,583,24657,0,0,900,54000,0,0,208,3994,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,217:8:0 0,9,118:3:0 0,12,130:4:0 +17 2546 . A 0 . DP=16;I16=6,9,0,0,608,27290,0,0,900,54000,0,0,209,4045,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,206:8:0 0,9,133:3:0 0,12,144:4:0 +17 2547 . G 0 . DP=16;I16=6,9,0,0,597,26215,0,0,900,54000,0,0,211,4117,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,191:7:0 0,9,131:3:0 0,15,150:5:0 +17 2548 . A 0 . DP=16;I16=6,9,0,0,632,28806,0,0,900,54000,0,0,214,4210,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,196:7:0 0,9,131:3:0 0,15,171:5:0 +17 2549 . G 0 . DP=16;I16=6,9,0,0,594,25254,0,0,900,54000,0,0,217,4325,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,180:7:0 0,9,132:3:0 0,15,160:5:0 +17 2550 . T 0 . DP=16;I16=6,9,0,0,572,24134,0,0,900,54000,0,0,219,4413,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,182:7:0 0,9,122:3:0 0,15,148:5:0 +17 2551 . G 0 . DP=16;I16=6,9,0,0,578,24606,0,0,900,54000,0,0,220,4474,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,181:7:0 0,9,131:3:0 0,15,151:5:0 +17 2552 . A 0 . DP=15;I16=6,8,0,0,585,26419,0,0,840,50400,0,0,221,4505,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,178:6:0 0,9,129:3:0 0,15,168:5:0 +17 2553 . G 0 . DP=15;I16=6,8,0,0,528,21944,0,0,840,50400,0,0,222,4554,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,170:6:0 0,9,117:3:0 0,15,142:5:0 +17 2554 . T 0 . DP=15;I16=6,8,0,0,543,23015,0,0,840,50400,0,0,223,4621,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,156:6:0 0,9,129:3:0 0,15,160:5:0 +17 2555 . C 0 . DP=15;I16=6,8,0,0,566,24416,0,0,840,50400,0,0,224,4706,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,173:6:0 0,9,131:3:0 0,15,159:5:0 +17 2556 . A 0 . DP=14;I16=6,7,0,0,487,20095,0,0,780,46800,0,0,226,4808,0,0;QS=3,0;MQSB=0.961166;MQ0F=0 PL:DP:DV 0,15,141:5:0 0,9,125:3:0 0,15,146:5:0 +17 2557 . C 0 . DP=13;I16=5,8,0,0,471,17481,0,0,780,46800,0,0,249,5325,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,15,161:5:0 0,9,96:3:0 0,15,151:5:0 +17 2558 . T 0 . DP=14;I16=5,9,0,0,535,20597,0,0,840,50400,0,0,251,5417,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,173:6:0 0,9,99:3:0 0,15,174:5:0 +17 2559 . G 0 . DP=14;I16=5,9,0,0,509,18693,0,0,840,50400,0,0,253,5475,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,172:6:0 0,9,98:3:0 0,15,156:5:0 +17 2560 . T 0 . DP=14;I16=5,9,0,0,489,17587,0,0,840,50400,0,0,255,5549,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,160:6:0 0,9,106:3:0 0,15,144:5:0 +17 2561 . C 0 . DP=14;I16=5,9,0,0,489,17477,0,0,840,50400,0,0,257,5639,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,164:6:0 0,9,96:3:0 0,15,153:5:0 +17 2562 . T 0 . DP=13;I16=5,8,0,0,460,17016,0,0,780,46800,0,0,260,5744,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,15,139:5:0 0,9,99:3:0 0,15,167:5:0 +17 2563 . C 0 . DP=14;I16=5,8,0,0,433,15133,0,0,780,46800,0,0,263,5863,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,15,149:5:0 0,9,83:3:0 0,15,142:5:0 +17 2564 . A G, 0 . DP=15;I16=1,4,4,5,174,6124,316,11352,300,18000,540,32400,61,1311,184,4034;QS=0.988263,2.01174,0;VDB=0.690812;SGB=-3.20711;RPB=0.197899;MQB=1;MQSB=1;BQB=0.965069;MQ0F=0 PL:DP:DV 88,0,78,98,87,171:6:3 57,0,56,63,62,117:4:2 124,12,0,124,12,124:4:4 +17 2565 . A 0 . DP=15;I16=6,9,0,0,562,21216,0,0,900,54000,0,0,274,6076,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,178:6:0 0,12,134:4:0 0,15,166:5:0 +17 2566 . A 0 . DP=15;I16=6,9,0,0,545,20019,0,0,900,54000,0,0,276,6098,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,181:6:0 0,12,120:4:0 0,15,162:5:0 +17 2567 . A 0 . DP=16;I16=7,9,0,0,580,21342,0,0,960,57600,0,0,278,6136,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,177:6:0 0,15,151:5:0 0,15,166:5:0 +17 2568 . A 0 . DP=16;I16=7,8,0,0,555,20795,0,0,900,54000,0,0,256,5566,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,180:6:0 0,12,132:4:0 0,15,167:5:0 +17 2569 . A 0 . DP=17;I16=7,10,0,0,661,25943,0,0,1020,61200,0,0,284,6264,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,213:7:0 0,15,163:5:0 0,15,172:5:0 +17 2570 . G 0 . DP=18;I16=8,10,0,0,664,24968,0,0,1080,64800,0,0,287,6305,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,213:7:0 0,15,152:5:0 0,18,176:6:0 +17 2571 . A 0 . DP=18;I16=8,10,0,0,618,21870,0,0,1080,64800,0,0,291,6365,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,195:7:0 0,15,155:5:0 0,18,155:6:0 +17 2572 . A 0 . DP=18;I16=8,10,0,0,631,22829,0,0,1080,64800,0,0,295,6445,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,194:7:0 0,15,150:5:0 0,18,173:6:0 +17 2573 . A 0 . DP=18;I16=8,10,0,0,690,26830,0,0,1080,64800,0,0,298,6494,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,210:7:0 0,15,170:5:0 0,18,183:6:0 +17 2574 . G 0 . DP=18;I16=8,10,0,0,664,24884,0,0,1080,64800,0,0,301,6561,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,211:7:0 0,15,152:5:0 0,18,176:6:0 +17 2575 . G 0 . DP=18;I16=8,10,0,0,642,23904,0,0,1080,64800,0,0,305,6645,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,242:8:0 0,15,145:5:0 0,15,140:5:0 +17 2576 . A 0 . DP=18;I16=7,10,0,0,595,21311,0,0,1020,61200,0,0,285,6121,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,210:8:0 0,15,153:5:0 0,12,131:4:0 +17 2577 . A 0 . DP=19;I16=8,10,0,0,682,26398,0,0,1080,64800,0,0,290,6240,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,244:8:0 0,15,161:5:0 0,15,155:5:0 +17 2578 . G 0 . DP=18;I16=9,9,0,0,643,24115,0,0,1080,64800,0,0,322,7002,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,249:8:0 0,12,114:4:0 0,18,161:6:0 +17 2579 . A 0 . DP=18;I16=9,8,0,0,634,23870,0,0,1020,61200,0,0,304,6532,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,229:8:0 0,9,110:3:0 0,18,176:6:0 +17 2580 . A 0 . DP=18;I16=9,9,0,0,629,22593,0,0,1080,64800,0,0,336,7330,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,223:8:0 0,12,117:4:0 0,18,169:6:0 +17 2581 . A 0 . DP=19;I16=10,9,0,0,691,25669,0,0,1140,68400,0,0,343,7521,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,12,133:4:0 0,18,166:6:0 +17 2582 . T 0 . DP=19;I16=10,9,0,0,674,24218,0,0,1140,68400,0,0,350,7682,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,235:9:0 0,12,138:4:0 0,18,168:6:0 +17 2583 . A 0 . DP=19;I16=10,9,0,0,693,25465,0,0,1140,68400,0,0,357,7865,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,247:9:0 0,12,126:4:0 0,18,178:6:0 +17 2584 . A 0 . DP=19;I16=10,9,0,0,702,26340,0,0,1140,68400,0,0,363,8019,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,243:9:0 0,12,134:4:0 0,18,187:6:0 +17 2585 . A 0 . DP=19;I16=9,9,0,0,690,26700,0,0,1080,64800,0,0,350,7818,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,250:9:0 0,9,114:3:0 0,18,190:6:0 +17 2586 . G 0 . DP=19;I16=10,9,0,0,714,27314,0,0,1140,68400,0,0,373,8283,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,12,127:4:0 0,18,176:6:0 +17 2587 . A 0 . DP=20;I16=9,9,0,0,665,24781,0,0,1049,62041,0,0,343,7717,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,137:4:0 0,12,136:4:0 +17 2588 . A 0 . DP=21;I16=12,9,0,0,737,26531,0,0,1229,72841,0,0,384,8620,0,0;QS=3,0;MQSB=0.950149;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,138:4:0 0,18,162:6:0 +17 2589 . A 0 . DP=22;I16=13,9,0,0,780,28412,0,0,1289,76441,0,0,390,8770,0,0;QS=3,0;MQSB=0.955854;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,142:4:0 0,18,170:6:0 +17 2590 . A 0 . DP=22;I16=13,9,0,0,774,28352,0,0,1289,76441,0,0,396,8894,0,0;QS=3,0;MQSB=0.955854;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,135:4:0 0,18,160:6:0 +17 2591 . C 0 . DP=21;I16=13,8,0,0,765,28617,0,0,1229,72841,0,0,403,9041,0,0;QS=3,0;MQSB=0.95891;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,136:4:0 0,15,136:5:0 +17 2592 . A 0 . DP=21;I16=13,8,0,0,763,28325,0,0,1229,72841,0,0,410,9210,0,0;QS=3,0;MQSB=0.95891;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,140:4:0 0,15,139:5:0 +17 2593 . A 0 . DP=21;I16=13,8,0,0,754,27888,0,0,1229,72841,0,0,416,9350,0,0;QS=3,0;MQSB=0.95891;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,141:4:0 0,15,147:5:0 +17 2594 . A 0 . DP=21;I16=13,8,0,0,775,29179,0,0,1229,72841,0,0,422,9510,0,0;QS=3,0;MQSB=0.95891;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,130:4:0 0,15,153:5:0 +17 2595 . T 0 . DP=22;I16=14,8,0,0,766,27472,0,0,1289,76441,0,0,427,9639,0,0;QS=3,0;MQSB=0.963419;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,119:4:0 0,15,143:5:0 +17 2596 . A 0 . DP=22;I16=13,8,0,0,751,27409,0,0,1229,72841,0,0,407,9111,0,0;QS=3,0;MQSB=0.95891;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,123:4:0 0,12,129:4:0 +17 2597 . A 0 . DP=22;I16=14,8,0,0,811,30147,0,0,1289,76441,0,0,437,9851,0,0;QS=3,0;MQSB=0.963419;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,145:4:0 0,15,145:5:0 +17 2598 . A 0 . DP=22;I16=14,8,0,0,817,30915,0,0,1289,76441,0,0,442,9984,0,0;QS=3,0;MQSB=0.963419;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,136:4:0 0,15,159:5:0 +17 2599 . A 0 . DP=22;I16=14,8,0,0,800,29912,0,0,1289,76441,0,0,447,10135,0,0;QS=3,0;MQSB=0.963419;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,126:4:0 0,15,150:5:0 +17 2600 . A 0 . DP=22;I16=14,8,0,0,784,29138,0,0,1289,76441,0,0,451,10255,0,0;QS=3,0;MQSB=0.963419;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,113:4:0 0,15,150:5:0 +17 2601 . T 0 . DP=22;I16=14,8,0,0,770,27820,0,0,1289,76441,0,0,454,10344,0,0;QS=3,0;MQSB=0.963419;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,118:4:0 0,15,142:5:0 +17 2602 . A 0 . DP=23;I16=15,8,0,0,825,29971,0,0,1349,80041,0,0,457,10451,0,0;QS=3,0;MQSB=0.967216;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,143:4:0 0,18,154:6:0 +17 2603 . A 0 . DP=23;I16=15,8,0,0,862,32840,0,0,1349,80041,0,0,460,10526,0,0;QS=3,0;MQSB=0.967216;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,138:4:0 0,18,172:6:0 +17 2604 . T 0 . DP=23;I16=15,8,0,0,822,29902,0,0,1349,80041,0,0,463,10619,0,0;QS=3,0;MQSB=0.967216;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,129:4:0 0,18,154:6:0 +17 2605 . A 0 . DP=23;I16=14,8,0,0,845,32617,0,0,1289,76441,0,0,441,10105,0,0;QS=3,0;MQSB=0.963419;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,143:4:0 0,15,157:5:0 +17 2606 . G 0 . DP=23;I16=14,8,0,0,812,30796,0,0,1289,76441,0,0,444,10234,0,0;QS=3,0;MQSB=0.963419;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,129:4:0 0,15,142:5:0 +17 2607 . T 0 . DP=22;I16=15,7,0,0,782,28440,0,0,1289,76441,0,0,472,10954,0,0;QS=3,0;MQSB=0.970024;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,119:4:0 0,15,132:5:0 +17 2608 . G 0 . DP=22;I16=15,7,0,0,851,33169,0,0,1289,76441,0,0,474,11014,0,0;QS=3,0;MQSB=0.970024;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,132:4:0 0,15,127:5:0 +17 2609 . C 0 . DP=22;I16=15,7,0,0,796,29454,0,0,1289,76441,0,0,475,11041,0,0;QS=3,0;MQSB=0.970024;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,137:4:0 0,15,124:5:0 +17 2610 . A 0 . DP=22;I16=15,7,0,0,830,31684,0,0,1289,76441,0,0,476,11086,0,0;QS=3,0;MQSB=0.970024;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,146:4:0 0,15,121:5:0 +17 2611 . G 0 . DP=22;I16=15,7,0,0,824,32048,0,0,1289,76441,0,0,477,11149,0,0;QS=3,0;MQSB=0.970024;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,129:4:0 0,15,122:5:0 +17 2612 . A 0 . DP=22;I16=14,7,0,0,771,29035,0,0,1229,72841,0,0,453,10605,0,0;QS=3,0;MQSB=0.966484;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,130:4:0 0,12,117:4:0 +17 2613 . C 0 . DP=22;I16=15,7,0,0,832,31926,0,0,1289,76441,0,0,478,11278,0,0;QS=3,0;MQSB=0.970024;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,138:4:0 0,15,120:5:0 +17 2614 . A 0 . DP=21;I16=15,6,0,0,791,30065,0,0,1229,72841,0,0,477,11241,0,0;QS=3,0;MQSB=0.973096;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,110:3:0 0,15,140:5:0 +17 2615 . A 0 . DP=21;I16=15,6,0,0,777,29101,0,0,1229,72841,0,0,475,11167,0,0;QS=3,0;MQSB=0.973096;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,99:3:0 0,15,142:5:0 +17 2616 . A 0 . DP=21;I16=15,6,0,0,734,26922,0,0,1229,72841,0,0,472,11056,0,0;QS=3,0;MQSB=0.973096;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,90:3:0 0,15,144:5:0 +17 2617 . A 0 . DP=21;I16=15,6,0,0,810,31654,0,0,1229,72841,0,0,469,10959,0,0;QS=3,0;MQSB=0.973096;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,95:3:0 0,15,140:5:0 +17 2618 . G 0 . DP=23;I16=16,6,0,0,863,34219,0,0,1289,76441,0,0,441,10251,0,0;QS=3,0;MQSB=0.97584;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,74:2:0 0,15,132:5:0 +17 2619 . G 0 . DP=23;I16=16,6,0,0,807,30109,0,0,1289,76441,0,0,439,10135,0,0;QS=3,0;MQSB=0.97584;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,66:2:0 0,15,127:5:0 +17 2620 . C 0 . DP=23;I16=16,7,0,0,780,28242,0,0,1349,80041,0,0,462,10664,0,0;QS=3,0;MQSB=0.973027;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,87:3:0 0,15,115:5:0 +17 2621 . C 0 . DP=23;I16=16,7,0,0,860,32944,0,0,1349,80041,0,0,459,10537,0,0;QS=3,0;MQSB=0.973027;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,112:3:0 0,15,124:5:0 +17 2622 . T 0 . DP=24;I16=17,7,0,0,908,35474,0,0,1409,83641,0,0,456,10428,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,115:3:0 0,15,134:5:0 +17 2623 . T 0 . DP=24;I16=17,7,0,0,850,30978,0,0,1409,83641,0,0,453,10289,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,114:3:0 0,15,129:5:0 +17 2624 . G 0 . DP=24;I16=17,7,0,0,882,33332,0,0,1409,83641,0,0,450,10172,0,0;QS=3,0;MQSB=0.975597;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,101:3:0 0,15,133:5:0 +17 2625 . A 0 . DP=23;I16=17,6,0,0,855,32593,0,0,1349,80041,0,0,448,10076,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,114:3:0 0,15,135:5:0 +17 2626 . C 0 . DP=23;I16=17,6,0,0,847,31625,0,0,1349,80041,0,0,446,10000,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,100:3:0 0,15,122:5:0 +17 2627 . C 0 . DP=23;I16=17,6,0,0,863,32865,0,0,1349,80041,0,0,444,9944,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,104:3:0 0,15,129:5:0 +17 2628 . C 0 . DP=24;I16=17,6,0,0,793,28559,0,0,1349,80041,0,0,431,9757,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,95:3:0 0,15,127:5:0 +17 2629 . A 0 . DP=24;I16=18,6,0,0,893,33537,0,0,1409,83641,0,0,439,9789,0,0;QS=3,0;MQSB=0.980199;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,101:3:0 0,18,148:6:0 +17 2630 . T 0 . DP=24;I16=17,6,0,0,836,31094,0,0,1380,82800,0,0,412,9116,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,112:3:0 0,18,140:6:0 +17 2631 . C 0 . DP=24;I16=18,6,0,0,900,34378,0,0,1409,83641,0,0,435,9713,0,0;QS=3,0;MQSB=0.980199;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,104:3:0 0,18,142:6:0 +17 2632 . T 0 . DP=24;I16=18,6,0,0,937,37097,0,0,1409,83641,0,0,433,9705,0,0;QS=3,0;MQSB=0.980199;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,113:3:0 0,18,164:6:0 +17 2633 . A 0 . DP=23;I16=18,5,0,0,801,28913,0,0,1349,80041,0,0,431,9667,0,0;QS=3,0;MQSB=0.982789;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,95:3:0 0,18,148:6:0 +17 2634 . G 0 . DP=23;I16=19,3,0,0,861,34125,0,0,1289,76441,0,0,405,9023,0,0;QS=3,0;MQSB=0.989755;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,74:2:0 0,18,149:6:0 +17 2635 . C 0 . DP=23;I16=19,4,0,0,848,32154,0,0,1349,80041,0,0,429,9599,0,0;QS=3,0;MQSB=0.986928;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,107:3:0 0,18,148:6:0 +17 2636 . T 0 . DP=24;I16=19,4,0,0,871,33973,0,0,1349,80041,0,0,428,9572,0,0;QS=3,0;MQSB=0.986928;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,98:3:0 0,18,160:6:0 +17 2637 . T 0 . DP=24;I16=19,5,0,0,871,32073,0,0,1409,83641,0,0,428,9568,0,0;QS=3,0;MQSB=0.984335;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,111:3:0 0,18,144:6:0 +17 2638 . T 0 . DP=24;I16=19,5,0,0,821,28851,0,0,1409,83641,0,0,428,9588,0,0;QS=3,0;MQSB=0.984335;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,103:3:0 0,18,135:6:0 +17 2639 . G 0 . DP=24;I16=18,6,0,0,842,30840,0,0,1409,83641,0,0,428,9582,0,0;QS=3,0;MQSB=0.980199;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,106:3:0 0,15,125:5:0 +17 2640 . G 0 . DP=24;I16=17,6,0,0,749,25957,0,0,1380,82800,0,0,404,8976,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,84:3:0 0,15,117:5:0 +17 2641 . C 0 . DP=23;I16=17,6,0,0,834,31792,0,0,1349,80041,0,0,431,9645,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,61:2:0 0,15,129:5:0 +17 2642 . C 0 . DP=23;I16=17,6,0,0,809,30033,0,0,1349,80041,0,0,433,9713,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,58:2:0 0,15,131:5:0 +17 2643 . C 0 . DP=23;I16=17,6,0,0,856,33004,0,0,1349,80041,0,0,434,9756,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,57:2:0 0,15,133:5:0 +17 2644 . T 0 . DP=22;I16=16,5,0,0,805,31419,0,0,1229,72841,0,0,428,9648,0,0;QS=3,0;MQSB=0.978919;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,73:2:0 0,15,143:5:0 +17 2645 . C 0 . DP=22;I16=15,6,0,0,823,32499,0,0,1229,72841,0,0,415,9323,0,0;QS=3,0;MQSB=0.973096;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,78:2:0 0,12,122:4:0 +17 2646 . A 0 . DP=22;I16=16,6,0,0,826,31566,0,0,1289,76441,0,0,430,9524,0,0;QS=3,0;MQSB=0.97584;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,79:2:0 0,15,129:5:0 +17 2647 . G 0 . DP=22;I16=16,6,0,0,803,30643,0,0,1289,76441,0,0,428,9460,0,0;QS=3,0;MQSB=0.97584;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,77:2:0 0,15,129:5:0 +17 2648 . C 0 . DP=21;I16=15,6,0,0,811,31709,0,0,1229,72841,0,0,426,9368,0,0;QS=3,0;MQSB=0.973096;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,80:2:0 0,12,118:4:0 +17 2649 . A 0 . DP=23;I16=16,6,0,0,789,29215,0,0,1258,73682,0,0,414,9196,0,0;QS=3,0;MQSB=0.934321;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,93:3:0 0,12,105:4:0 +17 2650 . T 0 . DP=23;I16=16,7,0,0,856,32340,0,0,1318,77282,0,0,423,9197,0,0;QS=3,0;MQSB=0.955805;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,103:3:0 0,12,118:4:0 +17 2651 . C 0 . DP=23;I16=16,7,0,0,871,33599,0,0,1318,77282,0,0,422,9124,0,0;QS=3,0;MQSB=0.955805;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,95:3:0 0,12,121:4:0 +17 2652 . A 0 . DP=23;I16=16,7,0,0,820,30324,0,0,1318,77282,0,0,421,9077,0,0;QS=3,0;MQSB=0.955805;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,87:3:0 0,12,126:4:0 +17 2653 . A 0 . DP=23;I16=15,6,0,0,759,28489,0,0,1198,70082,0,0,389,8395,0,0;QS=3,0;MQSB=0.940481;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,73:2:0 0,9,109:3:0 +17 2654 . C 0 . DP=23;I16=16,7,0,0,836,31006,0,0,1318,77282,0,0,393,8385,0,0;QS=3,0;MQSB=0.955805;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,9,88:3:0 0,9,99:3:0 +17 2655 . C 0 . DP=23;I16=16,7,0,0,774,27190,0,0,1318,77282,0,0,392,8364,0,0;QS=3,0;MQSB=0.955805;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,9,83:3:0 0,9,95:3:0 +17 2656 . G 0 . DP=24;I16=17,7,0,0,781,25689,0,0,1378,80882,0,0,390,8320,0,0;QS=3,0;MQSB=0.95083;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,116:4:0 0,9,74:3:0 +17 2657 . C 0 . DP=24;I16=17,6,0,0,871,33435,0,0,1349,80041,0,0,381,8241,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,9,98:3:0 0,9,99:3:0 +17 2658 . T 0 . DP=23;I16=17,6,0,0,897,35255,0,0,1318,77282,0,0,389,8319,0,0;QS=3,0;MQSB=0.92854;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,133:4:0 0,9,107:3:0 +17 2659 . A 0 . DP=23;I16=17,6,0,0,817,29729,0,0,1318,77282,0,0,389,8361,0,0;QS=3,0;MQSB=0.92854;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,120:4:0 0,9,93:3:0 +17 2660 . G 0 . DP=23;I16=17,6,0,0,900,35462,0,0,1318,77282,0,0,389,8379,0,0;QS=3,0;MQSB=0.92854;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,126:4:0 0,9,94:3:0 +17 2661 . A 0 . DP=24;I16=18,6,0,0,871,32185,0,0,1378,80882,0,0,390,8422,0,0;QS=3,0;MQSB=0.923116;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,127:4:0 0,9,104:3:0 +17 2662 . T 0 . DP=24;I16=17,6,0,0,836,30812,0,0,1349,80041,0,0,366,7816,0,0;QS=3,0;MQSB=0.83771;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,122:4:0 0,9,99:3:0 +17 2663 . A 0 . DP=24;I16=17,6,0,0,827,30583,0,0,1318,77282,0,0,389,8341,0,0;QS=3,0;MQSB=0.92854;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,104:4:0 0,9,101:3:0 +17 2664 . C 0 . DP=23;I16=17,6,0,0,787,28083,0,0,1318,77282,0,0,388,8270,0,0;QS=3,0;MQSB=0.92854;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,107:4:0 0,9,91:3:0 +17 2665 . G 0 . DP=23;I16=17,6,0,0,728,23290,0,0,1318,77282,0,0,386,8178,0,0;QS=3,0;MQSB=0.92854;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,112:4:0 0,9,78:3:0 +17 2666 . T 0 . DP=23;I16=17,5,0,0,799,29273,0,0,1289,76441,0,0,367,7825,0,0;QS=3,0;MQSB=0.981001;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,105:3:0 0,9,94:3:0 +17 2667 . C 0 . DP=23;I16=16,5,0,0,792,30190,0,0,1260,75600,0,0,345,7393,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,96:3:0 0,9,98:3:0 +17 2668 . C 0 . DP=24;I16=18,6,0,0,832,29692,0,0,1378,80882,0,0,381,8069,0,0;QS=3,0;MQSB=0.923116;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,107:4:0 0,9,95:3:0 +17 2669 . C 0 . DP=23;I16=18,5,0,0,829,30953,0,0,1318,77282,0,0,383,8087,0,0;QS=3,0;MQSB=0.889264;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,120:4:0 0,9,88:3:0 +17 2670 . T 0 . DP=23;I16=17,5,0,0,841,32669,0,0,1289,76441,0,0,368,7828,0,0;QS=3,0;MQSB=0.801124;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,131:4:0 0,9,100:3:0 +17 2671 . C 0 . DP=22;I16=17,5,0,0,842,32448,0,0,1258,73682,0,0,386,8110,0,0;QS=3,0;MQSB=0.895399;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,128:4:0 0,6,70:2:0 +17 2672 . C 0 . DP=22;I16=17,5,0,0,808,30180,0,0,1258,73682,0,0,388,8164,0,0;QS=3,0;MQSB=0.895399;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,129:4:0 0,6,75:2:0 +17 2673 . C 0 . DP=22;I16=17,5,0,0,842,32528,0,0,1258,73682,0,0,390,8246,0,0;QS=3,0;MQSB=0.895399;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,133:4:0 0,6,75:2:0 +17 2674 . T 0 . DP=23;I16=17,6,0,0,860,33242,0,0,1318,77282,0,0,392,8356,0,0;QS=3,0;MQSB=0.92854;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,142:4:0 0,6,79:2:0 +17 2675 . T 0 . DP=22;I16=16,6,0,0,756,26986,0,0,1258,73682,0,0,394,8392,0,0;QS=3,0;MQSB=0.934321;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,134:4:0 0,6,74:2:0 +17 2676 . T 0 . DP=22;I16=16,6,0,0,774,28022,0,0,1258,73682,0,0,396,8452,0,0;QS=3,0;MQSB=0.934321;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,135:4:0 0,6,75:2:0 +17 2677 . C 0 . DP=22;I16=16,6,0,0,866,34444,0,0,1258,73682,0,0,398,8536,0,0;QS=3,0;MQSB=0.934321;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,131:4:0 0,6,77:2:0 +17 2678 . T 0 . DP=22;I16=16,5,0,0,818,32216,0,0,1229,72841,0,0,374,7970,0,0;QS=3,0;MQSB=0.978919;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,111:3:0 0,6,80:2:0 +17 2679 . T 0 . DP=22;I16=16,6,0,0,808,29912,0,0,1258,73682,0,0,400,8680,0,0;QS=3,0;MQSB=0.934321;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,137:4:0 0,6,75:2:0 +17 2680 . C 0 . DP=23;I16=16,7,0,0,873,33605,0,0,1318,77282,0,0,400,8740,0,0;QS=3,0;MQSB=0.955805;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,131:4:0 0,6,70:2:0 +17 2681 . T 0 . DP=22;I16=15,7,0,0,820,31248,0,0,1258,73682,0,0,402,8824,0,0;QS=3,0;MQSB=0.961028;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,133:4:0 0,6,75:2:0 +17 2682 . G 0 . DP=22;I16=15,7,0,0,831,31865,0,0,1258,73682,0,0,403,8881,0,0;QS=3,0;MQSB=0.961028;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,135:4:0 0,6,64:2:0 +17 2683 . G 0 . DP=22;I16=13,6,0,0,702,26368,0,0,1109,65641,0,0,394,8926,0,0;QS=3,0;MQSB=0.850016;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,136:4:0 0,6,53:2:0 +17 2684 . G 0 . DP=22;I16=14,7,0,0,754,27678,0,0,1229,72841,0,0,403,9057,0,0;QS=3,0;MQSB=0.872525;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,128:4:0 0,6,62:2:0 +17 2685 . G 0 . DP=22;I16=15,7,0,0,736,25916,0,0,1258,73682,0,0,406,9184,0,0;QS=3,0;MQSB=0.961028;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,130:4:0 0,6,45:2:0 +17 2686 . C 0 . DP=22;I16=15,7,0,0,803,29933,0,0,1258,73682,0,0,406,9278,0,0;QS=3,0;MQSB=0.961028;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,134:4:0 0,6,68:2:0 +17 2687 . A 0 . DP=21;I16=13,7,0,0,716,26356,0,0,1169,69241,0,0,406,9340,0,0;QS=3,0;MQSB=0.875769;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,136:4:0 0,6,61:2:0 +17 2688 . C 0 . DP=20;I16=13,7,0,0,750,28308,0,0,1169,69241,0,0,407,9417,0,0;QS=3,0;MQSB=0.875769;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,134:4:0 0,6,66:2:0 +17 2689 . A 0 . DP=19;I16=12,7,0,0,741,29105,0,0,1109,65641,0,0,409,9507,0,0;QS=3,0;MQSB=0.879351;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,140:4:0 0,6,73:2:0 +17 2690 . G 0 . DP=20;I16=12,8,0,0,751,28929,0,0,1169,69241,0,0,411,9609,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,135:4:0 0,6,61:2:0 +17 2691 . G 0 . DP=20;I16=12,7,0,0,682,25006,0,0,1109,65641,0,0,403,9603,0,0;QS=3,0;MQSB=0.879351;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,132:4:0 0,6,63:2:0 +17 2692 . T 0 . DP=20;I16=12,8,0,0,648,21758,0,0,1169,69241,0,0,417,9853,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,125:4:0 0,6,72:2:0 +17 2693 . C 0 . DP=20;I16=12,8,0,0,779,30645,0,0,1169,69241,0,0,418,9898,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,130:4:0 0,6,70:2:0 +17 2694 . A 0 . DP=21;I16=13,8,0,0,723,25649,0,0,1229,72841,0,0,417,9859,0,0;QS=3,0;MQSB=0.895122;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,126:4:0 0,6,73:2:0 +17 2695 . C 0 . DP=20;I16=12,8,0,0,757,28835,0,0,1169,69241,0,0,418,9834,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,130:4:0 0,6,63:2:0 +17 2696 . A 0 . DP=20;I16=12,8,0,0,733,27357,0,0,1169,69241,0,0,419,9823,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,130:4:0 0,6,69:2:0 +17 2697 . C 0 . DP=20;I16=12,8,0,0,738,27604,0,0,1169,69241,0,0,419,9777,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,128:4:0 0,6,66:2:0 +17 2698 . T 0 . DP=21;I16=12,8,0,0,788,31268,0,0,1169,69241,0,0,419,9747,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,144:4:0 0,6,77:2:0 +17 2699 . C 0 . DP=22;I16=13,9,0,0,864,34148,0,0,1258,73682,0,0,443,10309,0,0;QS=3,0;MQSB=0.686045;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,135:4:0 0,9,98:3:0 +17 2700 . T 0 . DP=22;I16=13,9,0,0,850,33296,0,0,1258,73682,0,0,444,10310,0,0;QS=3,0;MQSB=0.686045;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,141:4:0 0,9,105:3:0 +17 2701 . C 0 . DP=22;I16=13,9,0,0,863,34157,0,0,1258,73682,0,0,444,10278,0,0;QS=3,0;MQSB=0.686045;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,140:4:0 0,9,94:3:0 +17 2702 . T 0 . DP=22;I16=13,9,0,0,837,32525,0,0,1258,73682,0,0,444,10262,0,0;QS=3,0;MQSB=0.686045;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,143:4:0 0,9,83:3:0 +17 2703 . T 0 . DP=21;I16=12,8,0,0,717,25881,0,0,1169,69241,0,0,420,9636,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,130:4:0 0,3,32:1:0 +17 2704 . C 0 . DP=21;I16=12,9,0,0,794,30766,0,0,1198,70082,0,0,445,10225,0,0;QS=3,0;MQSB=0.695144;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,137:4:0 0,6,55:2:0 +17 2705 . C 0 . DP=21;I16=12,9,0,0,809,31649,0,0,1198,70082,0,0,445,10205,0,0;QS=3,0;MQSB=0.695144;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,136:4:0 0,6,56:2:0 +17 2706 . A 0 . DP=22;I16=12,10,0,0,820,31386,0,0,1258,73682,0,0,444,10150,0,0;QS=3,0;MQSB=0.731218;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,141:4:0 0,6,70:2:0 +17 2707 . G 0 . DP=22;I16=12,10,0,0,832,32104,0,0,1258,73682,0,0,444,10110,0,0;QS=3,0;MQSB=0.731218;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,139:4:0 0,6,60:2:0 +17 2708 . G 0 . DP=22;I16=12,10,0,0,777,28329,0,0,1258,73682,0,0,444,10086,0,0;QS=3,0;MQSB=0.731218;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,136:4:0 0,6,57:2:0 +17 2709 . T 0 . DP=22;I16=12,9,0,0,761,28341,0,0,1229,72841,0,0,418,9404,0,0;QS=3,0;MQSB=0.913101;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,137:4:0 0,3,39:1:0 +17 2710 . C 0 . DP=23;I16=12,10,0,0,840,32478,0,0,1289,76441,0,0,417,9365,0,0;QS=3,0;MQSB=0.924723;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,134:4:0 0,3,38:1:0 +17 2711 . T 0 . DP=24;I16=13,11,0,0,893,33721,0,0,1378,80882,0,0,442,9970,0,0;QS=3,0;MQSB=0.75304;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,12,138:4:0 0,6,72:2:0 +17 2712 . A 0 . DP=24;I16=13,11,0,0,889,33333,0,0,1378,80882,0,0,443,9971,0,0;QS=3,0;MQSB=0.75304;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,12,141:4:0 0,6,65:2:0 +17 2713 . G T, 0 . DP=25;I16=13,11,0,1,915,35485,14,196,1378,80882,29,841,419,9369,25,625;QS=2.72549,0.27451,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.569783;BQB=1;MQ0F=0 PL:DP:DV 0,57,255,57,255,255:19:0 0,12,131,12,131,131:4:0 8,0,31,11,34,42:2:1 +17 2714 . G 0 . DP=25;I16=13,11,0,0,891,33457,0,0,1378,80882,0,0,444,9990,0,0;QS=3,0;MQSB=0.75304;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,12,132:4:0 0,6,64:2:0 +17 2715 . A 0 . DP=25;I16=13,12,0,0,888,32012,0,0,1407,81723,0,0,446,10014,0,0;QS=3,0;MQSB=0.569783;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,12,135:4:0 0,6,63:2:0 +17 2716 . T 0 . DP=26;I16=13,13,0,0,937,34241,0,0,1467,85323,0,0,446,10012,0,0;QS=3,0;MQSB=0.606531;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,12,134:4:0 0,9,90:3:0 +17 2717 . G 0 . DP=26;I16=13,12,0,0,939,35995,0,0,1438,84482,0,0,422,9410,0,0;QS=3,0;MQSB=0.778801;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,12,134:4:0 0,6,72:2:0 +17 2718 . C 0 . DP=24;I16=12,11,0,0,864,33118,0,0,1318,77282,0,0,425,9457,0,0;QS=3,0;MQSB=0.7613;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,130:4:0 0,6,65:2:0 +17 2719 . A 0 . DP=24;I16=12,12,0,0,911,35371,0,0,1347,78123,0,0,452,10102,0,0;QS=3,0;MQSB=0.582748;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,139:4:0 0,9,99:3:0 +17 2720 . G 0 . DP=24;I16=12,12,0,0,940,37044,0,0,1347,78123,0,0,453,10095,0,0;QS=3,0;MQSB=0.582748;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,136:4:0 0,9,97:3:0 +17 2721 . C 0 . DP=24;I16=12,11,0,0,881,34499,0,0,1318,77282,0,0,429,9485,0,0;QS=3,0;MQSB=0.7613;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,131:4:0 0,6,76:2:0 +17 2722 . T 0 . DP=24;I16=11,13,0,0,898,34310,0,0,1347,78123,0,0,456,10146,0,0;QS=3,0;MQSB=0.633229;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,156:5:0 0,9,98:3:0 +17 2723 . G 0 . DP=25;I16=12,13,0,0,941,36257,0,0,1407,81723,0,0,459,10203,0,0;QS=3,0;MQSB=0.619223;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,184:6:0 0,9,76:3:0 +17 2724 . A 0 . DP=25;I16=12,13,0,0,917,34211,0,0,1407,81723,0,0,462,10234,0,0;QS=3,0;MQSB=0.619223;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,188:6:0 0,9,84:3:0 +17 2725 . G 0 . DP=25;I16=12,12,0,0,916,35656,0,0,1378,80882,0,0,438,9566,0,0;QS=3,0;MQSB=0.786628;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,185:6:0 0,6,67:2:0 +17 2726 . G 0 . DP=25;I16=11,12,0,0,841,31809,0,0,1287,74523,0,0,437,9545,0,0;QS=3,0;MQSB=0.597127;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,186:6:0 0,6,46:2:0 +17 2727 . G 0 . DP=25;I16=12,13,0,0,889,32233,0,0,1407,81723,0,0,464,10182,0,0;QS=3,0;MQSB=0.619223;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,194:7:0 0,6,56:2:0 +17 2728 . G 0 . DP=25;I16=12,13,0,0,883,32287,0,0,1407,81723,0,0,467,10219,0,0;QS=3,0;MQSB=0.619223;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,189:7:0 0,6,50:2:0 +17 2729 . T 0 . DP=25;I16=12,13,0,0,871,31019,0,0,1407,81723,0,0,469,10233,0,0;QS=3,0;MQSB=0.619223;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,189:7:0 0,6,62:2:0 +17 2730 . G 0 . DP=25;I16=12,13,0,0,907,34299,0,0,1407,81723,0,0,471,10275,0,0;QS=3,0;MQSB=0.619223;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,192:7:0 0,6,49:2:0 +17 2731 . C 0 . DP=25;I16=12,13,0,0,893,33027,0,0,1407,81723,0,0,473,10345,0,0;QS=3,0;MQSB=0.619223;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,192:7:0 0,6,52:2:0 +17 2732 . C 0 . DP=25;I16=12,13,0,0,882,32170,0,0,1407,81723,0,0,473,10343,0,0;QS=3,0;MQSB=0.619223;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,195:7:0 0,6,38:2:0 +17 2733 . C A, 0 . DP=25;I16=12,12,0,1,835,30063,13,169,1378,80882,29,841,448,9744,25,625;QS=2.64865,0.351351,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.619223;BQB=1;MQ0F=0 PL:DP:DV 0,48,255,48,255,255:16:0 0,21,187,21,187,187:7:0 7,0,18,10,21,28:2:1 +17 2734 . C 0 . DP=25;I16=12,12,0,0,890,33726,0,0,1378,80882,0,0,449,9797,0,0;QS=3,0;MQSB=0.786628;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,24,208:8:0 0,3,39:1:0 +17 2735 . T 0 . DP=26;I16=13,12,0,0,955,36875,0,0,1438,84482,0,0,451,9877,0,0;QS=3,0;MQSB=0.778801;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,228:8:0 0,3,41:1:0 +17 2736 . C 0 . DP=26;I16=13,11,0,0,921,35553,0,0,1409,83641,0,0,428,9308,0,0;QS=3,0;MQSB=0.931547;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,24,220:8:0 0,3,33:1:0 +17 2737 . T 0 . DP=26;I16=13,13,0,0,967,36581,0,0,1467,85323,0,0,475,10403,0,0;QS=3,0;MQSB=0.606531;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,228:8:0 0,6,64:2:0 +17 2738 . T 0 . DP=26;I16=13,13,0,0,895,31873,0,0,1467,85323,0,0,474,10374,0,0;QS=3,0;MQSB=0.606531;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,201:8:0 0,6,47:2:0 +17 2739 . A 0 . DP=26;I16=13,12,0,0,871,31051,0,0,1407,81723,0,0,448,9698,0,0;QS=3,0;MQSB=0.569783;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,224:8:0 0,9,78:3:0 +17 2740 . C 0 . DP=26;I16=14,11,0,0,952,36456,0,0,1438,84482,0,0,448,9674,0,0;QS=3,0;MQSB=0.745495;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,24,216:8:0 0,6,71:2:0 +17 2741 . C 0 . DP=26;I16=14,11,0,0,945,36141,0,0,1438,84482,0,0,448,9678,0,0;QS=3,0;MQSB=0.745495;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,24,215:8:0 0,6,75:2:0 +17 2742 . A 0 . DP=27;I16=15,12,0,0,949,34263,0,0,1527,88923,0,0,472,10284,0,0;QS=3,0;MQSB=0.547344;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,27,230:9:0 0,9,92:3:0 +17 2743 . T 0 . DP=27;I16=15,12,0,0,955,34479,0,0,1527,88923,0,0,471,10243,0,0;QS=3,0;MQSB=0.547344;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,27,224:9:0 0,9,99:3:0 +17 2744 . C 0 . DP=26;I16=15,10,0,0,955,36951,0,0,1438,84482,0,0,445,9557,0,0;QS=3,0;MQSB=0.707404;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,234:9:0 0,6,76:2:0 +17 2745 . T 0 . DP=26;I16=15,11,0,0,962,36786,0,0,1467,85323,0,0,469,10151,0,0;QS=3,0;MQSB=0.505697;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,243:9:0 0,9,104:3:0 +17 2746 . A 0 . DP=26;I16=15,10,0,0,912,33536,0,0,1438,84482,0,0,443,9525,0,0;QS=3,0;MQSB=0.707404;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,235:9:0 0,6,78:2:0 +17 2747 . A 0 . DP=26;I16=15,11,0,0,945,35117,0,0,1467,85323,0,0,467,10179,0,0;QS=3,0;MQSB=0.505697;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,238:9:0 0,9,96:3:0 +17 2748 . T 0 . DP=27;I16=15,12,0,0,1005,37901,0,0,1527,88923,0,0,465,10187,0,0;QS=3,0;MQSB=0.547344;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,27,246:9:0 0,9,103:3:0 +17 2749 . C 0 . DP=26;I16=14,12,0,0,975,37353,0,0,1467,85323,0,0,463,10123,0,0;QS=3,0;MQSB=0.558035;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,232:9:0 0,9,98:3:0 +17 2750 . T 0 . DP=26;I16=15,11,0,0,982,37714,0,0,1498,88082,0,0,462,10086,0,0;QS=3,0;MQSB=0.738577;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,227:8:0 0,12,130:4:0 +17 2751 . G 0 . DP=26;I16=15,10,0,0,945,36031,0,0,1469,87241,0,0,437,9451,0,0;QS=3,0;MQSB=0.9171;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,205:8:0 0,9,103:3:0 +17 2752 . T 0 . DP=26;I16=15,11,0,0,870,30288,0,0,1498,88082,0,0,460,9998,0,0;QS=3,0;MQSB=0.738577;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,189:8:0 0,12,119:4:0 +17 2753 . G 0 . DP=26;I16=15,11,0,0,867,30913,0,0,1498,88082,0,0,458,9948,0,0;QS=3,0;MQSB=0.738577;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,202:8:0 0,12,116:4:0 +17 2754 . C 0 . DP=25;I16=14,10,0,0,873,32607,0,0,1409,83641,0,0,436,9484,0,0;QS=3,0;MQSB=0.919431;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,24,205:8:0 0,9,104:3:0 +17 2755 . C 0 . DP=25;I16=14,10,0,0,865,32243,0,0,1409,83641,0,0,436,9528,0,0;QS=3,0;MQSB=0.919431;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,24,209:8:0 0,9,97:3:0 +17 2756 . C 0 . DP=25;I16=14,9,0,0,838,31276,0,0,1380,82800,0,0,411,8971,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,204:8:0 0,9,97:3:0 +17 2757 . T 0 . DP=25;I16=14,11,0,0,904,33980,0,0,1438,84482,0,0,455,10011,0,0;QS=3,0;MQSB=0.745495;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,212:7:0 0,15,147:5:0 +17 2758 . T 0 . DP=25;I16=14,10,0,0,841,30293,0,0,1409,83641,0,0,439,9801,0,0;QS=3,0;MQSB=0.919431;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,195:7:0 0,12,133:4:0 +17 2759 . A 0 . DP=25;I16=14,11,0,0,884,31728,0,0,1438,84482,0,0,457,10195,0,0;QS=3,0;MQSB=0.745495;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,192:7:0 0,15,147:5:0 +17 2760 . T 0 . DP=25;I16=14,11,0,0,907,33965,0,0,1438,84482,0,0,457,10275,0,0;QS=3,0;MQSB=0.745495;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,204:7:0 0,15,150:5:0 +17 2761 . T 0 . DP=23;I16=13,9,0,0,838,32530,0,0,1289,76441,0,0,444,10130,0,0;QS=3,0;MQSB=0.910098;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,185:6:0 0,12,141:4:0 +17 2762 . T 0 . DP=24;I16=13,11,0,0,869,32261,0,0,1378,80882,0,0,459,10395,0,0;QS=3,0;MQSB=0.75304;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,178:6:0 0,18,177:6:0 +17 2763 . C A, 0 . DP=24;I16=13,10,0,1,843,31711,13,169,1349,80041,29,841,448,10290,12,144;QS=2.93333,0.0666667,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.75304;BQB=1;MQ0F=0 PL:DP:DV 0,36,255,36,255,255:12:0 0,18,170,18,170,170:6:0 0,5,147,15,150,153:6:1 +17 2764 . C 0 . DP=24;I16=13,10,0,0,854,32376,0,0,1349,80041,0,0,450,10374,0,0;QS=3,0;MQSB=0.921963;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,163:6:0 0,15,162:5:0 +17 2765 . T 0 . DP=24;I16=12,11,0,0,853,32173,0,0,1318,77282,0,0,457,10469,0,0;QS=3,0;MQSB=0.7613;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,154:5:0 0,18,189:6:0 +17 2766 . C 0 . DP=24;I16=12,11,0,0,887,34485,0,0,1349,80041,0,0,448,10398,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,160:5:0 0,18,186:6:0 +17 2767 . T 0 . DP=24;I16=12,12,0,0,905,34757,0,0,1378,80882,0,0,458,10510,0,0;QS=3,0;MQSB=0.786628;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,153:5:0 0,21,217:7:0 +17 2768 . G 0 . DP=23;I16=11,11,0,0,852,33258,0,0,1289,76441,0,0,452,10462,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,141:5:0 0,18,197:6:0 +17 2769 . C 0 . DP=23;I16=11,12,0,0,832,31390,0,0,1318,77282,0,0,459,10481,0,0;QS=3,0;MQSB=0.795196;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,142:5:0 0,21,202:7:0 +17 2770 . T 0 . DP=23;I16=11,12,0,0,828,30854,0,0,1318,77282,0,0,459,10471,0,0;QS=3,0;MQSB=0.795196;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,152:5:0 0,21,199:7:0 +17 2771 . T 0 . DP=23;I16=11,11,0,0,817,30957,0,0,1258,73682,0,0,454,10456,0,0;QS=3,0;MQSB=0.770381;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,154:5:0 0,18,198:6:0 +17 2772 . T 0 . DP=23;I16=11,12,0,0,856,32206,0,0,1318,77282,0,0,459,10511,0,0;QS=3,0;MQSB=0.795196;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,160:5:0 0,21,210:7:0 +17 2773 . A 0 . DP=23;I16=11,12,0,0,828,30664,0,0,1318,77282,0,0,459,10561,0,0;QS=3,0;MQSB=0.795196;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,140:5:0 0,21,209:7:0 +17 2774 . G 0 . DP=22;I16=11,11,0,0,843,32715,0,0,1258,73682,0,0,458,10530,0,0;QS=3,0;MQSB=0.770381;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,154:5:0 0,21,207:7:0 +17 2775 . T 0 . DP=22;I16=10,11,0,0,748,27720,0,0,1198,70082,0,0,432,9892,0,0;QS=3,0;MQSB=0.780412;MQ0F=0 PL:DP:DV 0,30,253:10:0 0,12,115:4:0 0,21,203:7:0 +17 2776 . G 0 . DP=22;I16=12,10,0,0,803,30251,0,0,1289,76441,0,0,456,10470,0,0;QS=3,0;MQSB=0.924723;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,135:5:0 0,21,210:7:0 +17 2777 . A 0 . DP=22;I16=12,10,0,0,852,33524,0,0,1289,76441,0,0,456,10438,0,0;QS=3,0;MQSB=0.924723;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,148:5:0 0,21,220:7:0 +17 2778 . G 0 . DP=23;I16=12,11,0,0,861,33049,0,0,1349,80041,0,0,456,10422,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,154:5:0 0,21,224:7:0 +17 2779 . G 0 . DP=23;I16=11,11,0,0,834,32014,0,0,1289,76441,0,0,432,9798,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,136:4:0 0,21,219:7:0 +17 2780 . A 0 . DP=23;I16=11,11,0,0,792,29162,0,0,1289,76441,0,0,433,9817,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,33,244:11:0 0,12,133:4:0 0,21,215:7:0 +17 2781 . A 0 . DP=23;I16=11,11,0,0,844,33092,0,0,1289,76441,0,0,441,10141,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,30,253:10:0 0,15,151:5:0 0,21,233:7:0 +17 2782 . G 0 . DP=23;I16=12,11,0,0,840,31826,0,0,1349,80041,0,0,458,10438,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,154:5:0 0,21,218:7:0 +17 2783 . A 0 . DP=23;I16=11,11,0,0,860,33888,0,0,1289,76441,0,0,432,9790,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,142:4:0 0,21,230:7:0 +17 2784 . G 0 . DP=23;I16=12,11,0,0,860,33092,0,0,1349,80041,0,0,456,10410,0,0;QS=3,0;MQSB=0.934091;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,143:5:0 0,21,212:7:0 +17 2785 . G 0 . DP=23;I16=11,11,0,0,797,29747,0,0,1289,76441,0,0,429,9749,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,134:4:0 0,21,204:7:0 +17 2786 . C 0 . DP=24;I16=12,12,0,0,831,29497,0,0,1409,83641,0,0,451,10309,0,0;QS=3,0;MQSB=0.941765;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,141:5:0 0,21,199:7:0 +17 2787 . C 0 . DP=24;I16=11,12,0,0,792,28454,0,0,1349,80041,0,0,424,9642,0,0;QS=3,0;MQSB=0.944319;MQ0F=0 PL:DP:DV 0,36,252:12:0 0,12,127:4:0 0,21,200:7:0 +17 2788 . C 0 . DP=23;I16=11,11,0,0,791,29517,0,0,1289,76441,0,0,421,9523,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,125:4:0 0,21,209:7:0 +17 2789 . C 0 . DP=24;I16=13,11,0,0,880,33470,0,0,1409,83641,0,0,443,10051,0,0;QS=3,0;MQSB=0.931547;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,150:5:0 0,21,226:7:0 +17 2790 . T 0 . DP=23;I16=13,10,0,0,886,34738,0,0,1349,80041,0,0,442,9976,0,0;QS=3,0;MQSB=0.921963;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,165:5:0 0,21,227:7:0 +17 2791 . G 0 . DP=23;I16=13,10,0,0,873,34037,0,0,1349,80041,0,0,441,9923,0,0;QS=3,0;MQSB=0.921963;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,155:5:0 0,21,226:7:0 +17 2792 . G 0 . DP=23;I16=13,10,0,0,832,30870,0,0,1349,80041,0,0,438,9792,0,0;QS=3,0;MQSB=0.921963;MQ0F=0 PL:DP:DV 0,33,254:11:0 0,15,146:5:0 0,21,221:7:0 +17 2793 . T 0 . DP=23;I16=13,10,0,0,827,30693,0,0,1349,80041,0,0,435,9683,0,0;QS=3,0;MQSB=0.921963;MQ0F=0 PL:DP:DV 0,33,247:11:0 0,15,157:5:0 0,21,214:7:0 +17 2794 . C 0 . DP=22;I16=12,10,0,0,786,29122,0,0,1289,76441,0,0,433,9595,0,0;QS=3,0;MQSB=0.924723;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,145:5:0 0,21,201:7:0 +17 2795 . C 0 . DP=22;I16=11,10,0,0,814,31804,0,0,1229,72841,0,0,428,9518,0,0;QS=3,0;MQSB=0.927743;MQ0F=0 PL:DP:DV 0,27,240:9:0 0,15,159:5:0 0,21,222:7:0 +17 2796 . A 0 . DP=22;I16=11,10,0,0,762,28412,0,0,1229,72841,0,0,427,9475,0,0;QS=3,0;MQSB=0.927743;MQ0F=0 PL:DP:DV 0,27,221:9:0 0,15,156:5:0 0,21,211:7:0 +17 2797 . T 0 . DP=22;I16=12,10,0,0,792,29116,0,0,1289,76441,0,0,427,9451,0,0;QS=3,0;MQSB=0.924723;MQ0F=0 PL:DP:DV 0,30,243:10:0 0,15,148:5:0 0,21,214:7:0 +17 2798 . G 0 . DP=22;I16=12,10,0,0,817,31105,0,0,1289,76441,0,0,424,9394,0,0;QS=3,0;MQSB=0.924723;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,152:5:0 0,21,205:7:0 +17 2799 . A 0 . DP=21;I16=11,10,0,0,788,30210,0,0,1229,72841,0,0,421,9309,0,0;QS=3,0;MQSB=0.927743;MQ0F=0 PL:DP:DV 0,27,220:9:0 0,15,167:5:0 0,21,218:7:0 +17 2800 . A 0 . DP=21;I16=11,10,0,0,836,33616,0,0,1229,72841,0,0,418,9246,0,0;QS=3,0;MQSB=0.927743;MQ0F=0 PL:DP:DV 0,27,237:9:0 0,15,164:5:0 0,21,237:7:0 +17 2801 . G 0 . DP=21;I16=11,10,0,0,792,30182,0,0,1229,72841,0,0,415,9205,0,0;QS=3,0;MQSB=0.927743;MQ0F=0 PL:DP:DV 0,27,234:9:0 0,15,157:5:0 0,21,214:7:0 +17 2802 . G 0 . DP=21;I16=11,9,0,0,729,27275,0,0,1169,69241,0,0,387,8559,0,0;QS=3,0;MQSB=0.916401;MQ0F=0 PL:DP:DV 0,24,229:8:0 0,15,135:5:0 0,21,215:7:0 +17 2803 . G 0 . DP=21;I16=11,10,0,0,737,26709,0,0,1229,72841,0,0,406,9036,0,0;QS=3,0;MQSB=0.927743;MQ0F=0 PL:DP:DV 0,27,233:9:0 0,15,125:5:0 0,21,207:7:0 +17 2804 . G 0 . DP=21;I16=11,10,0,0,727,26103,0,0,1229,72841,0,0,400,8908,0,0;QS=3,0;MQSB=0.927743;MQ0F=0 PL:DP:DV 0,27,218:9:0 0,15,129:5:0 0,21,210:7:0 +17 2805 . C 0 . DP=21;I16=10,10,0,0,714,26194,0,0,1169,69241,0,0,372,8316,0,0;QS=3,0;MQSB=0.931063;MQ0F=0 PL:DP:DV 0,27,229:9:0 0,12,111:4:0 0,21,205:7:0 +17 2806 . C 0 . DP=20;I16=11,8,0,0,682,25074,0,0,1109,65641,0,0,379,8611,0,0;QS=3,0;MQSB=0.902014;MQ0F=0 PL:DP:DV 0,24,215:8:0 0,15,138:5:0 0,18,191:6:0 +17 2807 . T 0 . DP=20;I16=11,9,0,0,755,29373,0,0,1169,69241,0,0,384,8640,0,0;QS=3,0;MQSB=0.916401;MQ0F=0 PL:DP:DV 0,24,221:8:0 0,15,152:5:0 0,21,227:7:0 +17 2808 . T 0 . DP=20;I16=11,9,0,0,749,28383,0,0,1169,69241,0,0,379,8587,0,0;QS=3,0;MQSB=0.916401;MQ0F=0 PL:DP:DV 0,24,209:8:0 0,15,157:5:0 0,21,225:7:0 +17 2809 . T 0 . DP=20;I16=11,8,0,0,697,26019,0,0,1109,65641,0,0,349,7927,0,0;QS=3,0;MQSB=0.902014;MQ0F=0 PL:DP:DV 0,21,189:7:0 0,15,148:5:0 0,21,226:7:0 +17 2810 . C 0 . DP=20;I16=12,8,0,0,754,28900,0,0,1169,69241,0,0,368,8436,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,24,229:8:0 0,15,150:5:0 0,21,215:7:0 +17 2811 . A 0 . DP=19;I16=11,8,0,0,759,30405,0,0,1109,65641,0,0,364,8340,0,0;QS=3,0;MQSB=0.902014;MQ0F=0 PL:DP:DV 0,21,209:7:0 0,15,166:5:0 0,21,228:7:0 +17 2812 . G 0 . DP=20;I16=11,9,0,0,758,29062,0,0,1169,69241,0,0,359,8213,0,0;QS=3,0;MQSB=0.916401;MQ0F=0 PL:DP:DV 0,24,229:8:0 0,15,150:5:0 0,21,216:7:0 +17 2813 . A 0 . DP=19;I16=11,8,0,0,702,27106,0,0,1140,68400,0,0,356,8104,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,195:7:0 0,15,160:5:0 0,21,217:7:0 +17 2814 . G 0 . DP=19;I16=11,8,0,0,703,26579,0,0,1140,68400,0,0,353,8013,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,217:7:0 0,15,147:5:0 0,21,204:7:0 +17 2815 . A 0 . DP=19;I16=10,7,0,0,597,21979,0,0,1020,61200,0,0,326,7470,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,170:6:0 0,12,122:4:0 0,21,208:7:0 +17 2816 . C 0 . DP=19;I16=11,8,0,0,630,21880,0,0,1140,68400,0,0,343,7685,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,193:7:0 0,15,134:5:0 0,21,180:7:0 +17 2817 . G 0 . DP=20;I16=11,8,0,0,612,20368,0,0,1140,68400,0,0,339,7547,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,200:7:0 0,15,115:5:0 0,21,178:7:0 +17 2818 . G 0 . DP=20;I16=11,8,0,0,688,25280,0,0,1140,68400,0,0,335,7377,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,216:7:0 0,15,132:5:0 0,21,206:7:0 +17 2819 . G 0 . DP=20;I16=11,8,0,0,696,25880,0,0,1140,68400,0,0,331,7227,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,222:7:0 0,15,142:5:0 0,21,195:7:0 +17 2820 . G 0 . DP=20;I16=10,8,0,0,624,22228,0,0,1080,64800,0,0,320,7048,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,205:7:0 0,12,119:4:0 0,21,188:7:0 +17 2821 . A 0 . DP=20;I16=9,7,0,0,496,16222,0,0,960,57600,0,0,279,6157,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,159:6:0 0,9,93:3:0 0,21,171:7:0 +17 2822 . C 0 . DP=19;I16=8,9,0,0,543,18163,0,0,1020,61200,0,0,310,7064,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,203:7:0 0,9,79:3:0 0,21,168:7:0 +17 2823 . C 0 . DP=18;I16=9,7,0,0,550,19506,0,0,960,57600,0,0,300,6640,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,201:7:0 0,6,58:2:0 0,21,192:7:0 +17 2824 . C 0 . DP=18;I16=9,7,0,0,584,21560,0,0,960,57600,0,0,299,6567,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,219:8:0 0,3,37:1:0 0,21,210:7:0 +17 2825 . C 0 . DP=18;I16=9,8,0,0,606,22286,0,0,1020,61200,0,0,324,7134,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,234:8:0 0,3,37:1:0 0,24,208:8:0 +17 2826 . T 0 . DP=18;I16=9,8,0,0,604,21766,0,0,1020,61200,0,0,323,7043,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,222:8:0 0,3,33:1:0 0,24,220:8:0 +17 2827 . G 0 . DP=18;I16=9,8,0,0,597,21643,0,0,1020,61200,0,0,322,6970,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,230:8:0 0,3,28:1:0 0,24,214:8:0 +17 2828 . A 0 . DP=20;I16=9,9,0,0,598,20740,0,0,1080,64800,0,0,321,6915,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,213:9:0 0,3,36:1:0 0,24,219:8:0 +17 2829 . G 0 . DP=20;I16=9,9,0,0,649,23719,0,0,1080,64800,0,0,305,6591,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,239:8:0 0,3,31:1:0 0,27,227:9:0 +17 2830 . G 0 . DP=20;I16=9,10,0,0,661,23841,0,0,1140,68400,0,0,323,6867,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,248:9:0 0,3,34:1:0 0,27,222:9:0 +17 2831 . A 0 . DP=21;I16=10,10,0,0,682,24052,0,0,1200,72000,0,0,324,6876,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,223:9:0 0,3,34:1:0 0,30,254:10:0 +17 2832 . G 0 . DP=21;I16=10,8,0,0,626,22384,0,0,1080,64800,0,0,281,5883,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,230:8:0 0,3,31:1:0 0,27,223:9:0 +17 2833 . C 0 . DP=21;I16=10,10,0,0,712,25708,0,0,1200,72000,0,0,327,6915,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,233:9:0 0,3,37:1:0 0,30,255:10:0 +17 2834 . C 0 . DP=21;I16=10,9,0,0,674,24470,0,0,1140,68400,0,0,306,6464,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,230:8:0 0,3,36:1:0 0,30,243:10:0 +17 2835 . C 0 . DP=20;I16=9,9,0,0,617,21835,0,0,1080,64800,0,0,305,6381,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,202:8:0 0,3,39:1:0 0,27,235:9:0 +17 2836 . C 0 . DP=20;I16=9,9,0,0,580,19624,0,0,1080,64800,0,0,306,6412,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,206:8:0 0,3,39:1:0 0,27,200:9:0 +17 2837 . G 0 . DP=21;I16=9,10,0,0,558,17614,0,0,1140,68400,0,0,330,7086,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,207:9:0 0,3,31:1:0 0,27,193:9:0 +17 2838 . A 0 . DP=20;I16=9,10,0,0,640,22674,0,0,1140,68400,0,0,331,7065,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,245:9:0 0,3,17:1:0 0,27,220:9:0 +17 2839 . G 0 . DP=20;I16=9,8,0,0,623,23267,0,0,1020,61200,0,0,282,5816,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,248:8:0 0,3,26:1:0 0,24,212:8:0 +17 2840 . C 0 . DP=20;I16=9,10,0,0,644,22798,0,0,1140,68400,0,0,333,7089,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,233:9:0 0,3,32:1:0 0,27,227:9:0 +17 2841 . A 0 . DP=20;I16=9,9,0,0,675,25801,0,0,1080,64800,0,0,309,6509,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,252:9:0 0,3,35:1:0 0,24,234:8:0 +17 2842 . G 0 . DP=20;I16=9,10,0,0,688,25554,0,0,1140,68400,0,0,332,7056,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,3,31:1:0 0,27,233:9:0 +17 2843 . C 0 . DP=20;I16=8,10,0,0,651,23969,0,0,1080,64800,0,0,309,6517,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,0,0:0:0 0,24,211:8:0 +17 2844 . A 0 . DP=20;I16=8,11,0,0,685,25399,0,0,1140,68400,0,0,331,6969,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,0,0:0:0 0,27,231:9:0 +17 2845 . G 0 . DP=20;I16=8,10,0,0,673,25399,0,0,1080,64800,0,0,311,6561,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,0,0:0:0 0,24,228:8:0 +17 2846 . C 0 . DP=20;I16=8,10,0,0,617,22007,0,0,1080,64800,0,0,311,6577,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,243:10:0 0,0,0:0:0 0,24,218:8:0 +17 2847 . C 0 . DP=20;I16=7,11,0,0,580,19468,0,0,1080,64800,0,0,321,6917,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,241:10:0 0,0,0:0:0 0,24,187:8:0 +17 2848 . G 0 . DP=19;I16=7,10,0,0,542,17884,0,0,1020,61200,0,0,323,6999,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,218:9:0 0,0,0:0:0 0,24,191:8:0 +17 2849 . T 0 . DP=19;I16=7,11,0,0,609,21717,0,0,1080,64800,0,0,341,7357,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,231:9:0 0,0,0:0:0 0,27,214:9:0 +17 2850 . C 0 . DP=19;I16=7,11,0,0,574,18980,0,0,1080,64800,0,0,343,7461,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,234:9:0 0,0,0:0:0 0,27,188:9:0 +17 2851 . G 0 . DP=17;I16=6,11,0,0,589,20831,0,0,1020,61200,0,0,346,7584,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,239:9:0 0,0,0:0:0 0,24,194:8:0 +17 2852 . T 0 . DP=17;I16=6,11,0,0,625,23241,0,0,1020,61200,0,0,348,7676,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,244:9:0 0,0,0:0:0 0,24,214:8:0 +17 2853 . G 0 . DP=17;I16=6,11,0,0,635,23949,0,0,1020,61200,0,0,349,7739,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,0,0:0:0 0,24,202:8:0 +17 2854 . T 0 . DP=17;I16=6,11,0,0,602,21990,0,0,1020,61200,0,0,348,7722,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,238:9:0 0,0,0:0:0 0,24,207:8:0 +17 2855 . C 0 . DP=17;I16=6,10,0,0,577,21539,0,0,960,57600,0,0,337,7623,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,0,0:0:0 0,21,185:7:0 +17 2856 . T 0 . DP=17;I16=6,8,0,0,530,20570,0,0,840,50400,0,0,289,6507,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,252:9:0 0,0,0:0:0 0,15,167:5:0 +17 2857 . C 0 . DP=18;I16=6,10,0,0,577,21641,0,0,960,57600,0,0,336,7664,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,0,0:0:0 0,21,185:7:0 +17 2858 . A 0 . DP=19;I16=6,12,0,0,634,23006,0,0,1080,64800,0,0,355,8081,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,254:10:0 0,3,39:1:0 0,21,185:7:0 +17 2859 . C 0 . DP=19;I16=6,13,0,0,646,23056,0,0,1140,68400,0,0,361,8139,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,3,26:1:0 0,24,194:8:0 +17 2860 . C 0 . DP=19;I16=6,13,0,0,655,23687,0,0,1140,68400,0,0,360,8166,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,251:10:0 0,3,37:1:0 0,24,200:8:0 +17 2861 . C 0 . DP=20;I16=7,12,0,0,708,26756,0,0,1140,68400,0,0,333,7537,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,3,38:1:0 0,21,203:7:0 +17 2862 . A 0 . DP=20;I16=6,13,0,0,749,29753,0,0,1140,68400,0,0,332,7554,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,3,43:1:0 0,24,225:8:0 +17 2863 . G 0 . DP=19;I16=7,12,0,0,707,26901,0,0,1140,68400,0,0,356,8166,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,3,35:1:0 0,21,195:7:0 +17 2864 . G 0 . DP=19;I16=7,11,0,0,677,25833,0,0,1080,64800,0,0,352,8070,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,3,36:1:0 0,18,185:6:0 +17 2865 . G 0 . DP=19;I16=7,12,0,0,671,24569,0,0,1140,68400,0,0,350,7994,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,3,27:1:0 0,21,193:7:0 +17 2866 . T 0 . DP=18;I16=6,11,0,0,591,21071,0,0,1020,61200,0,0,338,7834,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,3,32:1:0 0,15,147:5:0 +17 2867 . G 0 . DP=18;I16=7,11,0,0,655,24279,0,0,1080,64800,0,0,347,7889,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,58:2:0 0,15,150:5:0 +17 2868 . T 0 . DP=18;I16=7,11,0,0,640,23702,0,0,1080,64800,0,0,347,7859,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,68:2:0 0,15,157:5:0 +17 2869 . C 0 . DP=18;I16=7,11,0,0,655,24737,0,0,1080,64800,0,0,346,7794,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,56:2:0 0,15,165:5:0 +17 2870 . T 0 . DP=18;I16=7,11,0,0,700,27480,0,0,1080,64800,0,0,345,7743,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,70:2:0 0,15,176:5:0 +17 2871 . G 0 . DP=18;I16=7,11,0,0,700,27554,0,0,1080,64800,0,0,344,7706,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,68:2:0 0,15,172:5:0 +17 2872 . A 0 . DP=18;I16=7,11,0,0,651,23869,0,0,1080,64800,0,0,343,7683,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,66:2:0 0,15,171:5:0 +17 2873 . A 0 . DP=18;I16=7,11,0,0,664,25000,0,0,1080,64800,0,0,342,7674,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,61:2:0 0,15,159:5:0 +17 2874 . A 0 . DP=18;I16=7,11,0,0,636,23286,0,0,1080,64800,0,0,341,7679,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,57:2:0 0,15,162:5:0 +17 2875 . C 0 . DP=18;I16=7,11,0,0,664,25148,0,0,1080,64800,0,0,340,7698,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,63:2:0 0,15,166:5:0 +17 2876 . A 0 . DP=18;I16=6,11,0,0,666,26684,0,0,1020,61200,0,0,314,7106,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,6,74:2:0 0,15,185:5:0 +17 2877 . G 0 . DP=17;I16=6,11,0,0,659,26009,0,0,1020,61200,0,0,339,7777,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,6,67:2:0 0,12,148:4:0 +17 2878 . A 0 . DP=17;I16=7,10,0,0,628,23656,0,0,1020,61200,0,0,340,7834,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,6,69:2:0 0,15,166:5:0 +17 2879 . T 0 . DP=18;I16=7,11,0,0,671,25359,0,0,1080,64800,0,0,342,7902,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,253:10:0 0,9,96:3:0 0,15,175:5:0 +17 2880 . G 0 . DP=19;I16=8,11,0,0,708,26694,0,0,1140,68400,0,0,345,7983,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,118:4:0 0,15,173:5:0 +17 2881 . T 0 . DP=19;I16=6,11,0,0,618,23304,0,0,1020,61200,0,0,299,6829,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,209:8:0 0,12,124:4:0 0,15,178:5:0 +17 2882 . G 0 . DP=19;I16=8,11,0,0,700,26464,0,0,1140,68400,0,0,353,8191,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,118:4:0 0,15,176:5:0 +17 2883 . G 0 . DP=19;I16=8,11,0,0,707,26939,0,0,1140,68400,0,0,357,8319,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,121:4:0 0,15,175:5:0 +17 2884 . A 0 . DP=19;I16=7,11,0,0,649,24531,0,0,1080,64800,0,0,335,7787,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,229:9:0 0,12,121:4:0 0,15,181:5:0 +17 2885 . G 0 . DP=19;I16=8,11,0,0,737,29253,0,0,1140,68400,0,0,362,8470,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,113:4:0 0,15,182:5:0 +17 2886 . G A, 0 . DP=18;I16=7,9,1,0,571,21281,20,400,960,57600,60,3600,334,7882,6,36;QS=2.76471,0.235294,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=1;BQB=1;MQ0F=0 PL:DP:DV 0,27,236,27,236,236:9:0 11,0,51,17,54,66:3:1 0,15,171,15,171,171:5:0 +17 2887 . T 0 . DP=19;I16=9,9,0,0,581,20407,0,0,1080,64800,0,0,341,7905,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,213:10:0 0,9,94:3:0 0,15,166:5:0 +17 2888 . C 0 . DP=20;I16=10,10,0,0,714,26630,0,0,1200,72000,0,0,368,8532,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,94:4:0 0,15,159:5:0 +17 2889 . T 0 . DP=19;I16=9,10,0,0,712,27106,0,0,1140,68400,0,0,372,8550,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,114:4:0 0,15,175:5:0 +17 2890 . C 0 . DP=19;I16=9,10,0,0,613,20711,0,0,1140,68400,0,0,376,8584,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,247:10:0 0,12,95:4:0 0,15,139:5:0 +17 2891 . G 0 . DP=20;I16=9,11,0,0,674,23754,0,0,1200,72000,0,0,380,8634,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,242:10:0 0,15,141:5:0 0,15,143:5:0 +17 2892 . G 0 . DP=21;I16=9,12,0,0,731,26677,0,0,1260,75600,0,0,385,8701,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,142:5:0 0,15,164:5:0 +17 2893 . G 0 . DP=21;I16=9,12,0,0,696,24498,0,0,1260,75600,0,0,389,8687,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,251:11:0 0,15,141:5:0 0,15,150:5:0 +17 2894 . T 0 . DP=21;I16=9,12,0,0,716,25490,0,0,1260,75600,0,0,393,8693,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,137:5:0 0,15,155:5:0 +17 2895 . G 0 . DP=22;I16=9,12,0,0,773,29225,0,0,1260,75600,0,0,372,8094,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,149:6:0 0,15,166:5:0 +17 2896 . A 0 . DP=22;I16=8,12,0,0,732,27684,0,0,1200,72000,0,0,361,7885,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,151:5:0 0,15,163:5:0 +17 2897 . G 0 . DP=22;I16=10,12,0,0,783,28783,0,0,1320,79200,0,0,407,8835,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,161:6:0 0,15,168:5:0 +17 2898 . G 0 . DP=22;I16=10,12,0,0,724,25596,0,0,1320,79200,0,0,412,8926,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,254:11:0 0,18,143:6:0 0,15,169:5:0 +17 2899 . C 0 . DP=22;I16=8,11,0,0,625,21143,0,0,1140,68400,0,0,356,7640,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,228:9:0 0,15,130:5:0 0,15,147:5:0 +17 2900 . G 0 . DP=24;I16=11,13,0,0,782,26700,0,0,1440,86400,0,0,420,9078,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,164:6:0 0,15,153:5:0 +17 2901 . T 0 . DP=24;I16=11,13,0,0,821,29195,0,0,1440,86400,0,0,426,9192,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,174:6:0 0,15,166:5:0 +17 2902 . G 0 . DP=24;I16=11,13,0,0,898,34176,0,0,1440,86400,0,0,432,9334,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,171:6:0 0,15,164:5:0 +17 2903 . G 0 . DP=24;I16=11,13,0,0,894,33764,0,0,1440,86400,0,0,437,9455,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,183:6:0 0,15,168:5:0 +17 2904 . C 0 . DP=24;I16=11,13,0,0,892,34010,0,0,1440,86400,0,0,440,9506,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,176:6:0 0,15,169:5:0 +17 2905 . T 0 . DP=25;I16=12,13,0,0,926,34994,0,0,1500,90000,0,0,442,9536,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,175:6:0 0,15,174:5:0 +17 2906 . C 0 . DP=25;I16=12,13,0,0,960,37070,0,0,1500,90000,0,0,444,9544,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,178:6:0 0,15,173:5:0 +17 2907 . A 0 . DP=25;I16=11,13,0,0,933,36707,0,0,1440,86400,0,0,429,9275,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,202:6:0 0,15,170:5:0 +17 2908 . G 0 . DP=25;I16=12,13,0,0,943,36315,0,0,1500,90000,0,0,446,9548,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,167:6:0 0,15,164:5:0 +17 2909 . A 0 . DP=25;I16=10,13,0,0,864,32764,0,0,1380,82800,0,0,425,9105,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,182:6:0 0,15,171:5:0 +17 2910 . T 0 . DP=25;I16=11,13,0,0,870,32054,0,0,1440,86400,0,0,447,9575,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,181:6:0 0,15,166:5:0 +17 2911 . A 0 . DP=25;I16=11,14,0,0,871,31227,0,0,1500,90000,0,0,473,10259,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,174:6:0 0,18,188:6:0 +17 2912 . C 0 . DP=24;I16=11,13,0,0,899,34121,0,0,1440,86400,0,0,474,10298,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,173:6:0 0,18,189:6:0 +17 2913 . A 0 . DP=24;I16=10,13,0,0,879,34357,0,0,1380,82800,0,0,449,9691,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,164:5:0 0,18,199:6:0 +17 2914 . G 0 . DP=24;I16=11,13,0,0,899,34575,0,0,1440,86400,0,0,472,10262,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,170:6:0 0,18,187:6:0 +17 2915 . G 0 . DP=24;I16=11,13,0,0,867,32523,0,0,1440,86400,0,0,470,10236,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,177:6:0 0,18,178:6:0 +17 2916 . G 0 . DP=24;I16=11,12,0,0,813,29935,0,0,1380,82800,0,0,443,9613,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,173:6:0 0,15,155:5:0 +17 2917 . A 0 . DP=25;I16=11,13,0,0,864,31926,0,0,1440,86400,0,0,459,10181,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,185:6:0 0,18,178:6:0 +17 2918 . G 0 . DP=25;I16=13,12,0,0,903,33489,0,0,1500,90000,0,0,462,10122,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,165:6:0 0,18,170:6:0 +17 2919 . T 0 . DP=25;I16=12,12,0,0,837,29647,0,0,1440,86400,0,0,443,9765,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,169:6:0 0,18,178:6:0 +17 2920 . G 0 . DP=25;I16=12,12,0,0,850,31266,0,0,1440,86400,0,0,433,9389,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,132:5:0 0,18,180:6:0 +17 2921 . G 0 . DP=25;I16=13,12,0,0,874,31518,0,0,1500,90000,0,0,455,9951,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,159:6:0 0,18,176:6:0 +17 2922 . C 0 . DP=26;I16=13,12,0,0,872,31374,0,0,1500,90000,0,0,438,9718,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,160:6:0 0,18,172:6:0 +17 2923 . C 0 . DP=26;I16=13,12,0,0,873,31687,0,0,1500,90000,0,0,437,9735,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,172:6:0 0,18,175:6:0 +17 2924 . C 0 . DP=25;I16=13,12,0,0,940,36016,0,0,1500,90000,0,0,449,9921,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,173:6:0 0,18,184:6:0 +17 2925 . A 0 . DP=25;I16=13,12,0,0,912,33580,0,0,1500,90000,0,0,448,9964,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,174:6:0 0,18,189:6:0 +17 2926 . C 0 . DP=25;I16=13,12,0,0,902,33224,0,0,1500,90000,0,0,445,9931,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,176:6:0 0,18,174:6:0 +17 2927 . A 0 . DP=25;I16=12,12,0,0,896,33828,0,0,1440,86400,0,0,417,9295,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,162:5:0 0,18,191:6:0 +17 2928 . G 0 . DP=24;I16=13,11,0,0,862,32078,0,0,1440,86400,0,0,440,9930,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,170:6:0 0,18,161:6:0 +17 2929 . C 0 . DP=23;I16=13,9,0,0,794,29716,0,0,1320,79200,0,0,430,9878,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,153:5:0 0,15,149:5:0 +17 2930 . T 0 . DP=23;I16=13,10,0,0,822,30260,0,0,1380,82800,0,0,438,10006,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,168:6:0 0,15,157:5:0 +17 2931 . C 0 . DP=23;I16=13,10,0,0,803,28963,0,0,1380,82800,0,0,436,10020,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,162:6:0 0,15,140:5:0 +17 2932 . G 0 . DP=22;I16=12,10,0,0,728,25158,0,0,1320,79200,0,0,435,10049,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,171:6:0 0,12,117:4:0 +17 2933 . G 0 . DP=22;I16=11,10,0,0,760,28336,0,0,1260,75600,0,0,430,10034,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,175:6:0 0,12,116:4:0 +17 2934 . C 0 . DP=21;I16=12,9,0,0,759,28241,0,0,1260,75600,0,0,432,10052,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,161:6:0 0,9,104:3:0 +17 2935 . C 0 . DP=21;I16=12,9,0,0,766,28494,0,0,1260,75600,0,0,431,10075,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,178:6:0 0,9,94:3:0 +17 2936 . T 0 . DP=21;I16=11,9,0,0,760,29284,0,0,1200,72000,0,0,429,10063,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,188:6:0 0,9,98:3:0 +17 2937 . G 0 . DP=20;I16=11,9,0,0,728,27374,0,0,1200,72000,0,0,428,10066,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,177:6:0 0,9,79:3:0 +17 2938 . T 0 . DP=20;I16=11,9,0,0,719,26217,0,0,1200,72000,0,0,427,10083,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,188:6:0 0,9,101:3:0 +17 2939 . C 0 . DP=19;I16=11,8,0,0,729,28277,0,0,1140,68400,0,0,427,10113,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,163:5:0 0,9,106:3:0 +17 2940 . T 0 . DP=19;I16=11,8,0,0,739,29133,0,0,1140,68400,0,0,427,10155,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,171:5:0 0,9,109:3:0 +17 2941 . T 0 . DP=19;I16=11,8,0,0,702,26358,0,0,1140,68400,0,0,427,10209,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,170:5:0 0,9,99:3:0 +17 2942 . T 0 . DP=19;I16=11,8,0,0,695,25671,0,0,1140,68400,0,0,427,10275,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,169:5:0 0,9,100:3:0 +17 2943 . G 0 . DP=18;I16=11,6,0,0,621,23187,0,0,1020,61200,0,0,401,9627,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,228:9:0 0,15,170:5:0 0,9,86:3:0 +17 2944 . A 0 . DP=18;I16=10,7,0,0,642,24406,0,0,1020,61200,0,0,399,9563,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,239:9:0 0,15,168:5:0 0,9,111:3:0 +17 2945 . A 0 . DP=18;I16=11,7,0,0,637,23199,0,0,1080,64800,0,0,422,10132,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,242:10:0 0,15,152:5:0 0,9,107:3:0 +17 2946 . A 0 . DP=18;I16=11,7,0,0,692,26794,0,0,1080,64800,0,0,420,10084,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,174:5:0 0,9,108:3:0 +17 2947 . G 0 . DP=18;I16=11,7,0,0,639,23329,0,0,1080,64800,0,0,418,10044,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,160:5:0 0,9,78:3:0 +17 2948 . G 0 . DP=19;I16=11,8,0,0,702,26272,0,0,1140,68400,0,0,415,9961,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,163:5:0 0,12,116:4:0 +17 2949 . C 0 . DP=19;I16=10,8,0,0,657,24565,0,0,1080,64800,0,0,388,9260,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,125:4:0 0,12,124:4:0 +17 2950 . C 0 . DP=19;I16=11,8,0,0,667,24359,0,0,1140,68400,0,0,411,9817,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,131:5:0 0,12,115:4:0 +17 2951 . A 0 . DP=20;I16=11,8,0,0,682,24956,0,0,1140,68400,0,0,409,9757,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,250:10:0 0,15,149:5:0 0,12,133:4:0 +17 2952 . C 0 . DP=20;I16=11,9,0,0,647,21709,0,0,1200,72000,0,0,408,9706,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,128:5:0 0,12,112:4:0 +17 2953 . G 0 . DP=21;I16=11,9,0,0,620,19954,0,0,1200,72000,0,0,407,9665,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,237:11:0 0,15,132:5:0 0,12,111:4:0 +17 2954 . T 0 . DP=21;I16=11,10,0,0,742,26662,0,0,1260,75600,0,0,414,9666,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,175:6:0 0,12,135:4:0 +17 2955 . G 0 . DP=22;I16=11,11,0,0,787,28475,0,0,1320,79200,0,0,412,9568,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,170:6:0 0,12,127:4:0 +17 2956 . A 0 . DP=22;I16=11,11,0,0,747,26449,0,0,1320,79200,0,0,410,9438,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,161:6:0 0,12,125:4:0 +17 2957 . C 0 . DP=22;I16=10,10,0,0,693,24757,0,0,1200,72000,0,0,358,8078,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,143:6:0 0,9,104:3:0 +17 2958 . C 0 . DP=21;I16=11,10,0,0,784,29744,0,0,1260,75600,0,0,407,9237,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,172:6:0 0,12,135:4:0 +17 2959 . T 0 . DP=21;I16=11,10,0,0,791,30411,0,0,1260,75600,0,0,406,9164,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,182:6:0 0,12,139:4:0 +17 2960 . G 0 . DP=21;I16=11,10,0,0,778,29502,0,0,1260,75600,0,0,405,9109,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,178:6:0 0,12,126:4:0 +17 2961 . G 0 . DP=20;I16=10,9,0,0,657,23303,0,0,1140,68400,0,0,380,8446,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,231:10:0 0,18,176:6:0 0,9,111:3:0 +17 2962 . C 0 . DP=21;I16=10,10,0,0,731,27459,0,0,1200,72000,0,0,385,8615,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,151:5:0 0,12,132:4:0 +17 2963 . C 0 . DP=21;I16=10,10,0,0,722,26502,0,0,1200,72000,0,0,378,8274,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,169:6:0 0,9,100:3:0 +17 2964 . C 0 . DP=22;I16=11,10,0,0,752,27740,0,0,1260,75600,0,0,379,8275,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,148:5:0 0,15,151:5:0 +17 2965 . A 0 . DP=22;I16=11,11,0,0,804,29606,0,0,1320,79200,0,0,397,8539,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,176:6:0 0,15,155:5:0 +17 2966 . C 0 . DP=22;I16=11,11,0,0,705,23557,0,0,1320,79200,0,0,396,8468,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,254:11:0 0,18,146:6:0 0,15,142:5:0 +17 2967 . G 0 . DP=24;I16=11,13,0,0,767,25405,0,0,1440,86400,0,0,393,8325,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,162:6:0 0,18,135:6:0 +17 2968 . G 0 . DP=23;I16=11,12,0,0,812,29824,0,0,1380,82800,0,0,393,8213,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,152:5:0 0,18,162:6:0 +17 2969 . C 0 . DP=23;I16=11,12,0,0,866,32982,0,0,1380,82800,0,0,393,8133,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,151:5:0 0,18,181:6:0 +17 2970 . T 0 . DP=24;I16=11,12,0,0,816,29806,0,0,1380,82800,0,0,393,8085,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,154:5:0 0,18,189:6:0 +17 2971 . G 0 . DP=24;I16=12,12,0,0,878,33010,0,0,1440,86400,0,0,392,7970,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,173:6:0 0,18,184:6:0 +17 2972 . G 0 . DP=24;I16=12,12,0,0,839,30363,0,0,1440,86400,0,0,391,7889,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,175:6:0 0,18,161:6:0 +17 2973 . C 0 . DP=24;I16=12,12,0,0,854,31154,0,0,1440,86400,0,0,390,7842,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,177:6:0 0,18,165:6:0 +17 2974 . A 0 . DP=24;I16=12,12,0,0,869,32231,0,0,1440,86400,0,0,388,7778,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,169:6:0 0,18,174:6:0 +17 2975 . G 0 . DP=24;I16=12,12,0,0,857,31835,0,0,1440,86400,0,0,384,7648,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,173:6:0 0,18,167:6:0 +17 2976 . G 0 . DP=25;I16=13,12,0,0,866,31118,0,0,1500,90000,0,0,380,7554,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,180:7:0 0,18,171:6:0 +17 2977 . T 0 . DP=26;I16=13,12,0,0,760,25216,0,0,1469,87241,0,0,373,7437,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,151:6:0 0,18,155:6:0 +17 2978 . G 0 . DP=25;I16=12,12,0,0,862,31574,0,0,1409,83641,0,0,362,7290,0,0;QS=3,0;MQSB=0.941765;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,168:6:0 0,18,167:6:0 +17 2979 . G 0 . DP=24;I16=12,12,0,0,816,28440,0,0,1409,83641,0,0,370,7340,0,0;QS=3,0;MQSB=0.941765;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,164:6:0 0,15,142:5:0 +17 2980 . G 0 . DP=23;I16=12,11,0,0,834,30882,0,0,1349,80041,0,0,369,7293,0,0;QS=3,0;MQSB=0.944319;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,144:5:0 0,15,148:5:0 +17 2981 . A 0 . DP=23;I16=9,11,0,0,622,20306,0,0,1169,69241,0,0,318,6244,0,0;QS=3,0;MQSB=0.916401;MQ0F=0 PL:DP:DV 0,30,201:10:0 0,15,145:5:0 0,15,150:5:0 +17 2982 . C 0 . DP=23;I16=10,11,0,0,706,24366,0,0,1229,72841,0,0,340,6884,0,0;QS=3,0;MQSB=0.927743;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,93:3:0 0,15,144:5:0 +17 2983 . C 0 . DP=23;I16=12,11,0,0,781,27427,0,0,1349,80041,0,0,363,7197,0,0;QS=3,0;MQSB=0.944319;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,137:5:0 0,15,142:5:0 +17 2984 . C 0 . DP=23;I16=12,11,0,0,861,32655,0,0,1349,80041,0,0,361,7229,0,0;QS=3,0;MQSB=0.944319;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,154:5:0 0,15,157:5:0 +17 2985 . A 0 . DP=23;I16=12,11,0,0,798,28906,0,0,1349,80041,0,0,359,7293,0,0;QS=3,0;MQSB=0.944319;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,161:5:0 0,15,151:5:0 +17 2986 . G 0 . DP=21;I16=11,10,0,0,701,24335,0,0,1229,72841,0,0,358,7388,0,0;QS=3,0;MQSB=0.939898;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,129:5:0 0,12,126:4:0 +17 2987 . C 0 . DP=21;I16=10,10,0,0,720,26782,0,0,1169,69241,0,0,350,7448,0,0;QS=3,0;MQSB=0.931063;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,136:4:0 0,12,132:4:0 +17 2988 . T 0 . DP=20;I16=10,10,0,0,693,25143,0,0,1169,69241,0,0,358,7612,0,0;QS=3,0;MQSB=0.931063;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,132:5:0 0,12,136:4:0 +17 2989 . G 0 . DP=20;I16=10,10,0,0,708,25886,0,0,1169,69241,0,0,358,7736,0,0;QS=3,0;MQSB=0.931063;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,141:5:0 0,12,125:4:0 +17 2990 . C 0 . DP=20;I16=10,10,0,0,697,25083,0,0,1169,69241,0,0,357,7833,0,0;QS=3,0;MQSB=0.931063;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,149:5:0 0,12,129:4:0 +17 2991 . A 0 . DP=20;I16=10,10,0,0,717,26309,0,0,1169,69241,0,0,356,7952,0,0;QS=3,0;MQSB=0.931063;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,151:5:0 0,12,131:4:0 +17 2992 . G 0 . DP=18;I16=10,8,0,0,625,22505,0,0,1049,62041,0,0,356,8042,0,0;QS=3,0;MQSB=0.938795;MQ0F=0 PL:DP:DV 0,30,243:10:0 0,12,130:4:0 0,12,120:4:0 +17 2993 . G 0 . DP=18;I16=10,8,0,0,646,23620,0,0,1049,62041,0,0,354,8050,0,0;QS=3,0;MQSB=0.938795;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,118:4:0 0,12,123:4:0 +17 2994 . G 0 . DP=18;I16=10,8,0,0,620,21828,0,0,1049,62041,0,0,351,8025,0,0;QS=3,0;MQSB=0.938795;MQ0F=0 PL:DP:DV 0,30,254:10:0 0,12,115:4:0 0,12,116:4:0 +17 2995 . G 0 . DP=18;I16=10,8,0,0,628,22284,0,0,1049,62041,0,0,348,8018,0,0;QS=3,0;MQSB=0.938795;MQ0F=0 PL:DP:DV 0,30,248:10:0 0,12,110:4:0 0,12,135:4:0 +17 2996 . T 0 . DP=17;I16=8,8,0,0,497,16697,0,0,929,54841,0,0,323,7493,0,0;QS=3,0;MQSB=0.915545;MQ0F=0 PL:DP:DV 0,30,215:10:0 0,9,75:3:0 0,9,107:3:0 +17 2997 . C 0 . DP=17;I16=9,8,0,0,603,21925,0,0,989,58441,0,0,341,7901,0,0;QS=3,0;MQSB=0.928603;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,85:3:0 0,12,115:4:0 +17 2998 . C 0 . DP=17;I16=9,8,0,0,576,19964,0,0,989,58441,0,0,337,7841,0,0;QS=3,0;MQSB=0.928603;MQ0F=0 PL:DP:DV 0,30,247:10:0 0,9,84:3:0 0,12,123:4:0 +17 2999 . A 0 . DP=17;I16=9,8,0,0,599,22077,0,0,989,58441,0,0,333,7797,0,0;QS=3,0;MQSB=0.928603;MQ0F=0 PL:DP:DV 0,30,238:10:0 0,9,109:3:0 0,12,136:4:0 +17 3000 . G 0 . DP=15;I16=8,7,0,0,554,20620,0,0,869,51241,0,0,331,7767,0,0;QS=3,0;MQSB=0.921243;MQ0F=0 PL:DP:DV 0,24,220:8:0 0,9,102:3:0 0,12,135:4:0 +17 3001 . C 0 . DP=15;I16=7,7,0,0,521,19695,0,0,809,47641,0,0,309,7349,0,0;QS=3,0;MQSB=0.885987;MQ0F=0 PL:DP:DV 0,21,213:7:0 0,9,103:3:0 0,12,128:4:0 +17 3002 . A 0 . DP=15;I16=8,7,0,0,542,20082,0,0,869,51241,0,0,326,7692,0,0;QS=3,0;MQSB=0.921243;MQ0F=0 PL:DP:DV 0,24,224:8:0 0,9,92:3:0 0,12,139:4:0 +17 3003 . G 0 . DP=15;I16=8,7,0,0,540,19814,0,0,869,51241,0,0,322,7594,0,0;QS=3,0;MQSB=0.921243;MQ0F=0 PL:DP:DV 0,24,230:8:0 0,9,96:3:0 0,12,120:4:0 +17 3004 . C 0 . DP=15;I16=8,7,0,0,525,19113,0,0,869,51241,0,0,318,7504,0,0;QS=3,0;MQSB=0.921243;MQ0F=0 PL:DP:DV 0,24,211:8:0 0,9,100:3:0 0,12,129:4:0 +17 3005 . A 0 . DP=14;I16=7,7,0,0,491,17343,0,0,809,47641,0,0,315,7421,0,0;QS=3,0;MQSB=0.885987;MQ0F=0 PL:DP:DV 0,21,197:7:0 0,9,95:3:0 0,12,124:4:0 +17 3006 . C 0 . DP=16;I16=7,8,0,0,516,18376,0,0,869,51241,0,0,312,7344,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,24,200:8:0 0,9,95:3:0 0,12,135:4:0 +17 3007 . C 0 . DP=16;I16=7,8,0,0,553,20853,0,0,869,51241,0,0,310,7274,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,24,214:8:0 0,9,103:3:0 0,12,144:4:0 +17 3008 . C 0 . DP=16;I16=7,8,0,0,576,22238,0,0,869,51241,0,0,308,7212,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,24,228:8:0 0,9,105:3:0 0,12,145:4:0 +17 3009 . A 0 . DP=16;I16=7,8,0,0,493,16739,0,0,869,51241,0,0,306,7158,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,24,200:8:0 0,9,83:3:0 0,12,130:4:0 +17 3010 . C 0 . DP=15;I16=7,7,0,0,534,20464,0,0,809,47641,0,0,300,7096,0,0;QS=3,0;MQSB=0.885987;MQ0F=0 PL:DP:DV 0,21,211:7:0 0,9,106:3:0 0,12,135:4:0 +17 3011 . A 0 . DP=16;I16=7,8,0,0,559,21173,0,0,869,51241,0,0,302,7074,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,24,218:8:0 0,9,104:3:0 0,12,145:4:0 +17 3012 . G 0 . DP=16;I16=7,8,0,0,503,17903,0,0,869,51241,0,0,300,7044,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,24,193:8:0 0,9,93:3:0 0,12,141:4:0 +17 3013 . C 0 . DP=16;I16=7,9,0,0,549,19967,0,0,898,52082,0,0,305,7071,0,0;QS=3,0;MQSB=0.994413;MQ0F=0 PL:DP:DV 0,27,207:9:0 0,9,98:3:0 0,12,141:4:0 +17 3014 . A 0 . DP=18;I16=6,9,0,0,542,20362,0,0,838,48482,0,0,289,6959,0,0;QS=3,0;MQSB=0.984496;MQ0F=0 PL:DP:DV 0,24,195:8:0 0,9,109:3:0 0,12,141:4:0 +17 3015 . G 0 . DP=20;I16=7,9,0,0,549,19441,0,0,929,54841,0,0,311,7547,0,0;QS=3,0;MQSB=0.892753;MQ0F=0 PL:DP:DV 0,24,206:8:0 0,12,116:4:0 0,12,131:4:0 +17 3016 . C 0 . DP=20;I16=7,13,0,0,690,24374,0,0,1138,66482,0,0,337,7783,0,0;QS=3,0;MQSB=0.972138;MQ0F=0 PL:DP:DV 0,33,248:11:0 0,15,136:5:0 0,12,132:4:0 +17 3017 . C A, 0 . DP=20;I16=7,12,0,1,650,23264,23,529,1109,65641,29,841,329,7715,11,121;QS=2.93801,0.0619946,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.972138;BQB=1;MQ0F=0 PL:DP:DV 0,10,224,30,227,236:11:1 0,15,133,15,133,133:5:0 0,12,128,12,128,128:4:0 +17 3018 . A 0 . DP=21;I16=6,10,0,0,475,15057,0,0,929,54841,0,0,295,6991,0,0;QS=3,0;MQSB=0.863243;MQ0F=0 PL:DP:DV 0,27,192:9:0 0,12,111:4:0 0,9,81:3:0 +17 3019 . C 0 . DP=20;I16=6,12,0,0,618,21842,0,0,1049,62041,0,0,336,7818,0,0;QS=3,0;MQSB=0.85394;MQ0F=0 PL:DP:DV 0,30,242:10:0 0,15,129:5:0 0,9,104:3:0 +17 3020 . C 0 . DP=20;I16=6,12,0,0,588,21046,0,0,1049,62041,0,0,340,7888,0,0;QS=3,0;MQSB=0.85394;MQ0F=0 PL:DP:DV 0,30,221:10:0 0,15,129:5:0 0,9,114:3:0 +17 3021 . T 0 . DP=21;I16=5,13,0,0,618,22454,0,0,1049,62041,0,0,343,7921,0,0;QS=3,0;MQSB=0.814433;MQ0F=0 PL:DP:DV 0,30,216:10:0 0,15,147:5:0 0,9,109:3:0 +17 3022 . G 0 . DP=20;I16=5,13,0,0,672,25292,0,0,1049,62041,0,0,348,7968,0,0;QS=3,0;MQSB=0.814433;MQ0F=0 PL:DP:DV 0,30,234:10:0 0,15,153:5:0 0,9,109:3:0 +17 3023 . T G, 0 . DP=20;I16=5,12,0,1,554,19110,18,324,989,58441,60,3600,336,7740,17,289;QS=2.94231,0.0576923,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.814433;BQB=1;MQ0F=0 PL:DP:DV 0,12,191,27,194,199:10:1 0,15,125,15,125,125:5:0 0,9,111,9,111,111:3:0 +17 3024 . G 0 . DP=20;I16=5,14,0,0,684,25122,0,0,1109,65641,0,0,382,8680,0,0;QS=3,0;MQSB=0.810584;MQ0F=0 PL:DP:DV 0,30,235:10:0 0,18,152:6:0 0,9,113:3:0 +17 3025 . G 0 . DP=20;I16=5,14,0,0,625,21465,0,0,1109,65641,0,0,386,8722,0,0;QS=3,0;MQSB=0.810584;MQ0F=0 PL:DP:DV 0,30,225:10:0 0,18,133:6:0 0,9,109:3:0 +17 3026 . C 0 . DP=20;I16=5,13,0,0,632,23132,0,0,1018,59282,0,0,367,8217,0,0;QS=3,0;MQSB=0.925212;MQ0F=0 PL:DP:DV 0,33,235:11:0 0,12,105:4:0 0,9,107:3:0 +17 3027 . A 0 . DP=21;I16=6,15,0,0,693,24199,0,0,1198,70082,0,0,413,9199,0,0;QS=3,0;MQSB=0.940481;MQ0F=0 PL:DP:DV 0,33,222:11:0 0,21,175:7:0 0,9,108:3:0 +17 3028 . G 0 . DP=21;I16=6,15,0,0,753,27935,0,0,1198,70082,0,0,417,9239,0,0;QS=3,0;MQSB=0.940481;MQ0F=0 PL:DP:DV 0,33,241:11:0 0,21,192:7:0 0,9,107:3:0 +17 3029 . G 0 . DP=21;I16=6,15,0,0,787,29949,0,0,1198,70082,0,0,421,9303,0,0;QS=3,0;MQSB=0.940481;MQ0F=0 PL:DP:DV 0,33,251:11:0 0,21,189:7:0 0,9,109:3:0 +17 3030 . G 0 . DP=22;I16=6,16,0,0,720,24728,0,0,1258,73682,0,0,424,9342,0,0;QS=3,0;MQSB=0.934321;MQ0F=0 PL:DP:DV 0,36,229:12:0 0,21,174:7:0 0,9,106:3:0 +17 3031 . A 0 . DP=22;I16=5,16,0,0,693,24631,0,0,1198,70082,0,0,403,8783,0,0;QS=3,0;MQSB=0.902014;MQ0F=0 PL:DP:DV 0,36,222:12:0 0,18,162:6:0 0,9,113:3:0 +17 3032 . G 0 . DP=22;I16=6,15,0,0,727,26093,0,0,1229,72841,0,0,405,8775,0,0;QS=3,0;MQSB=0.843281;MQ0F=0 PL:DP:DV 0,33,237:11:0 0,21,180:7:0 0,9,106:3:0 +17 3033 . G 0 . DP=22;I16=6,15,0,0,697,24039,0,0,1198,70082,0,0,429,9407,0,0;QS=3,0;MQSB=0.940481;MQ0F=0 PL:DP:DV 0,33,235:11:0 0,21,160:7:0 0,9,106:3:0 +17 3034 . A 0 . DP=23;I16=6,14,0,0,617,20947,0,0,1138,66482,0,0,387,8491,0,0;QS=3,0;MQSB=0.947033;MQ0F=0 PL:DP:DV 0,33,203:11:0 0,15,134:5:0 0,12,126:4:0 +17 3035 . G 0 . DP=23;I16=7,13,0,0,641,22007,0,0,1138,66482,0,0,385,8379,0,0;QS=3,0;MQSB=0.972138;MQ0F=0 PL:DP:DV 0,30,208:10:0 0,18,151:6:0 0,12,128:4:0 +17 3036 . C 0 . DP=23;I16=6,15,0,0,688,23652,0,0,1198,70082,0,0,388,8258,0,0;QS=3,0;MQSB=0.940481;MQ0F=0 PL:DP:DV 0,36,216:12:0 0,15,132:5:0 0,12,140:4:0 +17 3037 . T 0 . DP=24;I16=7,16,0,0,797,28671,0,0,1318,77282,0,0,439,9521,0,0;QS=3,0;MQSB=0.955805;MQ0F=0 PL:DP:DV 0,36,242:12:0 0,21,170:7:0 0,12,143:4:0 +17 3038 . T 0 . DP=25;I16=8,17,0,0,815,27469,0,0,1438,84482,0,0,441,9561,0,0;QS=3,0;MQSB=0.966223;MQ0F=0 PL:DP:DV 0,42,249:14:0 0,21,190:7:0 0,12,125:4:0 +17 3039 . G 0 . DP=25;I16=8,17,0,0,780,25946,0,0,1438,84482,0,0,444,9630,0,0;QS=3,0;MQSB=0.966223;MQ0F=0 PL:DP:DV 0,42,249:14:0 0,21,156:7:0 0,12,127:4:0 +17 3040 . T 0 . DP=25;I16=7,15,0,0,701,23777,0,0,1258,73682,0,0,385,8279,0,0;QS=3,0;MQSB=0.961028;MQ0F=0 PL:DP:DV 0,36,239:12:0 0,18,154:6:0 0,12,130:4:0 +17 3041 . G 0 . DP=25;I16=8,16,0,0,824,29228,0,0,1378,80882,0,0,420,8982,0,0;QS=3,0;MQSB=0.970446;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,186:7:0 0,12,135:4:0 +17 3042 . G 0 . DP=25;I16=8,15,0,0,795,28227,0,0,1349,80041,0,0,409,8839,0,0;QS=3,0;MQSB=0.889418;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,148:6:0 0,12,120:4:0 +17 3043 . T 0 . DP=25;I16=8,16,0,0,723,23191,0,0,1378,80882,0,0,435,9415,0,0;QS=3,0;MQSB=0.970446;MQ0F=0 PL:DP:DV 0,39,233:13:0 0,21,151:7:0 0,12,124:4:0 +17 3044 . A C, 0 . DP=26;I16=8,15,0,1,665,20809,15,225,1318,77282,60,3600,392,8498,14,196;QS=2.96104,0.038961,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.970446;BQB=1;MQ0F=0 PL:DP:DV 0,26,216,39,219,220:14:1 0,18,133,18,133,133:6:0 0,12,124,12,124,124:4:0 +17 3045 . C 0 . DP=26;I16=8,16,0,0,754,25232,0,0,1378,80882,0,0,403,8627,0,0;QS=3,0;MQSB=0.970446;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,133:6:0 0,12,122:4:0 +17 3046 . A 0 . DP=25;I16=8,15,0,0,748,26170,0,0,1349,80041,0,0,400,8540,0,0;QS=3,0;MQSB=0.889418;MQ0F=0 PL:DP:DV 0,39,245:13:0 0,18,160:6:0 0,12,141:4:0 +17 3047 . G 0 . DP=25;I16=8,15,0,0,766,26998,0,0,1318,77282,0,0,396,8432,0,0;QS=3,0;MQSB=0.974802;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,143:6:0 0,12,129:4:0 +17 3048 . T 0 . DP=25;I16=8,11,0,0,608,20554,0,0,1109,65641,0,0,320,6762,0,0;QS=3,0;MQSB=0.902014;MQ0F=0 PL:DP:DV 0,30,226:10:0 0,15,128:5:0 0,12,129:4:0 +17 3049 . G 0 . DP=24;I16=8,16,0,0,831,29557,0,0,1378,80882,0,0,426,9068,0,0;QS=3,0;MQSB=0.970446;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,161:6:0 0,9,105:3:0 +17 3050 . G 0 . DP=24;I16=8,14,0,0,729,25093,0,0,1258,73682,0,0,379,8041,0,0;QS=3,0;MQSB=0.979255;MQ0F=0 PL:DP:DV 0,39,253:13:0 0,18,159:6:0 0,9,100:3:0 +17 3051 . A 0 . DP=23;I16=8,15,0,0,724,24200,0,0,1318,77282,0,0,423,9091,0,0;QS=3,0;MQSB=0.974802;MQ0F=0 PL:DP:DV 0,42,243:14:0 0,18,152:6:0 0,9,103:3:0 +17 3052 . C 0 . DP=23;I16=7,13,0,0,612,19876,0,0,1169,69241,0,0,363,7779,0,0;QS=3,0;MQSB=0.962269;MQ0F=0 PL:DP:DV 0,36,226:12:0 0,15,117:5:0 0,9,93:3:0 +17 3053 . A 0 . DP=22;I16=8,11,0,0,616,21288,0,0,1078,62882,0,0,360,7740,0,0;QS=3,0;MQSB=0.992359;MQ0F=0 PL:DP:DV 0,33,234:11:0 0,15,118:5:0 0,9,110:3:0 +17 3054 . G 0 . DP=22;I16=8,14,0,0,761,27617,0,0,1258,73682,0,0,414,8932,0,0;QS=3,0;MQSB=0.979255;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,126:5:0 0,9,99:3:0 +17 3055 . G 0 . DP=22;I16=8,9,0,0,566,19890,0,0,958,55682,0,0,333,7219,0,0;QS=3,0;MQSB=0.998843;MQ0F=0 PL:DP:DV 0,30,228:10:0 0,12,111:4:0 0,9,105:3:0 +17 3056 . C 0 . DP=22;I16=7,14,0,0,701,24685,0,0,1198,70082,0,0,420,9298,0,0;QS=3,0;MQSB=0.966484;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,125:4:0 0,12,122:4:0 +17 3057 . C 0 . DP=23;I16=8,13,0,0,706,24988,0,0,1198,70082,0,0,411,9253,0,0;QS=3,0;MQSB=0.983744;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,128:5:0 0,9,92:3:0 +17 3058 . C 0 . DP=23;I16=9,14,0,0,707,23327,0,0,1318,77282,0,0,429,9471,0,0;QS=3,0;MQSB=0.987676;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,131:5:0 0,12,116:4:0 +17 3059 . T G, 0 . DP=23;I16=9,11,0,1,638,21954,16,256,1169,69241,60,3600,355,7761,22,484;QS=2.95876,0.0412371,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.913101;BQB=1;MQ0F=0 PL:DP:DV 0,22,234,36,237,239:13:1 0,15,144,15,144,144:5:0 0,9,94,9,94,94:3:0 +17 3060 . G 0 . DP=24;I16=9,10,0,0,578,19136,0,0,1109,65641,0,0,324,6992,0,0;QS=3,0;MQSB=0.920044;MQ0F=0 PL:DP:DV 0,33,221:11:0 0,12,121:4:0 0,12,116:4:0 +17 3061 . C 0 . DP=24;I16=9,15,0,0,770,25918,0,0,1378,80882,0,0,446,10136,0,0;QS=3,0;MQSB=0.984127;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,138:5:0 0,15,145:5:0 +17 3062 . C 0 . DP=23;I16=9,13,0,0,727,25019,0,0,1289,76441,0,0,419,9551,0,0;QS=3,0;MQSB=0.910098;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,137:5:0 0,15,134:5:0 +17 3063 . C 0 . DP=23;I16=9,13,0,0,651,21695,0,0,1258,73682,0,0,415,9511,0,0;QS=3,0;MQSB=0.991121;MQ0F=0 PL:DP:DV 0,36,233:12:0 0,15,130:5:0 0,15,133:5:0 +17 3064 . A 0 . DP=23;I16=9,12,0,0,691,24125,0,0,1198,70082,0,0,385,8815,0,0;QS=3,0;MQSB=0.994334;MQ0F=0 PL:DP:DV 0,36,254:12:0 0,12,118:4:0 0,15,144:5:0 +17 3065 . G 0 . DP=22;I16=7,14,0,0,653,21733,0,0,1198,70082,0,0,426,9986,0,0;QS=3,0;MQSB=0.966484;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,109:4:0 0,12,118:4:0 +17 3066 . A 0 . DP=21;I16=7,10,0,0,501,16143,0,0,989,58441,0,0,326,7598,0,0;QS=3,0;MQSB=0.887766;MQ0F=0 PL:DP:DV 0,27,202:9:0 0,12,109:4:0 0,12,104:4:0 +17 3067 . T 0 . DP=21;I16=7,12,0,0,535,16779,0,0,1078,62882,0,0,373,8787,0,0;QS=3,0;MQSB=0.977926;MQ0F=0 PL:DP:DV 0,36,223:12:0 0,9,82:3:0 0,12,103:4:0 +17 3068 . G 0 . DP=20;I16=7,12,0,0,645,22781,0,0,1109,65641,0,0,396,9312,0,0;QS=3,0;MQSB=0.879351;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,115:4:0 0,9,84:3:0 +17 3069 . G 0 . DP=20;I16=7,10,0,0,468,14412,0,0,989,58441,0,0,346,8070,0,0;QS=3,0;MQSB=0.887766;MQ0F=0 PL:DP:DV 0,33,203:11:0 0,12,102:4:0 0,6,57:2:0 +17 3070 . C 0 . DP=20;I16=6,13,0,0,627,22135,0,0,1078,62882,0,0,414,9878,0,0;QS=3,0;MQSB=0.953977;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,98:3:0 0,9,98:3:0 +17 3071 . C 0 . DP=20;I16=7,13,0,0,715,26563,0,0,1138,66482,0,0,419,9893,0,0;QS=3,0;MQSB=0.972138;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,123:4:0 0,9,98:3:0 +17 3072 . C 0 . DP=20;I16=6,13,0,0,696,25784,0,0,1109,65641,0,0,414,9866,0,0;QS=3,0;MQSB=0.965977;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,128:4:0 0,9,106:3:0 +17 3073 . C 0 . DP=20;I16=6,13,0,0,706,26822,0,0,1109,65641,0,0,414,9872,0,0;QS=3,0;MQSB=0.965977;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,135:4:0 0,9,115:3:0 +17 3074 . C 0 . DP=20;I16=6,13,0,0,724,28052,0,0,1109,65641,0,0,414,9886,0,0;QS=3,0;MQSB=0.965977;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,135:4:0 0,9,116:3:0 +17 3075 . C 0 . DP=21;I16=6,13,0,0,630,21614,0,0,1109,65641,0,0,389,9283,0,0;QS=3,0;MQSB=0.965977;MQ0F=0 PL:DP:DV 0,33,239:11:0 0,15,140:5:0 0,9,94:3:0 +17 3076 . G 0 . DP=21;I16=6,14,0,0,645,21809,0,0,1169,69241,0,0,415,9939,0,0;QS=3,0;MQSB=0.969852;MQ0F=0 PL:DP:DV 0,36,252:12:0 0,15,126:5:0 0,9,91:3:0 +17 3077 . C 0 . DP=20;I16=5,15,0,0,694,25228,0,0,1169,69241,0,0,417,9979,0,0;QS=3,0;MQSB=0.976472;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,116:4:0 0,9,111:3:0 +17 3078 . C 0 . DP=20;I16=5,15,0,0,767,29761,0,0,1169,69241,0,0,420,10028,0,0;QS=3,0;MQSB=0.976472;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,113:4:0 0,9,111:3:0 +17 3079 . T 0 . DP=20;I16=5,15,0,0,749,28479,0,0,1169,69241,0,0,422,10038,0,0;QS=3,0;MQSB=0.976472;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,119:4:0 0,9,116:3:0 +17 3080 . G 0 . DP=21;I16=6,15,0,0,785,29901,0,0,1229,72841,0,0,424,10060,0,0;QS=3,0;MQSB=0.973096;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,124:4:0 0,9,103:3:0 +17 3081 . C 0 . DP=21;I16=6,15,0,0,752,27438,0,0,1229,72841,0,0,425,9997,0,0;QS=3,0;MQSB=0.973096;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,118:4:0 0,9,92:3:0 +17 3082 . C 0 . DP=21;I16=6,15,0,0,787,30211,0,0,1229,72841,0,0,426,9952,0,0;QS=3,0;MQSB=0.973096;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,118:4:0 0,9,112:3:0 +17 3083 . T C, 0 . DP=21;I16=6,14,0,1,764,29458,33,1089,1169,69241,60,3600,401,9249,25,625;QS=2.93666,0.0633397,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.973096;BQB=1;MQ0F=0 PL:DP:DV 0,9,255,39,255,255:14:1 0,12,130,12,130,130:4:0 0,9,113,9,113,113:3:0 +17 3084 . G 0 . DP=23;I16=6,17,0,0,859,32755,0,0,1349,80041,0,0,426,9812,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,118:4:0 0,12,135:4:0 +17 3085 . T 0 . DP=23;I16=6,16,0,0,824,31132,0,0,1289,76441,0,0,426,9718,0,0;QS=3,0;MQSB=0.97584;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,124:4:0 0,12,135:4:0 +17 3086 . G 0 . DP=23;I16=6,17,0,0,853,32429,0,0,1349,80041,0,0,428,9648,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,125:4:0 0,12,131:4:0 +17 3087 . G 0 . DP=23;I16=6,17,0,0,897,35253,0,0,1349,80041,0,0,429,9599,0,0;QS=3,0;MQSB=0.978183;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,130:4:0 0,12,137:4:0 +17 3088 . A 0 . DP=22;I16=6,16,0,0,834,31738,0,0,1289,76441,0,0,431,9571,0,0;QS=3,0;MQSB=0.97584;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,110:3:0 0,12,135:4:0 +17 3089 . A 0 . DP=23;I16=7,16,0,0,919,36903,0,0,1349,80041,0,0,432,9514,0,0;QS=3,0;MQSB=0.973027;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,113:3:0 0,15,175:5:0 +17 3090 . G 0 . DP=23;I16=7,16,0,0,885,34349,0,0,1349,80041,0,0,433,9431,0,0;QS=3,0;MQSB=0.973027;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,103:3:0 0,15,160:5:0 +17 3091 . T 0 . DP=23;I16=7,16,0,0,840,31352,0,0,1349,80041,0,0,434,9374,0,0;QS=3,0;MQSB=0.973027;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,105:3:0 0,15,153:5:0 +17 3092 . T 0 . DP=24;I16=8,16,0,0,895,33673,0,0,1409,83641,0,0,434,9294,0,0;QS=3,0;MQSB=0.970446;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,109:3:0 0,15,165:5:0 +17 3093 . G 0 . DP=25;I16=9,16,0,0,955,37033,0,0,1469,87241,0,0,434,9192,0,0;QS=3,0;MQSB=0.968069;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,133:4:0 0,15,157:5:0 +17 3094 . A 0 . DP=25;I16=9,15,0,0,891,33319,0,0,1409,83641,0,0,425,9019,0,0;QS=3,0;MQSB=0.96464;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,134:4:0 0,15,161:5:0 +17 3095 . C 0 . DP=25;I16=9,15,0,0,891,33469,0,0,1409,83641,0,0,425,8955,0,0;QS=3,0;MQSB=0.96464;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,131:4:0 0,15,163:5:0 +17 3096 . C 0 . DP=25;I16=9,16,0,0,952,36626,0,0,1469,87241,0,0,436,9014,0,0;QS=3,0;MQSB=0.968069;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,121:4:0 0,15,167:5:0 +17 3097 . A 0 . DP=25;I16=9,16,0,0,972,38200,0,0,1469,87241,0,0,436,8984,0,0;QS=3,0;MQSB=0.968069;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,144:4:0 0,15,174:5:0 +17 3098 . G 0 . DP=25;I16=9,16,0,0,959,37269,0,0,1469,87241,0,0,436,8986,0,0;QS=3,0;MQSB=0.968069;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,134:4:0 0,15,166:5:0 +17 3099 . A 0 . DP=25;I16=9,16,0,0,888,32632,0,0,1469,87241,0,0,435,8971,0,0;QS=3,0;MQSB=0.968069;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,124:4:0 0,15,165:5:0 +17 3100 . C 0 . DP=25;I16=9,16,0,0,870,31084,0,0,1469,87241,0,0,434,8990,0,0;QS=3,0;MQSB=0.968069;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,126:4:0 0,15,159:5:0 +17 3101 . C 0 . DP=25;I16=9,16,0,0,960,37090,0,0,1469,87241,0,0,432,8992,0,0;QS=3,0;MQSB=0.968069;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,134:4:0 0,15,161:5:0 +17 3102 . A 0 . DP=26;I16=10,16,0,0,952,35186,0,0,1529,90841,0,0,430,9026,0,0;QS=3,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,134:4:0 0,18,189:6:0 +17 3103 . T 0 . DP=26;I16=10,16,0,0,920,33094,0,0,1529,90841,0,0,427,8993,0,0;QS=3,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,131:4:0 0,18,187:6:0 +17 3104 . C T, 0 . DP=25;I16=8,15,2,0,900,35584,80,3202,1349,80041,120,7200,385,8143,40,850;QS=2.58763,0.412371,0;VDB=0.8;SGB=0.346553;RPB=0.717391;MQB=0.956522;MQSB=0.962269;BQB=0.978261;MQ0F=0 PL:DP:DV 0,48,255,48,255,255:16:0 0,12,144,12,144,144:4:0 59,0,93,68,99,157:5:2 +17 3105 . T 0 . DP=25;I16=10,15,0,0,959,37057,0,0,1469,87241,0,0,422,8976,0,0;QS=3,0;MQSB=0.962269;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,12,149:4:0 0,15,169:5:0 +17 3106 . G 0 . DP=23;I16=10,13,0,0,881,33891,0,0,1380,82800,0,0,420,8940,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,132:4:0 0,15,167:5:0 +17 3107 . T 0 . DP=24;I16=10,14,0,0,878,32496,0,0,1440,86400,0,0,418,8932,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,132:4:0 0,18,195:6:0 +17 3108 . C 0 . DP=24;I16=10,14,0,0,909,34897,0,0,1440,86400,0,0,417,8953,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,137:4:0 0,18,189:6:0 +17 3109 . A 0 . DP=24;I16=10,14,0,0,905,34249,0,0,1440,86400,0,0,416,9004,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,136:4:0 0,18,195:6:0 +17 3110 . C 0 . DP=24;I16=10,13,0,0,919,37099,0,0,1380,82800,0,0,413,8933,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,105:3:0 0,18,189:6:0 +17 3111 . A 0 . DP=25;I16=10,14,0,0,961,38943,0,0,1440,86400,0,0,410,8888,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,111:3:0 0,18,205:6:0 +17 3112 . G 0 . DP=25;I16=10,14,0,0,958,39370,0,0,1440,86400,0,0,407,8821,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,116:3:0 0,18,191:6:0 +17 3113 . C 0 . DP=25;I16=10,14,0,0,961,39641,0,0,1440,86400,0,0,403,8735,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,112:3:0 0,18,193:6:0 +17 3114 . A 0 . DP=24;I16=10,13,0,0,928,38448,0,0,1380,82800,0,0,400,8680,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,116:3:0 0,18,200:6:0 +17 3115 . G 0 . DP=23;I16=10,12,0,0,872,35800,0,0,1320,79200,0,0,397,8603,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,117:3:0 0,18,195:6:0 +17 3116 . G 0 . DP=23;I16=10,12,0,0,870,35372,0,0,1320,79200,0,0,394,8552,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,108:3:0 0,18,194:6:0 +17 3117 . T 0 . DP=22;I16=9,13,0,0,771,27537,0,0,1320,79200,0,0,399,8575,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,96:3:0 0,18,177:6:0 +17 3118 . A 0 . DP=22;I16=9,13,0,0,813,30285,0,0,1320,79200,0,0,397,8537,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,111:3:0 0,18,193:6:0 +17 3119 . A 0 . DP=22;I16=9,13,0,0,886,35954,0,0,1320,79200,0,0,393,8423,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,120:3:0 0,18,207:6:0 +17 3120 . G 0 . DP=22;I16=9,13,0,0,839,32281,0,0,1320,79200,0,0,389,8333,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,104:3:0 0,18,182:6:0 +17 3121 . A 0 . DP=22;I16=10,12,0,0,777,28399,0,0,1320,79200,0,0,386,8266,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,111:3:0 0,18,194:6:0 +17 3122 . C 0 . DP=22;I16=10,12,0,0,848,33002,0,0,1320,79200,0,0,384,8222,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,110:3:0 0,18,192:6:0 +17 3123 . T 0 . DP=22;I16=10,12,0,0,854,33456,0,0,1320,79200,0,0,382,8202,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,114:3:0 0,18,204:6:0 +17 3124 . C 0 . DP=22;I16=10,11,0,0,882,38286,0,0,1260,75600,0,0,381,8205,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,104:3:0 0,15,178:5:0 +17 3125 . T 0 . DP=22;I16=10,11,0,0,860,36764,0,0,1260,75600,0,0,380,8230,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,106:3:0 0,15,185:5:0 +17 3126 . G 0 . DP=22;I16=10,11,0,0,834,34998,0,0,1260,75600,0,0,379,8277,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,97:3:0 0,15,174:5:0 +17 3127 . C 0 . DP=23;I16=10,11,0,0,847,36381,0,0,1260,75600,0,0,378,8346,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,87:3:0 0,15,175:5:0 +17 3128 . T 0 . DP=22;I16=9,12,0,0,850,35972,0,0,1229,72841,0,0,402,9010,0,0;QS=3,0;MQSB=0.950149;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,107:3:0 0,15,182:5:0 +17 3129 . T 0 . DP=22;I16=9,12,0,0,809,32621,0,0,1229,72841,0,0,401,9067,0,0;QS=3,0;MQSB=0.950149;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,107:3:0 0,15,178:5:0 +17 3130 . T 0 . DP=21;I16=9,10,0,0,744,30322,0,0,1140,68400,0,0,376,8516,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,82:2:0 0,15,169:5:0 +17 3131 . C 0 . DP=21;I16=9,10,0,0,792,34778,0,0,1140,68400,0,0,376,8606,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,6,83:2:0 0,15,170:5:0 +17 3132 . T 0 . DP=21;I16=9,11,0,0,819,35197,0,0,1169,69241,0,0,400,9288,0,0;QS=3,0;MQSB=0.943233;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,109:3:0 0,15,174:5:0 +17 3133 . G 0 . DP=21;I16=9,11,0,0,800,34016,0,0,1169,69241,0,0,398,9312,0,0;QS=3,0;MQSB=0.943233;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,97:3:0 0,15,166:5:0 +17 3134 . G 0 . DP=22;I16=10,11,0,0,773,30227,0,0,1229,72841,0,0,396,9352,0,0;QS=3,0;MQSB=0.939898;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,97:3:0 0,15,163:5:0 +17 3135 . G 0 . DP=22;I16=9,12,0,0,812,33714,0,0,1229,72841,0,0,396,9408,0,0;QS=3,0;MQSB=0.950149;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,94:3:0 0,12,151:4:0 +17 3136 . C 0 . DP=22;I16=9,12,0,0,811,33469,0,0,1229,72841,0,0,396,9430,0,0;QS=3,0;MQSB=0.950149;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,102:3:0 0,12,140:4:0 +17 3137 . A 0 . DP=22;I16=10,11,0,0,786,31226,0,0,1229,72841,0,0,396,9416,0,0;QS=3,0;MQSB=0.939898;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,95:3:0 0,12,142:4:0 +17 3138 . A 0 . DP=21;I16=9,11,0,0,720,28200,0,0,1169,69241,0,0,398,9414,0,0;QS=3,0;MQSB=0.943233;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,98:3:0 0,12,147:4:0 +17 3139 . C 0 . DP=21;I16=9,11,0,0,755,31433,0,0,1169,69241,0,0,400,9424,0,0;QS=3,0;MQSB=0.943233;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,91:3:0 0,12,139:4:0 +17 3140 . C 0 . DP=21;I16=9,11,0,0,790,33238,0,0,1169,69241,0,0,402,9446,0,0;QS=3,0;MQSB=0.943233;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,102:3:0 0,12,145:4:0 +17 3141 . C 0 . DP=21;I16=9,11,0,0,819,35401,0,0,1169,69241,0,0,404,9480,0,0;QS=3,0;MQSB=0.943233;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,101:3:0 0,12,150:4:0 +17 3142 . A 0 . DP=21;I16=9,11,0,0,822,35744,0,0,1169,69241,0,0,405,9477,0,0;QS=3,0;MQSB=0.943233;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,107:3:0 0,12,155:4:0 +17 3143 . G 0 . DP=22;I16=10,11,0,0,846,36468,0,0,1198,70082,0,0,406,9488,0,0;QS=3,0;MQSB=0.99938;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,104:3:0 0,12,151:4:0 +17 3144 . C 0 . DP=23;I16=12,10,0,0,855,35905,0,0,1258,73682,0,0,409,9513,0,0;QS=3,0;MQSB=0.997828;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,104:3:0 0,15,165:5:0 +17 3145 . A 0 . DP=23;I16=12,10,0,0,869,35937,0,0,1258,73682,0,0,414,9554,0,0;QS=3,0;MQSB=0.997828;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,106:3:0 0,15,174:5:0 +17 3146 . G 0 . DP=23;I16=12,10,0,0,895,38345,0,0,1258,73682,0,0,419,9613,0,0;QS=3,0;MQSB=0.997828;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,105:3:0 0,15,179:5:0 +17 3147 . G 0 . DP=24;I16=11,11,0,0,851,34815,0,0,1289,76441,0,0,419,9623,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,123:4:0 0,15,172:5:0 +17 3148 . T 0 . DP=24;I16=12,11,0,0,795,30097,0,0,1318,77282,0,0,428,9682,0,0;QS=3,0;MQSB=0.999527;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,107:4:0 0,15,149:5:0 +17 3149 . G 0 . DP=24;I16=12,11,0,0,910,38142,0,0,1318,77282,0,0,433,9743,0,0;QS=3,0;MQSB=0.999527;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,120:4:0 0,15,167:5:0 +17 3150 . A 0 . DP=24;I16=12,11,0,0,854,33784,0,0,1318,77282,0,0,438,9822,0,0;QS=3,0;MQSB=0.999527;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,129:4:0 0,15,167:5:0 +17 3151 . C 0 . DP=24;I16=12,11,0,0,873,35315,0,0,1318,77282,0,0,442,9870,0,0;QS=3,0;MQSB=0.999527;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,125:4:0 0,15,163:5:0 +17 3152 . C 0 . DP=24;I16=12,11,0,0,857,34239,0,0,1318,77282,0,0,445,9889,0,0;QS=3,0;MQSB=0.999527;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,123:4:0 0,15,155:5:0 +17 3153 . C 0 . DP=24;I16=12,11,0,0,891,36711,0,0,1318,77282,0,0,448,9930,0,0;QS=3,0;MQSB=0.999527;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,125:4:0 0,15,166:5:0 +17 3154 . T 0 . DP=25;I16=13,11,0,0,938,38052,0,0,1378,80882,0,0,451,9993,0,0;QS=3,0;MQSB=0.998323;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,133:4:0 0,18,194:6:0 +17 3155 . G 0 . DP=25;I16=13,11,0,0,953,39423,0,0,1378,80882,0,0,454,10030,0,0;QS=3,0;MQSB=0.998323;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,127:4:0 0,18,180:6:0 +17 3156 . G 0 . DP=25;I16=13,11,0,0,946,38818,0,0,1378,80882,0,0,457,10093,0,0;QS=3,0;MQSB=0.998323;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,126:4:0 0,18,189:6:0 +17 3157 . A 0 . DP=24;I16=12,12,0,0,896,33648,0,0,1378,80882,0,0,486,10806,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,130:4:0 0,18,193:6:0 +17 3158 . A 0 . DP=24;I16=12,12,0,0,856,31670,0,0,1378,80882,0,0,490,10918,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,125:4:0 0,18,192:6:0 +17 3159 . T 0 . DP=24;I16=11,12,0,0,864,32952,0,0,1349,80041,0,0,477,10749,0,0;QS=3,0;MQSB=0.944319;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,134:4:0 0,18,194:6:0 +17 3160 . T 0 . DP=24;I16=12,12,0,0,907,34719,0,0,1378,80882,0,0,494,11018,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,134:4:0 0,18,193:6:0 +17 3161 . C 0 . DP=24;I16=12,12,0,0,880,33336,0,0,1378,80882,0,0,494,11006,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,123:4:0 0,18,196:6:0 +17 3162 . C 0 . DP=24;I16=12,12,0,0,916,35764,0,0,1378,80882,0,0,494,11018,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,127:4:0 0,18,188:6:0 +17 3163 . T A, 0 . DP=24;I16=11,12,1,0,895,35099,13,169,1349,80041,29,841,473,10603,20,400;QS=2.97436,0.025641,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=1;BQB=1;MQ0F=0 PL:DP:DV 0,28,255,39,255,255:14:1 0,12,137,12,137,137:4:0 0,18,200,18,200,200:6:0 +17 3164 . G 0 . DP=24;I16=12,11,0,0,887,34437,0,0,1349,80041,0,0,467,10385,0,0;QS=3,0;MQSB=0.944319;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,106:3:0 0,18,188:6:0 +17 3165 . T 0 . DP=24;I16=12,12,0,0,880,32654,0,0,1378,80882,0,0,490,10990,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,133:4:0 0,18,189:6:0 +17 3166 . C 0 . DP=24;I16=12,11,0,0,871,33389,0,0,1349,80041,0,0,463,10369,0,0;QS=3,0;MQSB=0.944319;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,111:3:0 0,18,193:6:0 +17 3167 . C 0 . DP=23;I16=12,11,0,0,879,34199,0,0,1318,77282,0,0,487,11021,0,0;QS=3,0;MQSB=0.999527;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,131:4:0 0,18,189:6:0 +17 3168 . A 0 . DP=23;I16=12,11,0,0,874,33294,0,0,1318,77282,0,0,486,11070,0,0;QS=3,0;MQSB=0.999527;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,125:4:0 0,18,192:6:0 +17 3169 . T 0 . DP=23;I16=11,11,0,0,824,31124,0,0,1289,76441,0,0,458,10416,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,128:4:0 0,18,187:6:0 +17 3170 . C 0 . DP=23;I16=11,11,0,0,877,35167,0,0,1289,76441,0,0,453,10307,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,129:4:0 0,18,201:6:0 +17 3171 . T 0 . DP=23;I16=11,11,0,0,843,32615,0,0,1289,76441,0,0,448,10216,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,127:4:0 0,18,201:6:0 +17 3172 . G 0 . DP=23;I16=12,11,0,0,813,29605,0,0,1318,77282,0,0,468,10768,0,0;QS=3,0;MQSB=0.999527;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,120:4:0 0,18,176:6:0 +17 3173 . G 0 . DP=23;I16=11,11,0,0,801,29659,0,0,1289,76441,0,0,436,9988,0,0;QS=3,0;MQSB=0.936864;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,126:4:0 0,18,174:6:0 +17 3174 . C 0 . DP=24;I16=13,11,0,0,938,36926,0,0,1378,80882,0,0,454,10476,0,0;QS=3,0;MQSB=0.998323;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,127:4:0 0,18,194:6:0 +17 3175 . A 0 . DP=25;I16=13,11,0,0,914,35230,0,0,1409,83641,0,0,422,9684,0,0;QS=3,0;MQSB=0.931547;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,127:4:0 0,21,209:7:0 +17 3176 . G 0 . DP=24;I16=14,10,0,0,909,34913,0,0,1378,80882,0,0,442,10164,0,0;QS=3,0;MQSB=0.993166;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,97:3:0 0,21,205:7:0 +17 3177 . G 0 . DP=23;I16=14,9,0,0,793,28159,0,0,1318,77282,0,0,438,10040,0,0;QS=3,0;MQSB=0.987676;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,93:3:0 0,21,195:7:0 +17 3178 . T 0 . DP=23;I16=13,9,0,0,754,26290,0,0,1289,76441,0,0,408,9262,0,0;QS=3,0;MQSB=0.910098;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,96:3:0 0,21,173:7:0 +17 3179 . G 0 . DP=23;I16=13,9,0,0,802,29686,0,0,1289,76441,0,0,403,9131,0,0;QS=3,0;MQSB=0.910098;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,97:3:0 0,21,188:7:0 +17 3180 . G 0 . DP=22;I16=12,9,0,0,701,24107,0,0,1229,72841,0,0,398,8970,0,0;QS=3,0;MQSB=0.913101;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,92:3:0 0,21,175:7:0 +17 3181 . G 0 . DP=22;I16=13,9,0,0,795,29503,0,0,1258,73682,0,0,418,9452,0,0;QS=3,0;MQSB=0.991121;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,99:3:0 0,21,193:7:0 +17 3182 . C 0 . DP=22;I16=12,9,0,0,772,28878,0,0,1198,70082,0,0,396,9038,0,0;QS=3,0;MQSB=0.994334;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,99:3:0 0,21,184:7:0 +17 3183 . A 0 . DP=22;I16=12,9,0,0,766,28304,0,0,1229,72841,0,0,382,8546,0,0;QS=3,0;MQSB=0.913101;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,106:3:0 0,21,193:7:0 +17 3184 . T 0 . DP=21;I16=12,8,0,0,721,26533,0,0,1169,69241,0,0,377,8409,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,30,248:10:0 0,9,106:3:0 0,21,196:7:0 +17 3185 . T 0 . DP=20;I16=13,7,0,0,740,27660,0,0,1138,66482,0,0,397,8865,0,0;QS=3,0;MQSB=0.972138;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,103:3:0 0,18,174:6:0 +17 3186 . G 0 . DP=20;I16=13,7,0,0,741,28311,0,0,1138,66482,0,0,391,8665,0,0;QS=3,0;MQSB=0.972138;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,103:3:0 0,18,169:6:0 +17 3187 . A 0 . DP=20;I16=13,7,0,0,693,24927,0,0,1138,66482,0,0,385,8485,0,0;QS=3,0;MQSB=0.972138;MQ0F=0 PL:DP:DV 0,33,247:11:0 0,9,102:3:0 0,18,171:6:0 +17 3188 . A 0 . DP=20;I16=13,7,0,0,704,25746,0,0,1138,66482,0,0,379,8325,0,0;QS=3,0;MQSB=0.972138;MQ0F=0 PL:DP:DV 0,33,249:11:0 0,9,100:3:0 0,18,174:6:0 +17 3189 . A 0 . DP=21;I16=13,8,0,0,763,28171,0,0,1198,70082,0,0,373,8185,0,0;QS=3,0;MQSB=0.983744;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,125:4:0 0,18,174:6:0 +17 3190 . C 0 . DP=20;I16=11,8,0,0,675,24915,0,0,1109,65641,0,0,344,7440,0,0;QS=3,0;MQSB=0.902014;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,123:4:0 0,15,148:5:0 +17 3191 . T 0 . DP=21;I16=11,9,0,0,773,30203,0,0,1169,69241,0,0,340,7340,0,0;QS=3,0;MQSB=0.916401;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,130:4:0 0,15,171:5:0 +17 3192 . G 0 . DP=21;I16=12,9,0,0,751,27785,0,0,1198,70082,0,0,362,7886,0,0;QS=3,0;MQSB=0.994334;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,125:4:0 0,15,152:5:0 +17 3193 . G 0 . DP=21;I16=12,9,0,0,756,27614,0,0,1198,70082,0,0,359,7829,0,0;QS=3,0;MQSB=0.994334;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,121:4:0 0,15,148:5:0 +17 3194 . T C, 0 . DP=21;I16=10,10,1,0,730,26992,18,324,1169,69241,29,841,332,7168,25,625;QS=2.95652,0.0434783,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.99938;BQB=1;MQ0F=0 PL:DP:DV 0,18,255,33,255,255:12:1 0,9,98,9,98,98:3:0 0,18,178,18,178,178:6:0 +17 3195 . T 0 . DP=21;I16=11,10,0,0,776,29184,0,0,1198,70082,0,0,356,7778,0,0;QS=3,0;MQSB=0.99938;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,95:3:0 0,18,189:6:0 +17 3196 . T 0 . DP=21;I16=10,10,0,0,722,26472,0,0,1169,69241,0,0,329,7111,0,0;QS=3,0;MQSB=0.931063;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,91:3:0 0,18,186:6:0 +17 3197 . A 0 . DP=22;I16=12,9,0,0,715,24911,0,0,1229,72841,0,0,352,7718,0,0;QS=3,0;MQSB=0.950149;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,103:3:0 0,18,179:6:0 +17 3198 . A 0 . DP=21;I16=12,8,0,0,745,28155,0,0,1169,69241,0,0,345,7675,0,0;QS=3,0;MQSB=0.953497;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,105:3:0 0,18,198:6:0 +17 3199 . A 0 . DP=21;I16=11,9,0,0,736,27514,0,0,1200,72000,0,0,326,7080,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,105:3:0 0,18,196:6:0 +17 3200 . A 0 . DP=20;I16=11,9,0,0,735,27533,0,0,1169,69241,0,0,350,7660,0,0;QS=3,0;MQSB=0.943233;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,108:3:0 0,18,195:6:0 +17 3201 . A 0 . DP=20;I16=11,8,0,0,706,26814,0,0,1109,65641,0,0,338,7486,0,0;QS=3,0;MQSB=0.946915;MQ0F=0 PL:DP:DV 0,30,248:10:0 0,9,107:3:0 0,18,198:6:0 +17 3202 . T 0 . DP=20;I16=10,9,0,0,692,25620,0,0,1140,68400,0,0,321,6907,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,249:10:0 0,9,109:3:0 0,18,187:6:0 +17 3203 . G A, 0 . DP=19;I16=9,9,1,0,644,23760,19,361,1080,64800,29,841,320,6872,25,625;QS=2.94823,0.0517711,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.934728;BQB=1;MQ0F=0 PL:DP:DV 0,14,239,30,242,248:11:1 0,9,105,9,105,105:3:0 0,15,160,15,160,160:5:0 +17 3204 . T 0 . DP=19;I16=9,8,0,0,619,22955,0,0,1020,61200,0,0,306,6686,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,234:9:0 0,9,101:3:0 0,15,169:5:0 +17 3205 . C 0 . DP=19;I16=9,9,0,0,672,25340,0,0,1080,64800,0,0,318,6856,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,99:3:0 0,15,157:5:0 +17 3206 . A 0 . DP=19;I16=10,9,0,0,661,23623,0,0,1109,65641,0,0,342,7500,0,0;QS=3,0;MQSB=0.934728;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,91:3:0 0,15,165:5:0 +17 3207 . C 0 . DP=19;I16=9,9,0,0,642,23618,0,0,1080,64800,0,0,316,6912,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,90:3:0 0,15,158:5:0 +17 3208 . A 0 . DP=18;I16=10,8,0,0,619,22023,0,0,1049,62041,0,0,341,7591,0,0;QS=3,0;MQSB=0.938795;MQ0F=0 PL:DP:DV 0,33,247:11:0 0,9,95:3:0 0,12,142:4:0 +17 3209 . C 0 . DP=19;I16=11,8,0,0,681,24747,0,0,1109,65641,0,0,340,7612,0,0;QS=3,0;MQSB=0.946915;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,106:3:0 0,12,134:4:0 +17 3210 . C 0 . DP=18;I16=11,7,0,0,664,24900,0,0,1049,62041,0,0,340,7602,0,0;QS=3,0;MQSB=0.951002;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,101:3:0 0,12,141:4:0 +17 3211 . A 0 . DP=17;I16=11,6,0,0,645,24627,0,0,989,58441,0,0,341,7611,0,0;QS=3,0;MQSB=0.955563;MQ0F=0 PL:DP:DV 0,30,243:10:0 0,9,106:3:0 0,12,140:4:0 +17 3212 . T 0 . DP=17;I16=10,6,0,0,575,21295,0,0,960,57600,0,0,316,6964,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,222:9:0 0,9,100:3:0 0,12,144:4:0 +17 3213 . A 0 . DP=17;I16=10,6,0,0,597,22631,0,0,960,57600,0,0,316,6962,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,228:9:0 0,9,117:3:0 0,12,138:4:0 +17 3214 . G 0 . DP=17;I16=11,6,0,0,615,23103,0,0,989,58441,0,0,341,7605,0,0;QS=3,0;MQSB=0.955563;MQ0F=0 PL:DP:DV 0,30,243:10:0 0,9,110:3:0 0,12,134:4:0 +17 3215 . G 0 . DP=17;I16=11,6,0,0,591,21523,0,0,989,58441,0,0,340,7592,0,0;QS=3,0;MQSB=0.955563;MQ0F=0 PL:DP:DV 0,30,241:10:0 0,9,93:3:0 0,12,128:4:0 +17 3216 . C 0 . DP=17;I16=11,6,0,0,623,23303,0,0,989,58441,0,0,339,7597,0,0;QS=3,0;MQSB=0.955563;MQ0F=0 PL:DP:DV 0,30,242:10:0 0,9,94:3:0 0,12,138:4:0 +17 3217 . C 0 . DP=17;I16=11,6,0,0,570,19896,0,0,989,58441,0,0,337,7569,0,0;QS=3,0;MQSB=0.955563;MQ0F=0 PL:DP:DV 0,30,236:10:0 0,9,84:3:0 0,12,123:4:0 +17 3218 . G C, 0 . DP=18;I16=10,7,1,0,547,18185,29,841,1020,61200,29,841,310,6932,24,576;QS=2.91667,0.0833333,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.951002;BQB=1;MQ0F=0 PL:DP:DV 0,4,202,30,205,221:11:1 0,9,96,9,96,96:3:0 0,12,112,12,112,112:4:0 +17 3219 . G A, 0 . DP=18;I16=10,7,1,0,606,22158,19,361,1020,61200,29,841,308,6888,23,529;QS=2.94837,0.0516304,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.951002;BQB=1;MQ0F=0 PL:DP:DV 0,14,234,30,237,243:11:1 0,9,107,9,107,107:3:0 0,12,126,12,126,126:4:0 +17 3220 . G 0 . DP=18;I16=11,7,0,0,631,22827,0,0,1049,62041,0,0,326,7248,0,0;QS=3,0;MQSB=0.951002;MQ0F=0 PL:DP:DV 0,33,252:11:0 0,9,112:3:0 0,12,126:4:0 +17 3221 . C 0 . DP=17;I16=9,7,0,0,598,22586,0,0,960,57600,0,0,301,6659,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,244:9:0 0,9,103:3:0 0,12,139:4:0 +17 3222 . A 0 . DP=17;I16=10,7,0,0,623,23037,0,0,989,58441,0,0,318,6972,0,0;QS=3,0;MQSB=0.943335;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,100:3:0 0,12,133:4:0 +17 3223 . C 0 . DP=17;I16=10,7,0,0,611,22603,0,0,989,58441,0,0,312,6764,0,0;QS=3,0;MQSB=0.943335;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,96:3:0 0,12,132:4:0 +17 3224 . A 0 . DP=16;I16=10,6,0,0,609,23381,0,0,929,54841,0,0,307,6575,0,0;QS=3,0;MQSB=0.948436;MQ0F=0 PL:DP:DV 0,27,238:9:0 0,9,97:3:0 0,12,141:4:0 +17 3225 . G 0 . DP=17;I16=11,6,0,0,604,22692,0,0,989,58441,0,0,302,6404,0,0;QS=3,0;MQSB=0.955563;MQ0F=0 PL:DP:DV 0,27,247:9:0 0,12,108:4:0 0,12,134:4:0 +17 3226 . T 0 . DP=18;I16=11,6,0,0,582,20466,0,0,1020,61200,0,0,282,5996,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,224:9:0 0,12,112:4:0 0,12,131:4:0 +17 3227 . G 0 . DP=18;I16=12,5,0,0,618,23008,0,0,989,58441,0,0,270,5496,0,0;QS=3,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,91:3:0 0,12,125:4:0 +17 3228 . G 0 . DP=18;I16=11,6,0,0,611,22581,0,0,1020,61200,0,0,278,5816,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,248:9:0 0,12,118:4:0 0,12,121:4:0 +17 3229 . C 0 . DP=19;I16=12,7,0,0,686,25394,0,0,1109,65641,0,0,289,5925,0,0;QS=3,0;MQSB=0.957193;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,118:4:0 0,12,126:4:0 +17 3230 . T 0 . DP=19;I16=12,6,0,0,669,25441,0,0,1049,62041,0,0,261,5187,0,0;QS=3,0;MQSB=0.961295;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,107:3:0 0,12,139:4:0 +17 3231 . C 0 . DP=19;I16=12,7,0,0,682,25046,0,0,1109,65641,0,0,283,5725,0,0;QS=3,0;MQSB=0.957193;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,112:4:0 0,12,128:4:0 +17 3232 . A 0 . DP=19;I16=11,7,0,0,597,20779,0,0,1080,64800,0,0,270,5564,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,229:10:0 0,12,117:4:0 0,12,132:4:0 +17 3233 . C 0 . DP=19;I16=12,7,0,0,573,18239,0,0,1109,65641,0,0,277,5629,0,0;QS=3,0;MQSB=0.957193;MQ0F=0 PL:DP:DV 0,33,238:11:0 0,12,91:4:0 0,12,110:4:0 +17 3234 . G T, 0 . DP=19;I16=10,6,1,0,511,17305,22,484,960,57600,29,841,233,4849,8,64;QS=2.93855,0.0614525,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.955563;BQB=1;MQ0F=0 PL:DP:DV 0,11,222,30,225,234:11:1 0,6,63,6,63,63:2:0 0,12,100,12,100,100:4:0 +17 3235 . C 0 . DP=18;I16=12,6,0,0,625,22649,0,0,1049,62041,0,0,274,5582,0,0;QS=3,0;MQSB=0.961295;MQ0F=0 PL:DP:DV 0,30,249:10:0 0,12,119:4:0 0,12,123:4:0 +17 3236 . C 0 . DP=18;I16=12,6,0,0,668,25124,0,0,1049,62041,0,0,273,5567,0,0;QS=3,0;MQSB=0.961295;MQ0F=0 PL:DP:DV 0,30,244:10:0 0,12,137:4:0 0,12,134:4:0 +17 3237 . T 0 . DP=17;I16=11,6,0,0,589,21235,0,0,989,58441,0,0,273,5573,0,0;QS=3,0;MQSB=0.955563;MQ0F=0 PL:DP:DV 0,27,230:9:0 0,12,102:4:0 0,12,136:4:0 +17 3238 . G 0 . DP=17;I16=11,6,0,0,609,22539,0,0,989,58441,0,0,273,5599,0,0;QS=3,0;MQSB=0.955563;MQ0F=0 PL:DP:DV 0,27,243:9:0 0,12,104:4:0 0,12,129:4:0 +17 3239 . T 0 . DP=17;I16=11,6,0,0,574,20204,0,0,989,58441,0,0,273,5645,0,0;QS=3,0;MQSB=0.955563;MQ0F=0 PL:DP:DV 0,27,220:9:0 0,12,107:4:0 0,12,131:4:0 +17 3240 . A 0 . DP=19;I16=12,7,0,0,624,21552,0,0,1109,65641,0,0,273,5711,0,0;QS=3,0;MQSB=0.957193;MQ0F=0 PL:DP:DV 0,33,248:11:0 0,12,101:4:0 0,12,132:4:0 +17 3241 . A 0 . DP=19;I16=11,6,0,0,619,23121,0,0,1020,61200,0,0,249,5173,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,252:10:0 0,9,96:3:0 0,12,143:4:0 +17 3242 . T 0 . DP=19;I16=12,7,0,0,655,23279,0,0,1140,68400,0,0,277,5911,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,252:10:0 0,12,104:4:0 0,15,152:5:0 +17 3243 . C 0 . DP=19;I16=12,7,0,0,682,25216,0,0,1140,68400,0,0,281,6047,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,111:4:0 0,15,148:5:0 +17 3244 . C 0 . DP=18;I16=11,6,0,0,587,21119,0,0,1020,61200,0,0,281,6139,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,221:8:0 0,12,116:4:0 0,15,142:5:0 +17 3245 . C 0 . DP=17;I16=10,7,0,0,631,23851,0,0,1020,61200,0,0,290,6282,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,12,126:4:0 0,12,131:4:0 +17 3246 . A 0 . DP=17;I16=10,7,0,0,646,24716,0,0,1020,61200,0,0,295,6427,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,12,129:4:0 0,12,139:4:0 +17 3247 . G 0 . DP=17;I16=10,7,0,0,606,22554,0,0,1020,61200,0,0,300,6590,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,12,92:4:0 0,12,133:4:0 +17 3248 . C 0 . DP=16;I16=10,6,0,0,603,23115,0,0,960,57600,0,0,306,6770,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,9,99:3:0 0,12,132:4:0 +17 3249 . C 0 . DP=16;I16=10,6,0,0,587,21913,0,0,960,57600,0,0,311,6917,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,246:9:0 0,9,99:3:0 0,12,133:4:0 +17 3250 . C 0 . DP=16;I16=10,6,0,0,616,24080,0,0,960,57600,0,0,316,7082,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,9,95:3:0 0,12,137:4:0 +17 3251 . T 0 . DP=16;I16=10,6,0,0,585,22193,0,0,960,57600,0,0,319,7165,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,241:9:0 0,9,104:3:0 0,12,135:4:0 +17 3252 . T 0 . DP=16;I16=10,6,0,0,553,19781,0,0,960,57600,0,0,321,7215,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,239:9:0 0,9,84:3:0 0,12,126:4:0 +17 3253 . T 0 . DP=16;I16=10,6,0,0,589,21933,0,0,960,57600,0,0,323,7281,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,245:9:0 0,9,102:3:0 0,12,132:4:0 +17 3254 . G 0 . DP=17;I16=10,7,0,0,631,23737,0,0,1020,61200,0,0,325,7363,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,9,100:3:0 0,15,154:5:0 +17 3255 . G 0 . DP=16;I16=9,7,0,0,554,20088,0,0,960,57600,0,0,328,7410,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,243:9:0 0,9,93:3:0 0,12,120:4:0 +17 3256 . G 0 . DP=16;I16=8,7,0,0,571,21985,0,0,900,54000,0,0,306,6846,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,255:9:0 0,6,62:2:0 0,12,142:4:0 +17 3257 . A 0 . DP=16;I16=9,7,0,0,585,21881,0,0,960,57600,0,0,334,7546,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,243:9:0 0,9,94:3:0 0,12,144:4:0 +17 3258 . G 0 . DP=17;I16=9,8,0,0,647,25407,0,0,1020,61200,0,0,337,7635,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,81:3:0 0,12,146:4:0 +17 3259 . G 0 . DP=17;I16=9,8,0,0,605,22237,0,0,1020,61200,0,0,341,7739,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,9,79:3:0 0,12,139:4:0 +17 3260 . C 0 . DP=17;I16=9,7,0,0,616,23908,0,0,960,57600,0,0,319,7183,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,6,64:2:0 0,12,133:4:0 +17 3261 . C 0 . DP=18;I16=9,9,0,0,655,24475,0,0,1080,64800,0,0,347,7891,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,90:3:0 0,12,138:4:0 +17 3262 . A 0 . DP=19;I16=10,9,0,0,712,27036,0,0,1140,68400,0,0,351,7989,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,123:4:0 0,12,148:4:0 +17 3263 . G 0 . DP=19;I16=10,9,0,0,715,27317,0,0,1140,68400,0,0,356,8104,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,116:4:0 0,12,146:4:0 +17 3264 . G 0 . DP=19;I16=10,9,0,0,676,24734,0,0,1140,68400,0,0,361,8237,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,93:4:0 0,12,143:4:0 +17 3265 . G 0 . DP=19;I16=10,9,0,0,701,26199,0,0,1140,68400,0,0,365,8339,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,109:4:0 0,12,137:4:0 +17 3266 . T 0 . DP=19;I16=9,9,0,0,597,20769,0,0,1080,64800,0,0,357,8229,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,82:4:0 0,9,113:3:0 +17 3267 . G 0 . DP=19;I16=10,9,0,0,659,24285,0,0,1140,68400,0,0,367,8299,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,76:4:0 0,12,133:4:0 +17 3268 . G 0 . DP=19;I16=10,9,0,0,668,24306,0,0,1140,68400,0,0,367,8255,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,92:4:0 0,12,142:4:0 +17 3269 . G 0 . DP=19;I16=10,9,0,0,714,27122,0,0,1140,68400,0,0,367,8227,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,115:4:0 0,12,137:4:0 +17 3270 . T 0 . DP=20;I16=10,9,0,0,606,20364,0,0,1140,68400,0,0,361,8141,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,251:11:0 0,12,83:4:0 0,12,136:4:0 +17 3271 . G 0 . DP=19;I16=10,9,0,0,709,26993,0,0,1140,68400,0,0,362,8108,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,100:4:0 0,12,143:4:0 +17 3272 . G 0 . DP=19;I16=10,9,0,0,672,24398,0,0,1140,68400,0,0,363,8093,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,97:4:0 0,12,140:4:0 +17 3273 . A 0 . DP=20;I16=10,10,0,0,735,27355,0,0,1200,72000,0,0,363,8047,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,153:5:0 0,12,147:4:0 +17 3274 . T 0 . DP=19;I16=9,10,0,0,699,26089,0,0,1140,68400,0,0,365,8021,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,142:5:0 0,12,149:4:0 +17 3275 . C 0 . DP=19;I16=9,10,0,0,727,28197,0,0,1140,68400,0,0,367,8015,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,137:5:0 0,12,139:4:0 +17 3276 . A 0 . DP=19;I16=9,10,0,0,681,25123,0,0,1140,68400,0,0,369,8029,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,253:10:0 0,15,150:5:0 0,12,141:4:0 +17 3277 . C 0 . DP=19;I16=9,10,0,0,733,28485,0,0,1140,68400,0,0,371,8063,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,153:5:0 0,12,146:4:0 +17 3278 . T 0 . DP=19;I16=9,10,0,0,737,28901,0,0,1140,68400,0,0,373,8117,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,168:5:0 0,12,153:4:0 +17 3279 . T 0 . DP=19;I16=9,10,0,0,714,27132,0,0,1140,68400,0,0,375,8191,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,148:5:0 0,12,150:4:0 +17 3280 . G 0 . DP=20;I16=9,11,0,0,758,29178,0,0,1200,72000,0,0,376,8234,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,143:5:0 0,12,146:4:0 +17 3281 . A 0 . DP=21;I16=10,11,0,0,822,32654,0,0,1260,75600,0,0,378,8296,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,179:6:0 0,12,157:4:0 +17 3282 . G 0 . DP=21;I16=10,11,0,0,815,32059,0,0,1260,75600,0,0,381,8379,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,173:6:0 0,12,150:4:0 +17 3283 . G 0 . DP=21;I16=10,11,0,0,790,30110,0,0,1260,75600,0,0,384,8484,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,161:6:0 0,12,146:4:0 +17 3284 . T 0 . DP=21;I16=10,11,0,0,748,27628,0,0,1260,75600,0,0,385,8511,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,155:6:0 0,12,146:4:0 +17 3285 . C 0 . DP=21;I16=10,11,0,0,776,29442,0,0,1260,75600,0,0,386,8560,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,169:6:0 0,12,143:4:0 +17 3286 . A 0 . DP=21;I16=10,11,0,0,826,32732,0,0,1260,75600,0,0,387,8631,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,187:6:0 0,12,153:4:0 +17 3287 . G 0 . DP=21;I16=10,11,0,0,804,31448,0,0,1260,75600,0,0,387,8673,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,164:6:0 0,12,150:4:0 +17 3288 . G 0 . DP=22;I16=10,11,0,0,754,27862,0,0,1260,75600,0,0,379,8635,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,141:5:0 0,15,164:5:0 +17 3289 . A 0 . DP=24;I16=13,11,0,0,897,34439,0,0,1440,86400,0,0,386,8714,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,166:6:0 0,15,178:5:0 +17 3290 . G 0 . DP=23;I16=12,10,0,0,832,31964,0,0,1320,79200,0,0,380,8684,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,112:4:0 0,15,168:5:0 +17 3291 . T 0 . DP=22;I16=11,9,0,0,707,25481,0,0,1200,72000,0,0,358,8112,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,9,95:3:0 0,15,168:5:0 +17 3292 . T 0 . DP=22;I16=13,9,0,0,783,28439,0,0,1320,79200,0,0,397,8929,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,127:5:0 0,15,164:5:0 +17 3293 . C 0 . DP=22;I16=13,9,0,0,852,33430,0,0,1320,79200,0,0,400,8992,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,136:5:0 0,15,170:5:0 +17 3294 . A 0 . DP=22;I16=13,9,0,0,818,30684,0,0,1320,79200,0,0,403,9077,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,145:5:0 0,15,162:5:0 +17 3295 . A 0 . DP=22;I16=14,8,0,0,820,31004,0,0,1320,79200,0,0,407,9183,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,140:5:0 0,12,143:4:0 +17 3296 . G 0 . DP=22;I16=14,8,0,0,837,32209,0,0,1320,79200,0,0,411,9259,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,133:5:0 0,12,140:4:0 +17 3297 . A 0 . DP=22;I16=14,8,0,0,787,28771,0,0,1320,79200,0,0,415,9355,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,134:5:0 0,12,140:4:0 +17 3298 . C 0 . DP=22;I16=13,9,0,0,826,31506,0,0,1320,79200,0,0,420,9470,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,113:4:0 0,12,135:4:0 +17 3299 . C 0 . DP=22;I16=13,9,0,0,857,33829,0,0,1320,79200,0,0,425,9553,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,117:4:0 0,12,140:4:0 +17 3300 . A 0 . DP=22;I16=13,9,0,0,861,33855,0,0,1320,79200,0,0,430,9654,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,134:4:0 0,12,144:4:0 +17 3301 . G 0 . DP=22;I16=13,9,0,0,869,34495,0,0,1320,79200,0,0,433,9675,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,131:4:0 0,12,141:4:0 +17 3302 . C 0 . DP=23;I16=14,9,0,0,863,32885,0,0,1380,82800,0,0,436,9718,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,115:4:0 0,15,155:5:0 +17 3303 . C 0 . DP=23;I16=14,9,0,0,887,34451,0,0,1380,82800,0,0,440,9784,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,125:4:0 0,15,153:5:0 +17 3304 . T 0 . DP=23;I16=14,9,0,0,886,34388,0,0,1380,82800,0,0,443,9825,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,134:4:0 0,15,167:5:0 +17 3305 . G 0 . DP=23;I16=14,9,0,0,878,33846,0,0,1380,82800,0,0,446,9892,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,119:4:0 0,15,151:5:0 +17 3306 . G 0 . DP=23;I16=14,9,0,0,886,34386,0,0,1380,82800,0,0,448,9934,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,127:4:0 0,15,150:5:0 +17 3307 . C 0 . DP=23;I16=14,8,0,0,812,30814,0,0,1320,79200,0,0,428,9508,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,116:4:0 0,15,153:5:0 +17 3308 . C 0 . DP=23;I16=14,9,0,0,835,31367,0,0,1380,82800,0,0,450,9986,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,118:4:0 0,15,151:5:0 +17 3309 . A 0 . DP=23;I16=14,9,0,0,875,33541,0,0,1380,82800,0,0,451,9995,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,128:4:0 0,15,162:5:0 +17 3310 . A 0 . DP=24;I16=15,9,0,0,882,32950,0,0,1440,86400,0,0,453,10027,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,152:5:0 0,15,164:5:0 +17 3311 . C 0 . DP=24;I16=15,9,0,0,913,35161,0,0,1440,86400,0,0,456,10084,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,145:5:0 0,15,157:5:0 +17 3312 . A 0 . DP=26;I16=16,9,0,0,950,36336,0,0,1500,90000,0,0,459,10167,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,153:5:0 0,15,160:5:0 +17 3313 . T 0 . DP=26;I16=16,10,0,0,987,37617,0,0,1560,93600,0,0,488,10902,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,180:6:0 0,15,161:5:0 +17 3314 . G 0 . DP=26;I16=16,10,0,0,1007,39401,0,0,1560,93600,0,0,491,10989,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,171:6:0 0,15,161:5:0 +17 3315 . G 0 . DP=26;I16=15,10,0,0,945,36073,0,0,1500,90000,0,0,484,10866,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,172:6:0 0,15,159:5:0 +17 3316 . T 0 . DP=26;I16=15,10,0,0,853,29881,0,0,1500,90000,0,0,464,10216,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,157:6:0 0,12,122:4:0 +17 3317 . G 0 . DP=27;I16=16,11,0,0,997,37431,0,0,1620,97200,0,0,488,10806,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,164:6:0 0,18,167:6:0 +17 3318 . A 0 . DP=26;I16=15,10,0,0,904,33212,0,0,1500,90000,0,0,481,10699,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,155:5:0 0,18,185:6:0 +17 3319 . A 0 . DP=25;I16=15,10,0,0,912,34090,0,0,1500,90000,0,0,482,10682,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,139:5:0 0,18,188:6:0 +17 3320 . A 0 . DP=25;I16=15,10,0,0,888,32722,0,0,1500,90000,0,0,483,10691,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,133:5:0 0,18,178:6:0 +17 3321 . C 0 . DP=25;I16=14,10,0,0,900,34142,0,0,1440,86400,0,0,471,10531,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,157:5:0 0,18,186:6:0 +17 3322 . C 0 . DP=25;I16=15,10,0,0,980,38582,0,0,1500,90000,0,0,483,10683,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,164:5:0 0,18,198:6:0 +17 3323 . C 0 . DP=25;I16=15,10,0,0,922,34948,0,0,1500,90000,0,0,483,10715,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,146:5:0 0,18,201:6:0 +17 3324 . C 0 . DP=25;I16=15,10,0,0,869,31271,0,0,1500,90000,0,0,482,10720,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,142:5:0 0,18,186:6:0 +17 3325 . G 0 . DP=25;I16=15,10,0,0,827,28293,0,0,1500,90000,0,0,481,10747,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,134:5:0 0,18,163:6:0 +17 3326 . T 0 . DP=24;I16=13,10,0,0,842,31362,0,0,1380,82800,0,0,464,10506,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,150:5:0 0,18,186:6:0 +17 3327 . C 0 . DP=24;I16=14,10,0,0,938,37076,0,0,1440,86400,0,0,481,10863,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,154:5:0 0,18,190:6:0 +17 3328 . T 0 . DP=25;I16=15,10,0,0,959,37033,0,0,1500,90000,0,0,480,10900,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,163:5:0 0,21,213:7:0 +17 3329 . A 0 . DP=24;I16=15,9,0,0,888,33082,0,0,1440,86400,0,0,481,10955,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,149:5:0 0,21,207:7:0 +17 3330 . C 0 . DP=25;I16=16,9,0,0,954,37064,0,0,1500,90000,0,0,481,10979,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,168:5:0 0,21,203:7:0 +17 3331 . T 0 . DP=25;I16=16,9,0,0,960,37332,0,0,1500,90000,0,0,482,11024,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,165:5:0 0,21,224:7:0 +17 3332 . A 0 . DP=25;I16=16,9,0,0,933,35065,0,0,1500,90000,0,0,483,11091,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,165:5:0 0,21,211:7:0 +17 3333 . A 0 . DP=26;I16=16,10,0,0,976,37344,0,0,1560,93600,0,0,483,11131,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,166:5:0 0,24,241:8:0 +17 3334 . A 0 . DP=25;I16=15,10,0,0,972,38210,0,0,1500,90000,0,0,485,11195,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,168:5:0 0,24,241:8:0 +17 3335 . A 0 . DP=25;I16=15,10,0,0,970,38200,0,0,1500,90000,0,0,486,11232,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,170:5:0 0,24,239:8:0 +17 3336 . A 0 . DP=25;I16=15,10,0,0,929,35277,0,0,1500,90000,0,0,485,11191,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,166:5:0 0,24,232:8:0 +17 3337 . T 0 . DP=25;I16=15,10,0,0,902,32856,0,0,1500,90000,0,0,484,11172,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,157:5:0 0,24,224:8:0 +17 3338 . A 0 . DP=25;I16=15,10,0,0,892,32056,0,0,1500,90000,0,0,481,11075,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,153:5:0 0,24,214:8:0 +17 3339 . C 0 . DP=25;I16=15,10,0,0,964,37444,0,0,1500,90000,0,0,478,11000,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,167:5:0 0,24,232:8:0 +17 3340 . A 0 . DP=23;I16=14,9,0,0,890,34616,0,0,1380,82800,0,0,477,10945,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,173:5:0 0,24,233:8:0 +17 3341 . A 0 . DP=23;I16=14,9,0,0,885,34459,0,0,1380,82800,0,0,476,10908,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,167:5:0 0,24,238:8:0 +17 3342 . A 0 . DP=23;I16=14,9,0,0,862,33262,0,0,1380,82800,0,0,475,10889,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,170:5:0 0,24,240:8:0 +17 3343 . A 0 . DP=22;I16=13,9,0,0,866,34280,0,0,1320,79200,0,0,474,10836,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,173:5:0 0,21,231:7:0 +17 3344 . A 0 . DP=22;I16=13,9,0,0,859,33731,0,0,1320,79200,0,0,473,10797,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,173:5:0 0,21,226:7:0 +17 3345 . T 0 . DP=22;I16=13,9,0,0,822,31100,0,0,1320,79200,0,0,472,10772,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,254:10:0 0,15,159:5:0 0,21,220:7:0 +17 3346 . T 0 . DP=22;I16=13,9,0,0,847,32679,0,0,1320,79200,0,0,470,10712,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,168:5:0 0,21,221:7:0 +17 3347 . A 0 . DP=23;I16=14,9,0,0,888,34650,0,0,1380,82800,0,0,468,10668,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,185:6:0 0,21,227:7:0 +17 3348 . G 0 . DP=23;I16=14,9,0,0,873,33609,0,0,1380,82800,0,0,467,10641,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,171:6:0 0,21,219:7:0 +17 3349 . C 0 . DP=24;I16=14,9,0,0,815,29785,0,0,1380,82800,0,0,465,10583,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,166:6:0 0,21,205:7:0 +17 3350 . C 0 . DP=24;I16=14,10,0,0,939,37249,0,0,1440,86400,0,0,464,10546,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,209:7:0 0,21,220:7:0 +17 3351 . T 0 . DP=24;I16=14,10,0,0,943,37255,0,0,1440,86400,0,0,463,10531,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,210:7:0 0,21,228:7:0 +17 3352 . G 0 . DP=24;I16=14,10,0,0,887,33267,0,0,1440,86400,0,0,462,10538,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,192:7:0 0,21,214:7:0 +17 3353 . G 0 . DP=24;I16=14,10,0,0,864,32092,0,0,1440,86400,0,0,461,10567,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,190:7:0 0,21,214:7:0 +17 3354 . C 0 . DP=24;I16=14,10,0,0,848,30714,0,0,1440,86400,0,0,459,10567,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,178:7:0 0,21,209:7:0 +17 3355 . G 0 . DP=23;I16=14,9,0,0,738,24386,0,0,1380,82800,0,0,457,10537,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,232:10:0 0,21,170:7:0 0,18,166:6:0 +17 3356 . T 0 . DP=23;I16=14,9,0,0,847,31689,0,0,1380,82800,0,0,454,10476,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,191:7:0 0,18,195:6:0 +17 3357 . G 0 . DP=23;I16=14,9,0,0,863,32919,0,0,1380,82800,0,0,449,10335,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,193:7:0 0,18,192:6:0 +17 3358 . G 0 . DP=22;I16=14,8,0,0,810,30184,0,0,1320,79200,0,0,445,10215,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,239:9:0 0,21,200:7:0 0,18,187:6:0 +17 3359 . T 0 . DP=23;I16=13,8,0,0,743,26737,0,0,1260,75600,0,0,404,9318,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,228:9:0 0,21,194:7:0 0,15,162:5:0 +17 3360 . G 0 . DP=23;I16=15,8,0,0,822,30058,0,0,1380,82800,0,0,436,9932,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,186:7:0 0,18,175:6:0 +17 3361 . G 0 . DP=22;I16=15,7,0,0,751,26793,0,0,1320,79200,0,0,433,9819,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,218:9:0 0,21,187:7:0 0,18,175:6:0 +17 3362 . C 0 . DP=22;I16=15,7,0,0,768,27462,0,0,1320,79200,0,0,430,9724,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,230:9:0 0,21,178:7:0 0,18,173:6:0 +17 3363 . G 0 . DP=21;I16=14,7,0,0,662,21572,0,0,1260,75600,0,0,428,9646,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,194:9:0 0,18,155:6:0 0,18,161:6:0 +17 3364 . C 0 . DP=21;I16=14,7,0,0,818,32184,0,0,1260,75600,0,0,423,9437,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,241:9:0 0,18,191:6:0 0,18,194:6:0 +17 3365 . A 0 . DP=21;I16=14,7,0,0,791,29983,0,0,1260,75600,0,0,418,9250,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,226:9:0 0,18,186:6:0 0,18,190:6:0 +17 3366 . T 0 . DP=21;I16=14,7,0,0,759,28053,0,0,1260,75600,0,0,413,9085,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,221:9:0 0,18,185:6:0 0,18,177:6:0 +17 3367 . G 0 . DP=21;I16=14,7,0,0,767,28539,0,0,1260,75600,0,0,408,8942,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,235:9:0 0,18,185:6:0 0,18,169:6:0 +17 3368 . C 0 . DP=21;I16=14,7,0,0,807,31329,0,0,1260,75600,0,0,403,8821,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,245:9:0 0,18,181:6:0 0,18,189:6:0 +17 3369 . C 0 . DP=21;I16=14,7,0,0,789,30271,0,0,1260,75600,0,0,398,8722,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,228:9:0 0,18,186:6:0 0,18,193:6:0 +17 3370 . T 0 . DP=21;I16=13,7,0,0,798,31960,0,0,1200,72000,0,0,392,8596,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,239:9:0 0,18,201:6:0 0,15,178:5:0 +17 3371 . G 0 . DP=20;I16=13,7,0,0,739,27875,0,0,1200,72000,0,0,387,8493,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,233:9:0 0,18,173:6:0 0,15,169:5:0 +17 3372 . T 0 . DP=20;I16=13,6,0,0,693,25677,0,0,1140,68400,0,0,359,7883,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,220:9:0 0,15,154:5:0 0,15,167:5:0 +17 3373 . A 0 . DP=20;I16=13,7,0,0,729,27019,0,0,1200,72000,0,0,375,8253,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,226:9:0 0,18,162:6:0 0,15,174:5:0 +17 3374 . A 0 . DP=19;I16=13,6,0,0,719,27437,0,0,1140,68400,0,0,369,8115,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,225:9:0 0,15,167:5:0 0,15,164:5:0 +17 3375 . T 0 . DP=20;I16=12,6,0,0,683,26039,0,0,1080,64800,0,0,337,7321,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,221:8:0 0,15,155:5:0 0,15,172:5:0 +17 3376 . C 0 . DP=20;I16=13,7,0,0,739,27867,0,0,1200,72000,0,0,356,7796,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,254:10:0 0,15,146:5:0 0,15,173:5:0 +17 3377 . C 0 . DP=20;I16=13,7,0,0,741,27905,0,0,1200,72000,0,0,350,7666,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,252:10:0 0,15,149:5:0 0,15,173:5:0 +17 3378 . C 0 . DP=20;I16=13,7,0,0,775,30179,0,0,1200,72000,0,0,343,7507,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,15,161:5:0 0,15,172:5:0 +17 3379 . A 0 . DP=20;I16=13,7,0,0,736,27530,0,0,1200,72000,0,0,336,7370,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,245:10:0 0,15,157:5:0 0,15,169:5:0 +17 3380 . G 0 . DP=19;I16=13,6,0,0,729,28249,0,0,1140,68400,0,0,330,7254,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,233:9:0 0,15,157:5:0 0,15,178:5:0 +17 3381 . C 0 . DP=19;I16=13,6,0,0,742,29288,0,0,1140,68400,0,0,324,7158,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,241:9:0 0,15,155:5:0 0,15,178:5:0 +17 3382 . T 0 . DP=17;I16=12,5,0,0,649,25245,0,0,1020,61200,0,0,320,7080,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,222:9:0 0,9,105:3:0 0,15,184:5:0 +17 3383 . A 0 . DP=17;I16=12,4,0,0,556,19808,0,0,960,57600,0,0,291,6393,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,196:9:0 0,6,71:2:0 0,15,167:5:0 +17 3384 . C 0 . DP=19;I16=14,5,0,0,701,26181,0,0,1140,68400,0,0,311,6923,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,235:10:0 0,9,98:3:0 0,18,187:6:0 +17 3385 . T 0 . DP=19;I16=14,5,0,0,730,28456,0,0,1140,68400,0,0,307,6797,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,237:10:0 0,9,109:3:0 0,18,195:6:0 +17 3386 . T 0 . DP=19;I16=14,5,0,0,642,22450,0,0,1140,68400,0,0,302,6642,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,197:10:0 0,9,104:3:0 0,18,188:6:0 +17 3387 . G 0 . DP=20;I16=14,6,0,0,723,26761,0,0,1200,72000,0,0,296,6460,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,230:10:0 0,9,105:3:0 0,21,210:7:0 +17 3388 . G 0 . DP=20;I16=14,6,0,0,705,25891,0,0,1200,72000,0,0,291,6303,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,225:10:0 0,9,109:3:0 0,21,202:7:0 +17 3389 . G 0 . DP=18;I16=10,7,0,0,617,22635,0,0,1020,61200,0,0,270,5808,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,190:7:0 0,9,105:3:0 0,21,207:7:0 +17 3390 . A 0 . DP=18;I16=11,7,0,0,631,22681,0,0,1080,64800,0,0,288,6056,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,200:8:0 0,9,105:3:0 0,21,198:7:0 +17 3391 . A 0 . DP=18;I16=11,7,0,0,663,24951,0,0,1080,64800,0,0,287,5965,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,192:8:0 0,9,113:3:0 0,21,224:7:0 +17 3392 . G 0 . DP=18;I16=11,7,0,0,666,25104,0,0,1080,64800,0,0,286,5896,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,211:8:0 0,9,103:3:0 0,21,216:7:0 +17 3393 . C 0 . DP=18;I16=11,7,0,0,686,26472,0,0,1080,64800,0,0,284,5800,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,222:8:0 0,9,106:3:0 0,21,214:7:0 +17 3394 . T 0 . DP=18;I16=11,7,0,0,699,27481,0,0,1080,64800,0,0,282,5728,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,219:8:0 0,9,114:3:0 0,21,222:7:0 +17 3395 . G 0 . DP=17;I16=10,7,0,0,656,25512,0,0,1020,61200,0,0,281,5679,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,205:7:0 0,9,105:3:0 0,21,222:7:0 +17 3396 . A 0 . DP=17;I16=10,7,0,0,644,25446,0,0,1020,61200,0,0,280,5652,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,182:7:0 0,9,119:3:0 0,21,232:7:0 +17 3397 . G 0 . DP=17;I16=10,7,0,0,633,23895,0,0,1020,61200,0,0,279,5647,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,193:7:0 0,9,107:3:0 0,21,218:7:0 +17 3398 . G 0 . DP=16;I16=10,6,0,0,610,23380,0,0,960,57600,0,0,279,5663,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,170:6:0 0,9,110:3:0 0,21,215:7:0 +17 3399 . G 0 . DP=17;I16=10,6,0,0,585,21729,0,0,960,57600,0,0,270,5618,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,15,147:5:0 0,12,122:4:0 0,21,216:7:0 +17 3400 . A 0 . DP=17;I16=10,6,0,0,576,21400,0,0,960,57600,0,0,264,5500,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,15,136:5:0 0,12,131:4:0 0,21,213:7:0 +17 3401 . T 0 . DP=17;I16=11,6,0,0,605,22159,0,0,1020,61200,0,0,280,5784,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,146:6:0 0,12,131:4:0 0,21,216:7:0 +17 3402 . G 0 . DP=17;I16=11,6,0,0,638,24150,0,0,1020,61200,0,0,280,5832,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,172:6:0 0,12,130:4:0 0,21,213:7:0 +17 3403 . A 0 . DP=16;I16=9,6,0,0,579,22815,0,0,900,54000,0,0,276,5874,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,15,139:5:0 0,12,140:4:0 0,18,205:6:0 +17 3404 . G 0 . DP=16;I16=10,6,0,0,564,20652,0,0,960,57600,0,0,281,5935,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,148:6:0 0,12,131:4:0 0,18,186:6:0 +17 3405 . A 0 . DP=16;I16=10,6,0,0,560,20158,0,0,960,57600,0,0,281,5991,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,157:6:0 0,12,124:4:0 0,18,179:6:0 +17 3406 . A 0 . DP=16;I16=10,6,0,0,568,20556,0,0,960,57600,0,0,281,6067,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,150:6:0 0,12,129:4:0 0,18,186:6:0 +17 3407 . C 0 . DP=17;I16=11,6,0,0,591,21225,0,0,1020,61200,0,0,281,6163,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,178:7:0 0,12,106:4:0 0,18,183:6:0 +17 3408 . T 0 . DP=17;I16=11,6,0,0,632,23754,0,0,1020,61200,0,0,282,6280,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,177:7:0 0,12,133:4:0 0,18,189:6:0 +17 3409 . G 0 . DP=16;I16=10,6,0,0,599,22667,0,0,960,57600,0,0,283,6369,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,172:6:0 0,12,119:4:0 0,18,192:6:0 +17 3410 . C 0 . DP=16;I16=10,6,0,0,585,21685,0,0,960,57600,0,0,282,6378,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,174:6:0 0,12,126:4:0 0,18,176:6:0 +17 3411 . T 0 . DP=15;I16=9,6,0,0,578,22492,0,0,900,54000,0,0,282,6404,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,165:6:0 0,9,114:3:0 0,18,196:6:0 +17 3412 . T 0 . DP=15;I16=9,6,0,0,546,20202,0,0,900,54000,0,0,283,6445,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,15,148:5:0 0,12,120:4:0 0,18,189:6:0 +17 3413 . G 0 . DP=15;I16=9,6,0,0,559,21023,0,0,900,54000,0,0,283,6401,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,15,158:5:0 0,12,124:4:0 0,18,184:6:0 +17 3414 . A 0 . DP=15;I16=9,6,0,0,512,17878,0,0,900,54000,0,0,283,6373,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,15,148:5:0 0,12,116:4:0 0,18,166:6:0 +17 3415 . A 0 . DP=16;I16=9,7,0,0,544,19656,0,0,960,57600,0,0,282,6310,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,15,142:5:0 0,12,132:4:0 0,21,179:7:0 +17 3416 . C 0 . DP=16;I16=9,7,0,0,562,20168,0,0,960,57600,0,0,282,6262,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,15,143:5:0 0,12,127:4:0 0,21,191:7:0 +17 3417 . C 0 . DP=16;I16=9,7,0,0,566,20666,0,0,960,57600,0,0,282,6230,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,15,147:5:0 0,12,126:4:0 0,21,192:7:0 +17 3418 . T 0 . DP=17;I16=10,5,0,0,557,21637,0,0,900,54000,0,0,268,5988,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,15,150:5:0 0,15,148:5:0 0,15,176:5:0 +17 3419 . G 0 . DP=17;I16=10,7,0,0,594,21642,0,0,1020,61200,0,0,310,6836,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,161:6:0 0,15,140:5:0 0,18,190:6:0 +17 3420 . G 0 . DP=17;I16=10,7,0,0,596,21580,0,0,1020,61200,0,0,312,6850,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,172:6:0 0,15,132:5:0 0,18,188:6:0 +17 3421 . G 0 . DP=18;I16=10,8,0,0,633,22781,0,0,1049,62041,0,0,314,6880,0,0;QS=3,0;MQSB=0.906029;MQ0F=0 PL:DP:DV 0,21,184:7:0 0,15,138:5:0 0,18,191:6:0 +17 3422 . A 0 . DP=18;I16=9,8,0,0,576,20954,0,0,989,58441,0,0,302,6702,0,0;QS=3,0;MQSB=0.91051;MQ0F=0 PL:DP:DV 0,18,167:6:0 0,15,130:5:0 0,18,188:6:0 +17 3423 . G 0 . DP=18;I16=9,9,0,0,651,24391,0,0,1049,62041,0,0,305,6747,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,21,200:7:0 0,15,149:5:0 0,18,183:6:0 +17 3424 . G 0 . DP=18;I16=8,8,0,0,555,20175,0,0,929,54841,0,0,275,6105,0,0;QS=3,0;MQSB=0.915545;MQ0F=0 PL:DP:DV 0,18,161:6:0 0,15,141:5:0 0,15,169:5:0 +17 3425 . C 0 . DP=18;I16=9,8,0,0,594,21676,0,0,1020,61200,0,0,307,6779,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,168:6:0 0,15,142:5:0 0,18,186:6:0 +17 3426 . A 0 . DP=18;I16=9,8,0,0,633,23967,0,0,1020,61200,0,0,308,6774,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,172:6:0 0,15,151:5:0 0,18,202:6:0 +17 3427 . G 0 . DP=18;I16=9,9,0,0,655,24639,0,0,1049,62041,0,0,315,6823,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,21,209:7:0 0,15,144:5:0 0,18,184:6:0 +17 3428 . A 0 . DP=18;I16=9,7,0,0,573,21235,0,0,960,57600,0,0,305,6793,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,15,158:5:0 0,15,147:5:0 0,18,178:6:0 +17 3429 . C 0 . DP=17;I16=8,9,0,0,516,16610,0,0,989,58441,0,0,320,6930,0,0;QS=3,0;MQSB=0.928603;MQ0F=0 PL:DP:DV 0,21,176:7:0 0,15,125:5:0 0,15,124:5:0 +17 3430 . G 0 . DP=18;I16=9,9,0,0,539,17155,0,0,1049,62041,0,0,323,7011,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,24,181:8:0 0,15,113:5:0 0,15,144:5:0 +17 3431 . T 0 . DP=18;I16=9,9,0,0,651,24101,0,0,1049,62041,0,0,327,7111,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,24,210:8:0 0,15,139:5:0 0,15,166:5:0 +17 3432 . T 0 . DP=18;I16=8,9,0,0,577,20601,0,0,989,58441,0,0,306,6606,0,0;QS=3,0;MQSB=0.928603;MQ0F=0 PL:DP:DV 0,21,162:7:0 0,15,144:5:0 0,15,165:5:0 +17 3433 . G 0 . DP=18;I16=9,9,0,0,623,22589,0,0,1049,62041,0,0,334,7320,0,0;QS=3,0;MQSB=0.924089;MQ0F=0 PL:DP:DV 0,24,199:8:0 0,15,138:5:0 0,15,164:5:0 +17 3434 . C 0 . DP=18;I16=10,7,0,0,582,20838,0,0,1020,61200,0,0,324,7208,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,208:8:0 0,15,130:5:0 0,12,137:4:0 +17 3435 . A 0 . DP=18;I16=10,8,0,0,595,21619,0,0,1049,62041,0,0,341,7453,0,0;QS=3,0;MQSB=0.906029;MQ0F=0 PL:DP:DV 0,27,185:9:0 0,15,150:5:0 0,12,151:4:0 +17 3436 . G 0 . DP=18;I16=10,8,0,0,617,22277,0,0,1049,62041,0,0,345,7549,0,0;QS=3,0;MQSB=0.906029;MQ0F=0 PL:DP:DV 0,27,218:9:0 0,15,146:5:0 0,12,133:4:0 +17 3437 . T G, 0 . DP=18;I16=10,7,0,1,594,21168,16,256,1020,61200,29,841,333,7409,16,256;QS=2.94286,0.0571429,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.906029;BQB=1;MQ0F=0 PL:DP:DV 0,11,188,24,191,195:9:1 0,15,148,15,148,148:5:0 0,12,132,12,132,132:4:0 +17 3438 . G 0 . DP=18;I16=10,7,0,0,622,23296,0,0,1020,61200,0,0,335,7461,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,215:8:0 0,15,152:5:0 0,12,140:4:0 +17 3439 . A 0 . DP=18;I16=10,8,0,0,619,22965,0,0,1049,62041,0,0,355,7853,0,0;QS=3,0;MQSB=0.906029;MQ0F=0 PL:DP:DV 0,27,215:9:0 0,15,153:5:0 0,12,132:4:0 +17 3440 . G 0 . DP=18;I16=10,7,0,0,610,22660,0,0,1020,61200,0,0,339,7613,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,221:8:0 0,15,143:5:0 0,12,131:4:0 +17 3441 . C 0 . DP=18;I16=10,6,0,0,585,22165,0,0,960,57600,0,0,315,7037,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,226:8:0 0,15,140:5:0 0,9,115:3:0 +17 3442 . T 0 . DP=20;I16=11,9,0,0,670,24716,0,0,1138,66482,0,0,362,8166,0,0;QS=3,0;MQSB=0.997118;MQ0F=0 PL:DP:DV 0,33,248:11:0 0,15,143:5:0 0,12,128:4:0 +17 3443 . G 0 . DP=20;I16=11,9,0,0,708,26092,0,0,1138,66482,0,0,366,8288,0,0;QS=3,0;MQSB=0.997118;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,143:5:0 0,12,137:4:0 +17 3444 . A 0 . DP=20;I16=11,9,0,0,698,25978,0,0,1138,66482,0,0,369,8379,0,0;QS=3,0;MQSB=0.997118;MQ0F=0 PL:DP:DV 0,33,244:11:0 0,15,161:5:0 0,12,131:4:0 +17 3445 . G 0 . DP=20;I16=11,9,0,0,718,26590,0,0,1138,66482,0,0,372,8488,0,0;QS=3,0;MQSB=0.997118;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,153:5:0 0,12,132:4:0 +17 3446 . A 0 . DP=20;I16=10,8,0,0,635,23323,0,0,1049,62041,0,0,325,7365,0,0;QS=3,0;MQSB=0.938795;MQ0F=0 PL:DP:DV 0,27,222:9:0 0,15,154:5:0 0,12,131:4:0 +17 3447 . T 0 . DP=20;I16=11,8,0,0,669,24331,0,0,1109,65641,0,0,352,8084,0,0;QS=3,0;MQSB=0.946915;MQ0F=0 PL:DP:DV 0,30,230:10:0 0,15,150:5:0 0,12,137:4:0 +17 3448 . C 0 . DP=19;I16=10,8,0,0,641,23693,0,0,1049,62041,0,0,355,8193,0,0;QS=3,0;MQSB=0.938795;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,113:4:0 0,12,128:4:0 +17 3449 . A 0 . DP=19;I16=10,8,0,0,565,19185,0,0,1049,62041,0,0,357,8265,0,0;QS=3,0;MQSB=0.938795;MQ0F=0 PL:DP:DV 0,30,217:10:0 0,12,111:4:0 0,12,119:4:0 +17 3450 . C 0 . DP=18;I16=8,8,0,0,520,17846,0,0,898,52082,0,0,334,7674,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,30,229:10:0 0,6,70:2:0 0,12,106:4:0 +17 3451 . G 0 . DP=18;I16=10,7,0,0,528,17178,0,0,989,58441,0,0,361,8345,0,0;QS=3,0;MQSB=0.943335;MQ0F=0 PL:DP:DV 0,30,226:10:0 0,9,56:3:0 0,12,123:4:0 +17 3452 . C 0 . DP=18;I16=10,8,0,0,657,24597,0,0,1018,59282,0,0,388,9028,0,0;QS=3,0;MQSB=0.99606;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,84:3:0 0,12,128:4:0 +17 3453 . C 0 . DP=18;I16=10,8,0,0,663,24951,0,0,1018,59282,0,0,390,9098,0,0;QS=3,0;MQSB=0.99606;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,90:3:0 0,12,125:4:0 +17 3454 . A 0 . DP=18;I16=10,8,0,0,614,21898,0,0,1018,59282,0,0,392,9180,0,0;QS=3,0;MQSB=0.99606;MQ0F=0 PL:DP:DV 0,33,251:11:0 0,9,90:3:0 0,12,128:4:0 +17 3455 . C 0 . DP=18;I16=10,8,0,0,650,23968,0,0,1018,59282,0,0,394,9274,0,0;QS=3,0;MQSB=0.99606;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,90:3:0 0,12,127:4:0 +17 3456 . T 0 . DP=18;I16=10,8,0,0,607,21961,0,0,1018,59282,0,0,395,9329,0,0;QS=3,0;MQSB=0.99606;MQ0F=0 PL:DP:DV 0,33,243:11:0 0,9,88:3:0 0,12,135:4:0 +17 3457 . G 0 . DP=18;I16=9,7,0,0,549,19861,0,0,898,52082,0,0,346,8144,0,0;QS=3,0;MQSB=0.994413;MQ0F=0 PL:DP:DV 0,33,254:11:0 0,6,63:2:0 0,9,107:3:0 +17 3458 . C 0 . DP=18;I16=10,8,0,0,638,23236,0,0,1018,59282,0,0,397,9469,0,0;QS=3,0;MQSB=0.99606;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,81:3:0 0,12,125:4:0 +17 3459 . A C, 0 . DP=17;I16=9,7,0,1,520,18390,22,484,929,54841,29,841,372,8830,25,625;QS=2.92971,0.0702875,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.998843;BQB=1;MQ0F=0 PL:DP:DV 0,8,201,27,204,213:10:1 0,9,84,9,84,84:3:0 0,12,116,12,116,116:4:0 +17 3460 . C 0 . DP=17;I16=8,7,0,0,554,20952,0,0,869,51241,0,0,345,8103,0,0;QS=3,0;MQSB=0.921243;MQ0F=0 PL:DP:DV 0,27,244:9:0 0,6,65:2:0 0,12,131:4:0 +17 3461 . T 0 . DP=17;I16=9,7,0,0,591,22805,0,0,929,54841,0,0,368,8638,0,0;QS=3,0;MQSB=0.933674;MQ0F=0 PL:DP:DV 0,27,231:9:0 0,9,103:3:0 0,12,133:4:0 +17 3462 . C 0 . DP=18;I16=9,9,0,0,672,25486,0,0,1018,59282,0,0,391,9185,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,90:3:0 0,12,130:4:0 +17 3463 . C 0 . DP=18;I16=8,9,0,0,584,21458,0,0,958,55682,0,0,369,8671,0,0;QS=3,0;MQSB=0.998843;MQ0F=0 PL:DP:DV 0,30,244:10:0 0,9,86:3:0 0,12,132:4:0 +17 3464 . A 0 . DP=18;I16=9,9,0,0,628,23490,0,0,1018,59282,0,0,387,8973,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,244:11:0 0,9,96:3:0 0,12,142:4:0 +17 3465 . G 0 . DP=19;I16=9,9,0,0,642,24008,0,0,1018,59282,0,0,384,8842,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,91:3:0 0,12,135:4:0 +17 3466 . C 0 . DP=20;I16=9,10,0,0,682,25218,0,0,1047,60123,0,0,378,8588,0,0;QS=3,0;MQSB=0.904084;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,9,101:3:0 0,15,147:5:0 +17 3467 . C 0 . DP=20;I16=10,9,0,0,685,25919,0,0,1047,60123,0,0,397,9139,0,0;QS=3,0;MQSB=0.948064;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,12,115:4:0 0,15,154:5:0 +17 3468 . T 0 . DP=20;I16=10,9,0,0,672,25426,0,0,1047,60123,0,0,374,8410,0,0;QS=3,0;MQSB=0.948064;MQ0F=0 PL:DP:DV 0,30,246:10:0 0,12,126:4:0 0,15,164:5:0 +17 3469 . G 0 . DP=21;I16=10,11,0,0,788,30064,0,0,1167,67323,0,0,396,8924,0,0;QS=3,0;MQSB=0.914611;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,146:5:0 0,15,163:5:0 +17 3470 . G 0 . DP=22;I16=11,11,0,0,796,29754,0,0,1196,68164,0,0,393,8781,0,0;QS=3,0;MQSB=0.770381;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,131:5:0 0,15,161:5:0 +17 3471 . G 0 . DP=23;I16=12,11,0,0,801,29083,0,0,1256,71764,0,0,391,8657,0,0;QS=3,0;MQSB=0.811552;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,133:5:0 0,15,151:5:0 +17 3472 . C 0 . DP=23;I16=12,11,0,0,757,26535,0,0,1256,71764,0,0,390,8554,0,0;QS=3,0;MQSB=0.811552;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,145:5:0 0,15,136:5:0 +17 3473 . A 0 . DP=23;I16=11,11,0,0,777,28175,0,0,1196,68164,0,0,379,8373,0,0;QS=3,0;MQSB=0.770381;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,148:5:0 0,15,153:5:0 +17 3474 . A 0 . DP=23;I16=12,11,0,0,807,29181,0,0,1256,71764,0,0,388,8414,0,0;QS=3,0;MQSB=0.811552;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,150:5:0 0,15,155:5:0 +17 3475 . C 0 . DP=22;I16=12,10,0,0,737,25849,0,0,1196,68164,0,0,387,8327,0,0;QS=3,0;MQSB=0.838545;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,137:5:0 0,15,143:5:0 +17 3476 . A 0 . DP=22;I16=12,10,0,0,790,29312,0,0,1196,68164,0,0,386,8262,0,0;QS=3,0;MQSB=0.838545;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,149:5:0 0,15,154:5:0 +17 3477 . G 0 . DP=22;I16=11,10,0,0,755,28237,0,0,1136,64564,0,0,363,7735,0,0;QS=3,0;MQSB=0.799507;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,126:4:0 0,15,153:5:0 +17 3478 . A 0 . DP=25;I16=13,11,0,0,857,31637,0,0,1316,75364,0,0,384,8198,0,0;QS=3,0;MQSB=0.845496;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,167:6:0 0,18,190:6:0 +17 3479 . G 0 . DP=25;I16=12,10,0,0,783,28623,0,0,1227,70923,0,0,355,7701,0,0;QS=3,0;MQSB=0.613159;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,152:5:0 0,18,160:6:0 +17 3480 . T 0 . DP=25;I16=13,11,0,0,788,27124,0,0,1316,75364,0,0,393,8531,0,0;QS=3,0;MQSB=0.845496;MQ0F=0 PL:DP:DV 0,33,249:11:0 0,21,182:7:0 0,18,155:6:0 +17 3481 . A 0 . DP=25;I16=12,12,0,0,858,30884,0,0,1347,78123,0,0,397,8685,0,0;QS=3,0;MQSB=0.941765;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,194:7:0 0,15,148:5:0 +17 3482 . A 0 . DP=25;I16=13,12,0,0,927,35013,0,0,1376,78964,0,0,412,8942,0,0;QS=3,0;MQSB=0.822311;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,202:7:0 0,18,182:6:0 +17 3483 . G 0 . DP=25;I16=12,12,0,0,794,27410,0,0,1316,75364,0,0,412,9002,0,0;QS=3,0;MQSB=0.786628;MQ0F=0 PL:DP:DV 0,33,253:11:0 0,21,183:7:0 0,18,158:6:0 +17 3484 . A C, 0 . DP=24;I16=12,9,0,1,710,25220,14,196,1198,70082,60,3600,346,7514,25,625;QS=2.93665,0.0633484,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.804615;BQB=1;MQ0F=0 PL:DP:DV 0,30,227,30,227,227:10:0 0,7,156,18,159,162:7:1 0,15,133,15,133,133:5:0 +17 3485 . C 0 . DP=23;I16=11,11,0,0,766,27656,0,0,1196,68164,0,0,393,8573,0,0;QS=3,0;MQSB=0.770381;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,163:6:0 0,15,120:5:0 +17 3486 . T 0 . DP=24;I16=12,10,0,0,799,30529,0,0,1196,68164,0,0,398,8756,0,0;QS=3,0;MQSB=0.838545;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,198:7:0 0,15,128:5:0 +17 3487 . C 0 . DP=24;I16=10,11,0,0,724,27586,0,0,1167,67323,0,0,393,8905,0,0;QS=3,0;MQSB=0.914611;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,162:6:0 0,12,92:4:0 +17 3488 . T 0 . DP=24;I16=12,10,0,0,742,27454,0,0,1196,68164,0,0,429,9571,0,0;QS=3,0;MQSB=0.838545;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,172:7:0 0,12,98:4:0 +17 3489 . G 0 . DP=25;I16=13,11,0,0,778,28994,0,0,1285,72605,0,0,433,9675,0,0;QS=3,0;MQSB=0.97965;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,177:8:0 0,12,75:4:0 +17 3490 . T C, 0 . DP=27;I16=14,10,1,0,806,28886,25,625,1254,69846,60,3600,427,9659,12,144;QS=2.90775,0.0922509,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.962269;BQB=1;MQ0F=0 PL:DP:DV 0,39,255,39,255,255:13:0 0,2,168,24,171,183:9:1 0,9,85,9,85,85:3:0 +17 3491 . C 0 . DP=28;I16=15,11,0,0,864,31232,0,0,1405,79805,0,0,445,9903,0,0;QS=3,0;MQSB=0.753395;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,197:9:0 0,9,78:3:0 +17 3492 . T 0 . DP=28;I16=15,11,0,0,852,31516,0,0,1405,79805,0,0,452,9986,0,0;QS=3,0;MQSB=0.753395;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,212:9:0 0,9,96:3:0 +17 3493 . C 0 . DP=28;I16=15,12,0,0,891,32181,0,0,1434,80646,0,0,464,10124,0,0;QS=3,0;MQSB=0.908075;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,27,214:9:0 0,9,80:3:0 +17 3493 . CAAAAAAAAAAAAA CAAAAAAAAAAAA,CAAAAAAAAAAAAAA 0 . INDEL;IDV=2;IMF=0.125;DP=28;I16=9,9,0,2,443,11071,47,1129,1049,62041,89,4441,320,7120,30,650;QS=2.81818,0.0909091,0.0909091;VDB=0.504964;SGB=0.346553;MQSB=0.997118;MQ0F=0 PL:DP:DV 0,19,37,19,40,37:11:2 0,18,39,18,39,39:6:0 0,9,23,9,23,23:3:0 +17 3494 . A 0 . DP=30;I16=15,12,0,0,970,37408,0,0,1465,83405,0,0,440,9568,0,0;QS=3,0;MQSB=0.723173;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,220:9:0 0,12,117:4:0 +17 3495 . A 0 . DP=31;I16=15,13,0,0,966,36178,0,0,1525,87005,0,0,472,10270,0,0;QS=3,0;MQSB=0.695496;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,210:9:0 0,15,129:5:0 +17 3496 . A 0 . DP=31;I16=15,13,0,0,974,36928,0,0,1525,87005,0,0,477,10281,0,0;QS=3,0;MQSB=0.695496;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,207:9:0 0,15,138:5:0 +17 3497 . A 0 . DP=32;I16=14,14,0,0,1015,39525,0,0,1525,87005,0,0,460,9834,0,0;QS=3,0;MQSB=0.62781;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,208:8:0 0,18,148:6:0 +17 3498 . A 0 . DP=32;I16=14,14,0,0,982,37264,0,0,1556,89764,0,0,460,9628,0,0;QS=3,0;MQSB=0.813104;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,27,220:9:0 0,15,115:5:0 +17 3499 . A 0 . DP=32;I16=14,14,0,0,1024,40072,0,0,1525,87005,0,0,489,10267,0,0;QS=3,0;MQSB=0.62781;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,222:8:0 0,18,144:6:0 +17 3500 . A 0 . DP=31;I16=14,14,0,0,995,38097,0,0,1525,87005,0,0,494,10316,0,0;QS=3,0;MQSB=0.62781;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,214:8:0 0,18,150:6:0 +17 3501 . A 0 . DP=31;I16=14,14,0,0,1017,39845,0,0,1525,87005,0,0,499,10399,0,0;QS=3,0;MQSB=0.62781;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,221:8:0 0,18,149:6:0 +17 3502 . A 0 . DP=31;I16=14,14,0,0,1051,41955,0,0,1525,87005,0,0,504,10516,0,0;QS=3,0;MQSB=0.62781;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,223:8:0 0,18,154:6:0 +17 3503 . A 0 . DP=31;I16=14,14,0,0,1038,40832,0,0,1525,87005,0,0,509,10667,0,0;QS=3,0;MQSB=0.62781;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,229:8:0 0,18,155:6:0 +17 3504 . A 0 . DP=31;I16=14,14,0,0,1037,41235,0,0,1525,87005,0,0,512,10750,0,0;QS=3,0;MQSB=0.62781;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,229:8:0 0,18,145:6:0 +17 3505 . A 0 . DP=31;I16=14,14,0,0,1039,40959,0,0,1525,87005,0,0,514,10814,0,0;QS=3,0;MQSB=0.62781;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,24,233:8:0 0,18,156:6:0 +17 3506 . A 0 . DP=32;I16=11,13,0,0,889,34265,0,0,1378,80882,0,0,427,9079,0,0;QS=3,0;MQSB=0.998323;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,201:6:0 0,18,158:6:0 +17 3507 . T 0 . DP=31;I16=10,17,0,0,995,38431,0,0,1527,88923,0,0,493,10499,0,0;QS=3,0;MQSB=0.997168;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,187:6:0 0,18,153:6:0 +17 3508 . C 0 . DP=31;I16=10,17,0,0,997,40091,0,0,1527,88923,0,0,499,10675,0,0;QS=3,0;MQSB=0.997168;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,160:6:0 0,15,119:5:0 +17 3509 . A 0 . DP=30;I16=11,17,0,0,995,37147,0,0,1556,89764,0,0,529,11459,0,0;QS=3,0;MQSB=0.960952;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,175:6:0 0,15,125:5:0 +17 3510 . C A, 0 . DP=29;I16=9,17,1,0,959,37997,40,1600,1498,88082,29,841,483,10351,25,625;QS=2.95246,0.047541,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.997168;BQB=1;MQ0F=0 PL:DP:DV 0,19,255,45,255,255:16:1 0,18,150,18,150,150:6:0 0,15,119,15,119,119:5:0 +17 3511 . A 0 . DP=32;I16=11,17,0,0,923,33125,0,0,1587,92523,0,0,512,11150,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,169:6:0 0,15,115:5:0 +17 3512 . C 0 . DP=32;I16=10,18,0,0,1058,42208,0,0,1618,95282,0,0,493,10733,0,0;QS=3,0;MQSB=0.891417;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,181:6:0 0,15,131:5:0 +17 3513 . C A, 0 . DP=32;I16=10,18,1,0,1074,42406,13,169,1618,95282,29,841,498,10926,25,625;QS=2.98,0.02,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.995968;BQB=1;MQ0F=0 PL:DP:DV 0,39,255,51,255,255:18:1 0,18,190,18,190,190:6:0 0,15,136,15,136,136:5:0 +17 3514 . A 0 . DP=33;I16=11,19,0,0,1101,42213,0,0,1707,99723,0,0,528,11778,0,0;QS=3,0;MQSB=0.997918;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,199:7:0 0,15,132:5:0 +17 3515 . T 0 . DP=33;I16=12,19,0,0,1130,43380,0,0,1736,100564,0,0,557,12563,0,0;QS=3,0;MQSB=0.960505;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,192:7:0 0,15,126:5:0 +17 3516 . T 0 . DP=34;I16=14,17,0,0,1147,44331,0,0,1767,103323,0,0,536,12078,0,0;QS=3,0;MQSB=0.924242;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,203:7:0 0,15,133:5:0 +17 3517 . T 0 . DP=34;I16=14,18,0,0,1183,46549,0,0,1796,104164,0,0,565,12773,0,0;QS=3,0;MQSB=0.988522;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,21,210:7:0 0,15,153:5:0 +17 3518 . T 0 . DP=34;I16=14,18,0,0,1165,44867,0,0,1796,104164,0,0,568,12826,0,0;QS=3,0;MQSB=0.988522;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,21,203:7:0 0,15,141:5:0 +17 3519 . G 0 . DP=33;I16=13,18,0,0,1158,46678,0,0,1736,100564,0,0,572,12912,0,0;QS=3,0;MQSB=0.980167;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,18,189:6:0 0,15,154:5:0 +17 3520 . G 0 . DP=33;I16=12,18,0,0,1111,42471,0,0,1707,99723,0,0,552,12438,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,183:6:0 0,15,151:5:0 +17 3521 . C 0 . DP=32;I16=11,17,0,0,1077,43755,0,0,1649,98041,0,0,530,11850,0,0;QS=3,0;MQSB=0.967085;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,185:6:0 0,15,143:5:0 +17 3522 . T 0 . DP=32;I16=12,17,0,0,1125,46329,0,0,1678,98882,0,0,552,12274,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,199:6:0 0,15,158:5:0 +17 3523 . T 0 . DP=31;I16=11,16,0,0,996,38204,0,0,1558,91682,0,0,544,12286,0,0;QS=3,0;MQSB=0.992419;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,193:6:0 0,15,145:5:0 +17 3524 . C 0 . DP=31;I16=11,16,0,0,1067,43883,0,0,1589,94441,0,0,538,11960,0,0;QS=3,0;MQSB=0.96384;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,192:6:0 0,15,152:5:0 +17 3525 . A 0 . DP=31;I16=13,16,0,0,1132,46402,0,0,1678,98882,0,0,556,12250,0,0;QS=3,0;MQSB=0.997839;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,200:6:0 0,15,165:5:0 +17 3526 . G 0 . DP=31;I16=12,16,0,0,1090,43912,0,0,1649,98041,0,0,543,12053,0,0;QS=3,0;MQSB=0.96195;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,181:6:0 0,15,147:5:0 +17 3527 . A 0 . DP=31;I16=13,16,0,0,1068,41740,0,0,1678,98882,0,0,560,12334,0,0;QS=3,0;MQSB=0.997839;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,170:6:0 0,15,157:5:0 +17 3528 . T 0 . DP=31;I16=13,16,0,0,1076,41782,0,0,1678,98882,0,0,561,12369,0,0;QS=3,0;MQSB=0.997839;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,193:6:0 0,15,152:5:0 +17 3529 . T 0 . DP=31;I16=12,16,0,0,1016,38674,0,0,1649,98041,0,0,550,12290,0,0;QS=3,0;MQSB=0.96195;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,184:6:0 0,15,154:5:0 +17 3530 . G 0 . DP=30;I16=12,17,0,0,1070,40570,0,0,1709,101641,0,0,578,13032,0,0;QS=3,0;MQSB=0.965321;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,176:6:0 0,18,175:6:0 +17 3531 . C A, 0 . DP=31;I16=13,17,1,0,1080,40304,38,1444,1738,102482,29,841,607,13801,10,100;QS=2.95773,0.0422741,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.924242;BQB=1;MQ0F=0 PL:DP:DV 0,28,255,54,255,255:19:1 0,18,172,18,172,172:6:0 0,18,175,18,175,175:6:0 +17 3532 . A 0 . DP=31;I16=14,17,0,0,1136,42380,0,0,1767,103323,0,0,619,14003,0,0;QS=3,0;MQSB=0.924242;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,180:6:0 0,18,184:6:0 +17 3533 . T 0 . DP=31;I16=13,17,0,0,1074,39206,0,0,1738,102482,0,0,595,13457,0,0;QS=3,0;MQSB=0.996503;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,180:6:0 0,18,176:6:0 +17 3534 . A 0 . DP=30;I16=12,17,0,0,1014,36168,0,0,1678,98882,0,0,597,13561,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,165:6:0 0,18,175:6:0 +17 3535 . T 0 . DP=31;I16=14,17,0,0,1042,36456,0,0,1767,103323,0,0,624,14314,0,0;QS=3,0;MQSB=0.924242;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,162:6:0 0,18,164:6:0 +17 3536 . C 0 . DP=31;I16=13,17,0,0,1102,41182,0,0,1738,102482,0,0,602,13842,0,0;QS=3,0;MQSB=0.996503;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,178:6:0 0,18,180:6:0 +17 3537 . C 0 . DP=32;I16=13,17,0,0,1142,43828,0,0,1769,105241,0,0,598,13854,0,0;QS=3,0;MQSB=0.963674;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,194:7:0 0,18,185:6:0 +17 3538 . T 0 . DP=32;I16=14,17,0,0,1151,43471,0,0,1798,106082,0,0,603,13923,0,0;QS=3,0;MQSB=0.998229;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,211:7:0 0,18,185:6:0 +17 3539 . C 0 . DP=32;I16=12,17,0,0,1077,40959,0,0,1709,101641,0,0,600,13994,0,0;QS=3,0;MQSB=0.965321;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,170:6:0 0,18,173:6:0 +17 3540 . C 0 . DP=31;I16=13,17,0,0,1134,43546,0,0,1769,105241,0,0,603,14055,0,0;QS=3,0;MQSB=0.963674;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,209:7:0 0,18,172:6:0 +17 3541 . T 0 . DP=32;I16=13,18,0,0,1143,42901,0,0,1829,108841,0,0,604,14134,0,0;QS=3,0;MQSB=0.966712;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,224:8:0 0,18,187:6:0 +17 3542 . G 0 . DP=32;I16=13,18,0,0,1152,43714,0,0,1829,108841,0,0,604,14134,0,0;QS=3,0;MQSB=0.966712;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,223:8:0 0,18,172:6:0 +17 3543 . C 0 . DP=31;I16=13,17,0,0,1142,43818,0,0,1769,105241,0,0,605,14153,0,0;QS=3,0;MQSB=0.963674;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,221:8:0 0,18,188:6:0 +17 3544 . A 0 . DP=31;I16=13,17,0,0,1089,40065,0,0,1769,105241,0,0,606,14190,0,0;QS=3,0;MQSB=0.963674;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,221:8:0 0,18,173:6:0 +17 3545 . A 0 . DP=30;I16=13,16,0,0,1118,43688,0,0,1709,101641,0,0,607,14195,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,228:7:0 0,18,196:6:0 +17 3546 . G 0 . DP=30;I16=14,16,0,0,1131,43425,0,0,1738,102482,0,0,630,14698,0,0;QS=3,0;MQSB=0.999136;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,206:7:0 0,18,179:6:0 +17 3547 . G 0 . DP=31;I16=13,17,0,0,1076,39798,0,0,1769,105241,0,0,607,14163,0,0;QS=3,0;MQSB=0.963674;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,189:7:0 0,18,187:6:0 +17 3548 . A 0 . DP=31;I16=13,17,0,0,1071,39059,0,0,1769,105241,0,0,608,14178,0,0;QS=3,0;MQSB=0.963674;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,208:7:0 0,18,179:6:0 +17 3549 . T 0 . DP=30;I16=13,16,0,0,1008,35928,0,0,1678,98882,0,0,605,13989,0,0;QS=3,0;MQSB=0.997839;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,180:6:0 0,15,152:5:0 +17 3550 . A 0 . DP=30;I16=13,16,0,0,1061,39371,0,0,1709,101641,0,0,612,14270,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,194:7:0 0,15,173:5:0 +17 3551 . T 0 . DP=30;I16=13,16,0,0,1026,36844,0,0,1709,101641,0,0,613,14295,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,192:7:0 0,15,162:5:0 +17 3552 . A 0 . DP=30;I16=14,16,0,0,1080,39588,0,0,1738,102482,0,0,631,14627,0,0;QS=3,0;MQSB=0.999136;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,202:7:0 0,15,158:5:0 +17 3553 . T A, 0 . DP=30;I16=13,16,1,0,1047,38333,20,400,1709,101641,29,841,616,14398,16,256;QS=2.96795,0.0320513,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.999136;BQB=1;MQ0F=0 PL:DP:DV 0,34,255,51,255,255:18:1 0,18,178,18,178,178:6:0 0,18,183,18,183,183:6:0 +17 3554 . A 0 . DP=30;I16=14,16,0,0,1063,38413,0,0,1738,102482,0,0,632,14602,0,0;QS=3,0;MQSB=0.999136;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,185:6:0 0,18,179:6:0 +17 3555 . C 0 . DP=30;I16=14,16,0,0,1021,35781,0,0,1738,102482,0,0,632,14574,0,0;QS=3,0;MQSB=0.999136;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,169:6:0 0,18,163:6:0 +17 3556 . G 0 . DP=30;I16=13,16,0,0,1014,36426,0,0,1709,101641,0,0,618,14350,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,168:6:0 0,18,173:6:0 +17 3557 . C 0 . DP=31;I16=14,16,0,0,1001,34919,0,0,1769,105241,0,0,618,14342,0,0;QS=3,0;MQSB=0.958545;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,140:6:0 0,18,165:6:0 +17 3558 . G 0 . DP=31;I16=15,16,0,0,1036,35974,0,0,1798,106082,0,0,630,14476,0,0;QS=3,0;MQSB=0.999805;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,159:6:0 0,18,171:6:0 +17 3559 . T 0 . DP=30;I16=14,16,0,0,1086,40202,0,0,1769,105241,0,0,619,14341,0,0;QS=3,0;MQSB=0.958545;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,171:6:0 0,18,192:6:0 +17 3560 . G 0 . DP=31;I16=14,16,0,0,1151,45035,0,0,1738,102482,0,0,611,14127,0,0;QS=3,0;MQSB=0.999136;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,165:5:0 0,18,194:6:0 +17 3561 . A 0 . DP=31;I16=15,16,0,0,1147,43431,0,0,1798,106082,0,0,626,14366,0,0;QS=3,0;MQSB=0.999805;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,186:6:0 0,18,196:6:0 +17 3562 . A 0 . DP=31;I16=16,15,0,0,1157,43859,0,0,1798,106082,0,0,623,14257,0,0;QS=3,0;MQSB=0.999805;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,192:6:0 0,21,213:7:0 +17 3563 . A 0 . DP=31;I16=16,15,0,0,1162,44010,0,0,1798,106082,0,0,620,14124,0,0;QS=3,0;MQSB=0.999805;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,192:6:0 0,21,216:7:0 +17 3564 . T 0 . DP=31;I16=15,15,0,0,1132,43298,0,0,1769,105241,0,0,610,13932,0,0;QS=3,0;MQSB=0.952765;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,192:6:0 0,21,214:7:0 +17 3565 . T 0 . DP=32;I16=16,16,0,0,1163,42649,0,0,1858,109682,0,0,611,13791,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,189:6:0 0,21,212:7:0 +17 3566 . C 0 . DP=32;I16=16,16,0,0,1162,43586,0,0,1858,109682,0,0,606,13596,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,181:6:0 0,21,209:7:0 +17 3567 . A 0 . DP=32;I16=15,16,0,0,1181,45245,0,0,1829,108841,0,0,597,13375,0,0;QS=3,0;MQSB=0.957006;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,192:6:0 0,21,222:7:0 +17 3568 . A 0 . DP=32;I16=15,16,0,0,1194,46670,0,0,1829,108841,0,0,592,13200,0,0;QS=3,0;MQSB=0.957006;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,204:6:0 0,21,228:7:0 +17 3569 . G 0 . DP=31;I16=15,16,0,0,1164,44544,0,0,1829,108841,0,0,586,13006,0,0;QS=3,0;MQSB=0.957006;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,180:6:0 0,21,204:7:0 +17 3570 . T 0 . DP=30;I16=14,15,0,0,1029,37527,0,0,1709,101641,0,0,572,12730,0,0;QS=3,0;MQSB=0.954405;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,12,136:4:0 0,21,213:7:0 +17 3571 . C 0 . DP=28;I16=13,15,0,0,1066,41192,0,0,1649,98041,0,0,568,12564,0,0;QS=3,0;MQSB=0.956162;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,138:4:0 0,21,215:7:0 +17 3572 . A 0 . DP=29;I16=13,16,0,0,1108,42566,0,0,1709,101641,0,0,564,12426,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,172:5:0 0,21,218:7:0 +17 3573 . A 0 . DP=29;I16=13,16,0,0,1119,43403,0,0,1709,101641,0,0,558,12168,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,174:5:0 0,21,220:7:0 +17 3574 . T 0 . DP=29;I16=13,16,0,0,1104,42220,0,0,1709,101641,0,0,552,11942,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,175:5:0 0,21,218:7:0 +17 3575 . G 0 . DP=29;I16=13,16,0,0,1122,43748,0,0,1709,101641,0,0,546,11748,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,161:5:0 0,21,212:7:0 +17 3576 . A 0 . DP=29;I16=13,16,0,0,1043,38405,0,0,1709,101641,0,0,540,11586,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,170:5:0 0,21,213:7:0 +17 3577 . C 0 . DP=30;I16=13,17,0,0,1123,42529,0,0,1769,105241,0,0,534,11456,0,0;QS=3,0;MQSB=0.963674;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,161:5:0 0,21,211:7:0 +17 3578 . A 0 . DP=30;I16=13,17,0,0,1148,44236,0,0,1769,105241,0,0,529,11359,0,0;QS=3,0;MQSB=0.963674;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,178:5:0 0,21,216:7:0 +17 3579 . A 0 . DP=29;I16=13,16,0,0,1051,38961,0,0,1709,101641,0,0,524,11244,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,172:5:0 0,18,192:6:0 +17 3580 . A 0 . DP=29;I16=13,16,0,0,1104,42344,0,0,1709,101641,0,0,519,11159,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,172:5:0 0,18,201:6:0 +17 3581 . T 0 . DP=29;I16=13,16,0,0,1088,41226,0,0,1709,101641,0,0,513,11055,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,161:5:0 0,18,199:6:0 +17 3582 . C 0 . DP=29;I16=13,16,0,0,1120,43616,0,0,1709,101641,0,0,506,10934,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,172:5:0 0,18,201:6:0 +17 3583 . A 0 . DP=30;I16=14,16,0,0,1130,43606,0,0,1769,105241,0,0,498,10796,0,0;QS=3,0;MQSB=0.958545;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,183:5:0 0,21,213:7:0 +17 3584 . G 0 . DP=29;I16=12,16,0,0,1027,38895,0,0,1649,98041,0,0,487,10665,0,0;QS=3,0;MQSB=0.96195;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,137:4:0 0,21,209:7:0 +17 3585 . A 0 . DP=31;I16=14,17,0,0,1057,37719,0,0,1829,108841,0,0,486,10616,0,0;QS=3,0;MQSB=0.962133;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,168:5:0 0,24,209:8:0 +17 3586 . A 0 . DP=30;I16=14,15,0,0,1053,40043,0,0,1709,101641,0,0,477,10461,0,0;QS=3,0;MQSB=0.954405;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,174:5:0 0,24,213:8:0 +17 3587 . G A, 0 . DP=29;I16=4,7,10,6,426,16884,555,20381,660,39600,960,57600,192,4420,280,5942;QS=1.32665,1.67335,0;VDB=0.902044;SGB=-3.91326;RPB=0.800999;MQB=1;MQSB=1;BQB=0.156944;MQ0F=0 PL:DP:DV 161,0,184,182,205,255:14:7 22,0,118,34,121,148:5:1 212,24,0,212,24,212:8:8 +17 3588 . A 0 . DP=29;I16=14,14,0,0,999,36973,0,0,1680,100800,0,0,470,10254,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,166:5:0 0,24,215:8:0 +17 3589 . A 0 . DP=28;I16=14,13,0,0,967,35935,0,0,1620,97200,0,0,467,10173,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,166:5:0 0,24,206:8:0 +17 3590 . A 0 . DP=27;I16=13,13,0,0,948,35860,0,0,1560,93600,0,0,464,10072,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,146:4:0 0,24,211:8:0 +17 3591 . A 0 . DP=26;I16=13,13,0,0,913,33539,0,0,1560,93600,0,0,459,9901,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,144:4:0 0,24,212:8:0 +17 3592 . A 0 . DP=26;I16=13,13,0,0,893,32087,0,0,1560,93600,0,0,453,9711,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,143:4:0 0,24,199:8:0 +17 3593 . A 0 . DP=26;I16=13,13,0,0,891,31363,0,0,1560,93600,0,0,447,9553,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,137:4:0 0,24,198:8:0 +17 3594 . C 0 . DP=25;I16=12,12,0,0,910,34868,0,0,1440,86400,0,0,426,9170,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,142:4:0 0,24,216:8:0 +17 3595 . A 0 . DP=24;I16=13,11,0,0,918,35274,0,0,1440,86400,0,0,438,9328,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,143:4:0 0,21,199:7:0 +17 3596 . T 0 . DP=24;I16=13,11,0,0,837,30077,0,0,1440,86400,0,0,434,9258,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,138:4:0 0,21,188:7:0 +17 3597 . A 0 . DP=24;I16=13,11,0,0,893,33549,0,0,1440,86400,0,0,430,9216,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,132:4:0 0,21,204:7:0 +17 3598 . T 0 . DP=23;I16=12,10,0,0,778,28226,0,0,1320,79200,0,0,415,9005,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,140:4:0 0,21,162:7:0 +17 3599 . A 0 . DP=23;I16=13,10,0,0,859,32403,0,0,1380,82800,0,0,425,9105,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,142:4:0 0,21,182:7:0 +17 3600 . T 0 . DP=24;I16=14,10,0,0,872,32086,0,0,1435,85825,0,0,422,9036,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,139:4:0 0,21,183:7:0 +17 3601 . A 0 . DP=24;I16=14,10,0,0,862,31424,0,0,1435,85825,0,0,420,8994,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,132:4:0 0,21,186:7:0 +17 3602 . T 0 . DP=25;I16=15,10,0,0,873,31323,0,0,1495,89425,0,0,418,8980,0,0;QS=3,0;MQSB=0.962269;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,161:5:0 0,21,174:7:0 +17 3603 . A 0 . DP=26;I16=15,11,0,0,907,32447,0,0,1555,93025,0,0,416,8944,0,0;QS=3,0;MQSB=0.960078;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,151:5:0 0,24,216:8:0 +17 3604 . C 0 . DP=27;I16=16,11,0,0,905,31199,0,0,1615,96625,0,0,415,8937,0,0;QS=3,0;MQSB=0.96384;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,147:6:0 0,24,201:8:0 +17 3605 . G 0 . DP=27;I16=15,11,0,0,853,28887,0,0,1555,93025,0,0,393,8477,0,0;QS=3,0;MQSB=0.960078;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,171:6:0 0,21,174:7:0 +17 3606 . C 0 . DP=27;I16=15,12,0,0,982,36756,0,0,1615,96625,0,0,415,8967,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,187:6:0 0,27,231:9:0 +17 3607 . A 0 . DP=26;I16=15,11,0,0,927,33859,0,0,1555,93025,0,0,417,9005,0,0;QS=3,0;MQSB=0.960078;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,183:6:0 0,27,232:9:0 +17 3608 . A 0 . DP=27;I16=14,12,0,0,930,34054,0,0,1555,93025,0,0,394,8450,0,0;QS=3,0;MQSB=0.953497;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,176:6:0 0,24,232:8:0 +17 3609 . A 0 . DP=27;I16=15,12,0,0,955,34701,0,0,1615,96625,0,0,421,9127,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,186:6:0 0,27,238:9:0 +17 3610 . C 0 . DP=27;I16=14,12,0,0,915,33071,0,0,1555,93025,0,0,397,8537,0,0;QS=3,0;MQSB=0.953497;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,172:6:0 0,24,221:8:0 +17 3611 . C 0 . DP=25;I16=13,11,0,0,899,33995,0,0,1435,85825,0,0,398,8502,0,0;QS=3,0;MQSB=0.950498;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,173:6:0 0,24,234:8:0 +17 3612 . A 0 . DP=25;I16=14,11,0,0,957,37723,0,0,1495,89425,0,0,424,9118,0,0;QS=3,0;MQSB=0.955682;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,18,194:6:0 0,27,251:9:0 +17 3613 . G 0 . DP=26;I16=13,12,0,0,902,33110,0,0,1495,89425,0,0,399,8461,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,172:6:0 0,24,223:8:0 +17 3614 . T 0 . DP=26;I16=14,12,0,0,912,33340,0,0,1555,93025,0,0,425,9083,0,0;QS=3,0;MQSB=0.953497;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,156:6:0 0,27,237:9:0 +17 3615 . A 0 . DP=26;I16=15,11,0,0,946,35138,0,0,1555,93025,0,0,427,9109,0,0;QS=3,0;MQSB=0.960078;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,176:6:0 0,27,242:9:0 +17 3616 . T 0 . DP=26;I16=15,11,0,0,965,36541,0,0,1555,93025,0,0,431,9163,0,0;QS=3,0;MQSB=0.960078;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,185:6:0 0,27,238:9:0 +17 3617 . C 0 . DP=25;I16=14,11,0,0,907,33675,0,0,1495,89425,0,0,436,9196,0,0;QS=3,0;MQSB=0.955682;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,176:6:0 0,24,215:8:0 +17 3618 . C 0 . DP=25;I16=14,11,0,0,964,37698,0,0,1495,89425,0,0,441,9259,0,0;QS=3,0;MQSB=0.955682;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,190:6:0 0,24,225:8:0 +17 3619 . T 0 . DP=25;I16=14,11,0,0,961,37553,0,0,1495,89425,0,0,446,9352,0,0;QS=3,0;MQSB=0.955682;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,194:6:0 0,24,238:8:0 +17 3620 . A 0 . DP=25;I16=14,11,0,0,880,31656,0,0,1495,89425,0,0,451,9475,0,0;QS=3,0;MQSB=0.955682;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,178:6:0 0,24,212:8:0 +17 3621 . C 0 . DP=25;I16=14,11,0,0,949,36561,0,0,1495,89425,0,0,456,9628,0,0;QS=3,0;MQSB=0.955682;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,18,182:6:0 0,24,230:8:0 +17 3622 . T 0 . DP=26;I16=15,11,0,0,983,38067,0,0,1555,93025,0,0,460,9762,0,0;QS=3,0;MQSB=0.960078;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,194:7:0 0,24,242:8:0 +17 3623 . G 0 . DP=27;I16=16,11,0,0,969,35645,0,0,1615,96625,0,0,465,9929,0,0;QS=3,0;MQSB=0.96384;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,195:7:0 0,24,209:8:0 +17 3624 . T 0 . DP=27;I16=15,11,0,0,948,35330,0,0,1555,93025,0,0,448,9596,0,0;QS=3,0;MQSB=0.960078;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,188:6:0 0,24,224:8:0 +17 3625 . G 0 . DP=27;I16=14,12,0,0,983,37483,0,0,1555,93025,0,0,453,9735,0,0;QS=3,0;MQSB=0.953497;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,210:7:0 0,24,219:8:0 +17 3626 . T 0 . DP=28;I16=15,12,0,0,998,37364,0,0,1615,96625,0,0,458,9854,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,214:7:0 0,27,229:9:0 +17 3627 . G 0 . DP=29;I16=15,13,0,0,999,36375,0,0,1675,100225,0,0,464,10004,0,0;QS=3,0;MQSB=0.956162;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,199:7:0 0,27,224:9:0 +17 3628 . T 0 . DP=29;I16=15,13,0,0,1033,38721,0,0,1675,100225,0,0,471,10187,0,0;QS=3,0;MQSB=0.956162;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,206:7:0 0,27,232:9:0 +17 3629 . G 0 . DP=29;I16=15,13,0,0,1058,40226,0,0,1675,100225,0,0,476,10304,0,0;QS=3,0;MQSB=0.956162;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,207:7:0 0,27,235:9:0 +17 3630 . T 0 . DP=30;I16=15,14,0,0,1052,39072,0,0,1735,103825,0,0,480,10404,0,0;QS=3,0;MQSB=0.954405;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,216:7:0 0,27,223:9:0 +17 3631 . C 0 . DP=29;I16=13,14,0,0,884,29476,0,0,1615,96625,0,0,461,9911,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,186:7:0 0,21,179:7:0 +17 3632 . G 0 . DP=29;I16=14,14,0,0,914,31068,0,0,1675,100225,0,0,491,10649,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,183:7:0 0,24,181:8:0 +17 3633 . T 0 . DP=29;I16=14,14,0,0,1022,38214,0,0,1675,100225,0,0,496,10792,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,216:7:0 0,24,222:8:0 +17 3634 . T 0 . DP=29;I16=14,14,0,0,1043,39891,0,0,1675,100225,0,0,500,10914,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,219:7:0 0,24,227:8:0 +17 3635 . T 0 . DP=28;I16=13,14,0,0,1029,39507,0,0,1615,96625,0,0,505,11063,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,219:7:0 0,24,224:8:0 +17 3636 . G 0 . DP=28;I16=13,14,0,0,1001,37681,0,0,1615,96625,0,0,510,11238,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,201:7:0 0,24,217:8:0 +17 3637 . T 0 . DP=27;I16=13,14,0,0,1019,39331,0,0,1615,96625,0,0,515,11439,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,212:7:0 0,24,240:8:0 +17 3638 . T 0 . DP=26;I16=12,14,0,0,967,36467,0,0,1555,93025,0,0,520,11616,0,0;QS=3,0;MQSB=0.937241;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,185:6:0 0,24,222:8:0 +17 3639 . G 0 . DP=27;I16=13,14,0,0,997,37265,0,0,1615,96625,0,0,524,11768,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,183:6:0 0,27,221:9:0 +17 3640 . T 0 . DP=27;I16=13,14,0,0,1001,37533,0,0,1615,96625,0,0,527,11847,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,191:6:0 0,27,229:9:0 +17 3641 . G 0 . DP=27;I16=13,14,0,0,977,36379,0,0,1615,96625,0,0,529,11905,0,0;QS=3,0;MQSB=0.94394;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,178:6:0 0,27,224:9:0 +17 3642 . T 0 . DP=26;I16=12,13,0,0,931,35169,0,0,1495,89425,0,0,506,11314,0,0;QS=3,0;MQSB=0.939413;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,169:5:0 0,24,225:8:0 +17 3643 . T 0 . DP=26;I16=13,13,0,0,968,36820,0,0,1555,93025,0,0,533,11997,0,0;QS=3,0;MQSB=0.945959;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,176:5:0 0,27,230:9:0 +17 3644 . T 0 . DP=26;I16=12,13,0,0,961,37477,0,0,1495,89425,0,0,517,11755,0,0;QS=3,0;MQSB=0.939413;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,175:5:0 0,24,236:8:0 +17 3645 . T 0 . DP=26;I16=13,13,0,0,980,37508,0,0,1555,93025,0,0,537,12185,0,0;QS=3,0;MQSB=0.945959;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,175:5:0 0,27,239:9:0 +17 3646 . C 0 . DP=26;I16=12,13,0,0,766,25026,0,0,1495,89425,0,0,514,11690,0,0;QS=3,0;MQSB=0.939413;MQ0F=0 PL:DP:DV 0,33,234:11:0 0,15,136:5:0 0,27,188:9:0 +17 3647 . G 0 . DP=26;I16=12,12,0,0,820,29600,0,0,1435,85825,0,0,492,11218,0,0;QS=3,0;MQSB=0.941765;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,151:5:0 0,21,173:7:0 +17 3648 . A 0 . DP=26;I16=13,12,0,0,924,34680,0,0,1495,89425,0,0,519,11919,0,0;QS=3,0;MQSB=0.948139;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,174:5:0 0,24,225:8:0 +17 3649 . C 0 . DP=26;I16=14,12,0,0,955,36105,0,0,1555,93025,0,0,545,12593,0,0;QS=3,0;MQSB=0.953497;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,173:5:0 0,27,226:9:0 +17 3650 . A 0 . DP=27;I16=15,12,0,0,1033,40511,0,0,1615,96625,0,0,546,12664,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,196:6:0 0,27,246:9:0 +17 3651 . G 0 . DP=27;I16=15,12,0,0,1035,40351,0,0,1615,96625,0,0,547,12707,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,194:6:0 0,27,233:9:0 +17 3652 . C 0 . DP=29;I16=15,13,0,0,1010,38264,0,0,1675,100225,0,0,521,12047,0,0;QS=3,0;MQSB=0.956162;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,198:6:0 0,27,225:9:0 +17 3653 . T 0 . DP=29;I16=16,13,0,0,1109,42919,0,0,1735,103825,0,0,546,12610,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,202:6:0 0,27,239:9:0 +17 3654 . G 0 . DP=28;I16=14,12,0,0,981,37447,0,0,1555,93025,0,0,514,11882,0,0;QS=3,0;MQSB=0.953497;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,184:6:0 0,18,180:6:0 +17 3655 . T 0 . DP=28;I16=16,12,0,0,999,37029,0,0,1675,100225,0,0,541,12505,0,0;QS=3,0;MQSB=0.96195;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,190:6:0 0,21,179:7:0 +17 3656 . C 0 . DP=28;I16=15,12,0,0,963,35883,0,0,1615,96625,0,0,518,11848,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,164:5:0 0,21,191:7:0 +17 3657 . C 0 . DP=28;I16=15,12,0,0,923,32223,0,0,1615,96625,0,0,520,11836,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,154:5:0 0,21,192:7:0 +17 3658 . G 0 . DP=28;I16=15,12,0,0,876,29960,0,0,1615,96625,0,0,539,12405,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,142:5:0 0,21,163:7:0 +17 3659 . T 0 . DP=28;I16=16,12,0,0,996,36682,0,0,1675,100225,0,0,548,12448,0,0;QS=3,0;MQSB=0.96195;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,163:6:0 0,21,186:7:0 +17 3660 . G 0 . DP=28;I16=15,12,0,0,997,37571,0,0,1615,96625,0,0,526,11920,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,172:6:0 0,18,171:6:0 +17 3661 . T 0 . DP=28;I16=16,12,0,0,1013,37837,0,0,1675,100225,0,0,549,12423,0,0;QS=3,0;MQSB=0.96195;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,180:6:0 0,21,188:7:0 +17 3662 . T 0 . DP=28;I16=15,12,0,0,987,36627,0,0,1615,96625,0,0,528,11980,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,182:6:0 0,18,184:6:0 +17 3663 . A 0 . DP=29;I16=16,12,0,0,997,36233,0,0,1675,100225,0,0,527,11959,0,0;QS=3,0;MQSB=0.96195;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,170:6:0 0,18,180:6:0 +17 3664 . T 0 . DP=29;I16=17,12,0,0,1044,38402,0,0,1735,103825,0,0,550,12490,0,0;QS=3,0;MQSB=0.965321;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,183:6:0 0,21,196:7:0 +17 3665 . A 0 . DP=27;I16=16,11,0,0,1017,38535,0,0,1615,96625,0,0,552,12510,0,0;QS=3,0;MQSB=0.96384;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,182:6:0 0,21,208:7:0 +17 3666 . A 0 . DP=27;I16=16,11,0,0,1036,40292,0,0,1615,96625,0,0,554,12550,0,0;QS=3,0;MQSB=0.96384;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,193:6:0 0,21,208:7:0 +17 3667 . T 0 . DP=27;I16=15,11,0,0,955,35895,0,0,1555,93025,0,0,540,12354,0,0;QS=3,0;MQSB=0.960078;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,189:6:0 0,18,189:6:0 +17 3668 . A 0 . DP=27;I16=16,11,0,0,981,36297,0,0,1615,96625,0,0,557,12641,0,0;QS=3,0;MQSB=0.96384;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,182:6:0 0,21,209:7:0 +17 3669 . A 0 . DP=27;I16=16,11,0,0,1030,39666,0,0,1615,96625,0,0,558,12694,0,0;QS=3,0;MQSB=0.96384;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,194:6:0 0,21,209:7:0 +17 3670 . T 0 . DP=28;I16=17,11,0,0,1057,40245,0,0,1675,100225,0,0,559,12769,0,0;QS=3,0;MQSB=0.967085;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,181:6:0 0,24,220:8:0 +17 3671 . T 0 . DP=28;I16=17,11,0,0,1059,40427,0,0,1675,100225,0,0,561,12867,0,0;QS=3,0;MQSB=0.967085;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,193:6:0 0,24,223:8:0 +17 3672 . C 0 . DP=28;I16=16,11,0,0,988,37264,0,0,1615,96625,0,0,550,12820,0,0;QS=3,0;MQSB=0.96384;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,169:6:0 0,21,205:7:0 +17 3673 . C 0 . DP=27;I16=16,10,0,0,1016,40148,0,0,1555,93025,0,0,528,12314,0,0;QS=3,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,154:5:0 0,24,219:8:0 +17 3674 . T 0 . DP=27;I16=17,10,0,0,1035,40645,0,0,1615,96625,0,0,556,13028,0,0;QS=3,0;MQSB=0.968979;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,155:5:0 0,24,228:8:0 +17 3675 . C 0 . DP=27;I16=17,10,0,0,1049,41413,0,0,1615,96625,0,0,558,13090,0,0;QS=3,0;MQSB=0.968979;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,149:5:0 0,24,222:8:0 +17 3676 . T 0 . DP=27;I16=17,10,0,0,1040,40640,0,0,1615,96625,0,0,559,13125,0,0;QS=3,0;MQSB=0.968979;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,159:5:0 0,24,231:8:0 +17 3677 . A 0 . DP=27;I16=16,10,0,0,922,34182,0,0,1555,93025,0,0,537,12557,0,0;QS=3,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,136:5:0 0,24,217:8:0 +17 3678 . G 0 . DP=27;I16=17,10,0,0,1009,38307,0,0,1615,96625,0,0,563,13159,0,0;QS=3,0;MQSB=0.968979;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,149:5:0 0,24,216:8:0 +17 3679 . T 0 . DP=27;I16=17,10,0,0,1018,39274,0,0,1615,96625,0,0,563,13105,0,0;QS=3,0;MQSB=0.968979;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,156:5:0 0,24,227:8:0 +17 3680 . T 0 . DP=27;I16=17,10,0,0,988,36872,0,0,1615,96625,0,0,562,13022,0,0;QS=3,0;MQSB=0.968979;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,157:5:0 0,24,202:8:0 +17 3681 . C 0 . DP=27;I16=17,10,0,0,1012,39154,0,0,1615,96625,0,0,560,12910,0,0;QS=3,0;MQSB=0.968979;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,157:5:0 0,24,217:8:0 +17 3682 . A 0 . DP=27;I16=17,10,0,0,1009,38221,0,0,1615,96625,0,0,557,12769,0,0;QS=3,0;MQSB=0.968979;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,156:5:0 0,24,220:8:0 +17 3683 . A 0 . DP=27;I16=17,9,0,0,966,36748,0,0,1555,93025,0,0,546,12552,0,0;QS=3,0;MQSB=0.971017;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,153:5:0 0,24,225:8:0 +17 3684 . A 0 . DP=26;I16=16,10,0,0,974,37440,0,0,1555,93025,0,0,550,12456,0,0;QS=3,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,155:5:0 0,21,215:7:0 +17 3685 . T 0 . DP=26;I16=16,10,0,0,954,36330,0,0,1555,93025,0,0,547,12333,0,0;QS=3,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,148:5:0 0,21,207:7:0 +17 3686 . T 0 . DP=26;I16=16,10,0,0,979,37645,0,0,1555,93025,0,0,544,12232,0,0;QS=3,0;MQSB=0.965874;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,162:5:0 0,21,216:7:0 +17 3687 . T 0 . DP=27;I16=16,11,0,0,1028,39276,0,0,1592,94394,0,0,541,12153,0,0;QS=3,0;MQSB=0.989102;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,159:5:0 0,24,229:8:0 +17 3688 . A 0 . DP=28;I16=17,10,0,0,1007,37883,0,0,1569,92163,0,0,526,11904,0,0;QS=3,0;MQSB=0.99874;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,148:5:0 0,24,232:8:0 +17 3689 . T 0 . DP=28;I16=17,11,0,0,1042,39780,0,0,1629,95763,0,0,535,11919,0,0;QS=3,0;MQSB=0.995584;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,162:5:0 0,24,233:8:0 +17 3690 . T 0 . DP=28;I16=17,11,0,0,1051,39981,0,0,1629,95763,0,0,532,11816,0,0;QS=3,0;MQSB=0.995584;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,160:5:0 0,24,225:8:0 +17 3691 . C 0 . DP=28;I16=16,11,0,0,1037,40549,0,0,1569,92163,0,0,520,11592,0,0;QS=3,0;MQSB=0.992419;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,155:5:0 0,21,214:7:0 +17 3692 . A 0 . DP=29;I16=18,11,0,0,1028,37574,0,0,1689,99363,0,0,522,11496,0,0;QS=3,0;MQSB=0.99773;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,156:5:0 0,24,209:8:0 +17 3693 . T 0 . DP=28;I16=18,10,0,0,1067,40901,0,0,1629,95763,0,0,519,11381,0,0;QS=3,0;MQSB=0.999713;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,160:5:0 0,24,230:8:0 +17 3694 . T 0 . DP=28;I16=18,10,0,0,1043,39659,0,0,1629,95763,0,0,516,11296,0,0;QS=3,0;MQSB=0.999713;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,159:5:0 0,24,234:8:0 +17 3695 . T 0 . DP=28;I16=18,10,0,0,1046,39662,0,0,1629,95763,0,0,513,11241,0,0;QS=3,0;MQSB=0.999713;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,156:5:0 0,24,233:8:0 +17 3696 . T 0 . DP=28;I16=18,10,0,0,1075,41567,0,0,1629,95763,0,0,509,11165,0,0;QS=3,0;MQSB=0.999713;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,162:5:0 0,24,235:8:0 +17 3697 . T 0 . DP=28;I16=18,10,0,0,1031,38399,0,0,1629,95763,0,0,505,11117,0,0;QS=3,0;MQSB=0.999713;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,155:5:0 0,24,229:8:0 +17 3698 . A 0 . DP=28;I16=18,9,0,0,983,36457,0,0,1569,92163,0,0,477,10515,0,0;QS=3,0;MQSB=0.999669;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,144:5:0 0,24,229:8:0 +17 3699 . A 0 . DP=27;I16=17,10,0,0,1011,38455,0,0,1569,92163,0,0,493,10861,0,0;QS=3,0;MQSB=0.99874;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,150:5:0 0,21,226:7:0 +17 3700 . C 0 . DP=28;I16=16,11,0,0,970,35910,0,0,1574,92738,0,0,473,10525,0,0;QS=3,0;MQSB=0.992419;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,168:6:0 0,24,212:8:0 +17 3701 . T 0 . DP=28;I16=17,11,0,0,1071,41669,0,0,1634,96338,0,0,484,10618,0,0;QS=3,0;MQSB=0.990092;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,196:6:0 0,24,233:8:0 +17 3702 . T 0 . DP=28;I16=17,10,0,0,1019,38653,0,0,1597,94969,0,0,462,10144,0,0;QS=3,0;MQSB=0.968979;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,184:6:0 0,21,207:7:0 +17 3703 . C 0 . DP=28;I16=17,11,0,0,1059,40561,0,0,1634,96338,0,0,470,10154,0,0;QS=3,0;MQSB=0.990092;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,183:6:0 0,24,232:8:0 +17 3704 . A 0 . DP=28;I16=17,10,0,0,1015,38483,0,0,1574,92738,0,0,439,9347,0,0;QS=3,0;MQSB=0.984677;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,182:6:0 0,21,211:7:0 +17 3705 . T 0 . DP=27;I16=17,10,0,0,992,37112,0,0,1574,92738,0,0,459,9773,0,0;QS=3,0;MQSB=0.984677;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,180:6:0 0,21,209:7:0 +17 3706 . A 0 . DP=27;I16=17,10,0,0,1040,40262,0,0,1574,92738,0,0,454,9608,0,0;QS=3,0;MQSB=0.984677;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,186:6:0 0,21,204:7:0 +17 3707 . G 0 . DP=26;I16=17,9,0,0,974,37394,0,0,1514,89138,0,0,450,9476,0,0;QS=3,0;MQSB=0.977029;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,173:6:0 0,18,168:6:0 +17 3708 . T 0 . DP=26;I16=18,7,0,0,911,33609,0,0,1454,85538,0,0,426,8934,0,0;QS=3,0;MQSB=0.914166;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,182:6:0 0,15,139:5:0 +17 3709 . A 0 . DP=26;I16=18,8,0,0,905,32473,0,0,1491,86907,0,0,445,9305,0,0;QS=3,0;MQSB=0.998458;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,168:6:0 0,18,162:6:0 +17 3710 . C 0 . DP=26;I16=18,8,0,0,924,33504,0,0,1491,86907,0,0,443,9267,0,0;QS=3,0;MQSB=0.998458;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,165:6:0 0,18,159:6:0 +17 3711 . C 0 . DP=26;I16=18,8,0,0,953,35965,0,0,1491,86907,0,0,441,9261,0,0;QS=3,0;MQSB=0.998458;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,164:6:0 0,18,173:6:0 +17 3712 . A 0 . DP=26;I16=18,8,0,0,893,31917,0,0,1491,86907,0,0,439,9287,0,0;QS=3,0;MQSB=0.998458;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,144:6:0 0,18,165:6:0 +17 3713 . C 0 . DP=26;I16=19,7,0,0,908,32834,0,0,1491,86907,0,0,437,9293,0,0;QS=3,0;MQSB=0.989612;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,163:6:0 0,18,164:6:0 +17 3714 . A 0 . DP=27;I16=19,6,0,0,920,34366,0,0,1408,81076,0,0,409,8651,0,0;QS=3,0;MQSB=0.999494;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,177:6:0 0,18,174:6:0 +17 3715 . T 0 . DP=28;I16=21,6,0,0,982,36286,0,0,1505,86045,0,0,408,8616,0,0;QS=3,0;MQSB=0.996181;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,180:6:0 0,18,164:6:0 +17 3716 . T 0 . DP=26;I16=19,7,0,0,927,33833,0,0,1445,82445,0,0,434,9236,0,0;QS=3,0;MQSB=0.966731;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,165:5:0 0,18,164:6:0 +17 3717 . C 0 . DP=26;I16=19,7,0,0,979,37527,0,0,1445,82445,0,0,435,9261,0,0;QS=3,0;MQSB=0.966731;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,165:5:0 0,18,168:6:0 +17 3718 . T 0 . DP=26;I16=19,7,0,0,994,39040,0,0,1445,82445,0,0,435,9265,0,0;QS=3,0;MQSB=0.966731;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,169:5:0 0,18,165:6:0 +17 3719 . A 0 . DP=26;I16=19,6,0,0,889,32163,0,0,1408,81076,0,0,410,8672,0,0;QS=3,0;MQSB=0.747144;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,148:5:0 0,15,142:5:0 +17 3720 . C 0 . DP=26;I16=19,7,0,0,934,34326,0,0,1445,82445,0,0,435,9357,0,0;QS=3,0;MQSB=0.966731;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,148:5:0 0,18,158:6:0 +17 3721 . A 0 . DP=27;I16=20,5,0,0,910,33944,0,0,1405,80725,0,0,385,8195,0,0;QS=3,0;MQSB=0.697274;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,153:5:0 0,15,145:5:0 +17 3722 . C 0 . DP=27;I16=20,7,0,0,964,35276,0,0,1502,85694,0,0,436,9562,0,0;QS=3,0;MQSB=0.927743;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,151:5:0 0,18,165:6:0 +17 3723 . A 0 . DP=25;I16=18,6,0,0,888,33516,0,0,1345,77125,0,0,414,9082,0,0;QS=3,0;MQSB=0.606531;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,134:4:0 0,15,145:5:0 +17 3724 . C 0 . DP=25;I16=18,7,0,0,944,35956,0,0,1382,78494,0,0,442,9878,0,0;QS=3,0;MQSB=0.889393;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,137:4:0 0,18,169:6:0 +17 3725 . T 0 . DP=25;I16=18,7,0,0,973,38263,0,0,1382,78494,0,0,445,10075,0,0;QS=3,0;MQSB=0.889393;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,138:4:0 0,18,190:6:0 +17 3726 . G 0 . DP=24;I16=18,6,0,0,865,32339,0,0,1322,74894,0,0,446,10146,0,0;QS=3,0;MQSB=0.934987;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,93:3:0 0,18,166:6:0 +17 3727 . C 0 . DP=22;I16=17,5,0,0,762,27812,0,0,1202,67694,0,0,447,10139,0,0;QS=3,0;MQSB=0.963102;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,82:3:0 0,15,143:5:0 +17 3728 . C 0 . DP=22;I16=17,5,0,0,792,29850,0,0,1202,67694,0,0,448,10154,0,0;QS=3,0;MQSB=0.963102;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,89:3:0 0,15,160:5:0 +17 3729 . C 0 . DP=22;I16=17,5,0,0,838,32312,0,0,1202,67694,0,0,449,10191,0,0;QS=3,0;MQSB=0.963102;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,93:3:0 0,15,164:5:0 +17 3730 . A 0 . DP=21;I16=17,4,0,0,749,27561,0,0,1142,64094,0,0,448,10100,0,0;QS=3,0;MQSB=0.995997;MQ0F=0 PL:DP:DV 0,39,241:13:0 0,9,98:3:0 0,15,159:5:0 +17 3731 . T 0 . DP=22;I16=18,4,0,0,787,29489,0,0,1152,64194,0,0,447,10031,0,0;QS=3,0;MQSB=0.967917;MQ0F=0 PL:DP:DV 0,42,253:14:0 0,9,101:3:0 0,15,139:5:0 +17 3732 . G 0 . DP=22;I16=18,4,0,0,811,30695,0,0,1152,64194,0,0,447,9985,0,0;QS=3,0;MQSB=0.967917;MQ0F=0 PL:DP:DV 0,42,252:14:0 0,9,101:3:0 0,15,149:5:0 +17 3733 . T 0 . DP=23;I16=19,4,0,0,820,29616,0,0,1212,67794,0,0,447,9963,0,0;QS=3,0;MQSB=0.979651;MQ0F=0 PL:DP:DV 0,45,248:15:0 0,9,101:3:0 0,15,152:5:0 +17 3734 . C 0 . DP=24;I16=20,4,0,0,863,32277,0,0,1272,71394,0,0,447,9915,0,0;QS=3,0;MQSB=0.988072;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,86:3:0 0,15,152:5:0 +17 3735 . C 0 . DP=24;I16=20,4,0,0,826,30112,0,0,1272,71394,0,0,448,9892,0,0;QS=3,0;MQSB=0.988072;MQ0F=0 PL:DP:DV 0,48,254:16:0 0,9,83:3:0 0,15,152:5:0 +17 3736 . C 0 . DP=25;I16=20,3,0,0,839,31471,0,0,1262,71294,0,0,419,9245,0,0;QS=3,0;MQSB=0.963194;MQ0F=0 PL:DP:DV 0,42,235:14:0 0,9,99:3:0 0,18,156:6:0 +17 3737 . C 0 . DP=25;I16=21,4,0,0,894,33402,0,0,1332,74994,0,0,451,9925,0,0;QS=3,0;MQSB=0.993838;MQ0F=0 PL:DP:DV 0,48,251:16:0 0,9,95:3:0 0,18,175:6:0 +17 3738 . T 0 . DP=25;I16=21,4,0,0,926,35484,0,0,1332,74994,0,0,452,9934,0,0;QS=3,0;MQSB=0.993838;MQ0F=0 PL:DP:DV 0,48,253:16:0 0,9,101:3:0 0,18,189:6:0 +17 3739 . C 0 . DP=25;I16=21,4,0,0,958,37390,0,0,1332,74994,0,0,452,9922,0,0;QS=3,0;MQSB=0.993838;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,105:3:0 0,18,181:6:0 +17 3740 . A 0 . DP=24;I16=20,4,0,0,848,31126,0,0,1272,71394,0,0,452,9886,0,0;QS=3,0;MQSB=0.988072;MQ0F=0 PL:DP:DV 0,48,247:16:0 0,9,109:3:0 0,15,163:5:0 +17 3741 . A 0 . DP=24;I16=19,4,0,0,814,30176,0,0,1212,67794,0,0,442,9742,0,0;QS=3,0;MQSB=0.979651;MQ0F=0 PL:DP:DV 0,48,238:16:0 0,6,82:2:0 0,15,172:5:0 +17 3742 . G 0 . DP=24;I16=20,4,0,0,893,34371,0,0,1272,71394,0,0,450,9782,0,0;QS=3,0;MQSB=0.988072;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,101:3:0 0,15,162:5:0 +17 3743 . C 0 . DP=24;I16=19,4,0,0,839,31673,0,0,1262,71294,0,0,437,9619,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,254:15:0 0,9,103:3:0 0,15,158:5:0 +17 3744 . T 0 . DP=24;I16=20,4,0,0,918,36126,0,0,1272,71394,0,0,448,9766,0,0;QS=3,0;MQSB=0.988072;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,118:3:0 0,15,164:5:0 +17 3745 . T 0 . DP=24;I16=19,4,0,0,808,29490,0,0,1212,67794,0,0,422,9166,0,0;QS=3,0;MQSB=0.979651;MQ0F=0 PL:DP:DV 0,45,233:15:0 0,9,108:3:0 0,15,158:5:0 +17 3746 . C 0 . DP=24;I16=20,4,0,0,886,33564,0,0,1272,71394,0,0,445,9789,0,0;QS=3,0;MQSB=0.988072;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,101:3:0 0,15,165:5:0 +17 3747 . C 0 . DP=24;I16=19,4,0,0,833,31071,0,0,1262,71294,0,0,426,9504,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,249:15:0 0,9,103:3:0 0,15,162:5:0 +17 3748 . C 0 . DP=24;I16=19,4,0,0,845,31753,0,0,1262,71294,0,0,422,9464,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,106:3:0 0,15,161:5:0 +17 3749 . C 0 . DP=24;I16=19,4,0,0,844,31888,0,0,1262,71294,0,0,417,9395,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,250:15:0 0,9,111:3:0 0,15,154:5:0 +17 3750 . T 0 . DP=25;I16=21,4,0,0,876,32880,0,0,1309,72763,0,0,431,9709,0,0;QS=3,0;MQSB=0.966906;MQ0F=0 PL:DP:DV 0,51,251:17:0 0,9,112:3:0 0,15,146:5:0 +17 3751 . G 0 . DP=24;I16=19,4,0,0,836,31374,0,0,1239,69063,0,0,408,9274,0,0;QS=3,0;MQSB=0.986928;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,82:2:0 0,15,162:5:0 +17 3752 . G 0 . DP=22;I16=19,2,0,0,728,26270,0,0,1069,58363,0,0,404,9134,0,0;QS=3,0;MQSB=0.868421;MQ0F=0 PL:DP:DV 0,42,182:14:0 0,6,74:2:0 0,15,159:5:0 +17 3753 . C 0 . DP=22;I16=19,3,0,0,761,28017,0,0,1129,61963,0,0,426,9674,0,0;QS=3,0;MQSB=0.995434;MQ0F=0 PL:DP:DV 0,45,213:15:0 0,6,61:2:0 0,15,163:5:0 +17 3754 . T 0 . DP=23;I16=19,3,0,0,767,28751,0,0,1129,61963,0,0,425,9707,0,0;QS=3,0;MQSB=0.995434;MQ0F=0 PL:DP:DV 0,45,218:15:0 0,6,69:2:0 0,15,157:5:0 +17 3755 . C 0 . DP=21;I16=16,4,0,0,749,28747,0,0,1028,55504,0,0,404,9188,0,0;QS=3,0;MQSB=0.777932;MQ0F=0 PL:DP:DV 0,36,219:12:0 0,9,93:3:0 0,15,161:5:0 +17 3756 . C 0 . DP=22;I16=17,4,0,0,782,29994,0,0,1038,55604,0,0,430,9840,0,0;QS=3,0;MQSB=0.885747;MQ0F=0 PL:DP:DV 0,39,229:13:0 0,9,93:3:0 0,15,159:5:0 +17 3757 . T 0 . DP=23;I16=17,6,0,0,828,30942,0,0,1158,62804,0,0,456,10510,0,0;QS=3,0;MQSB=0.9945;MQ0F=0 PL:DP:DV 0,39,210:13:0 0,15,143:5:0 0,15,169:5:0 +17 3758 . G 0 . DP=23;I16=17,6,0,0,832,30792,0,0,1158,62804,0,0,458,10574,0,0;QS=3,0;MQSB=0.9945;MQ0F=0 PL:DP:DV 0,39,220:13:0 0,15,135:5:0 0,15,147:5:0 +17 3759 . C 0 . DP=23;I16=17,4,0,0,756,28338,0,0,1061,57835,0,0,409,9357,0,0;QS=3,0;MQSB=0.964547;MQ0F=0 PL:DP:DV 0,39,220:13:0 0,12,112:4:0 0,12,127:4:0 +17 3760 . A 0 . DP=24;I16=17,7,0,0,792,27956,0,0,1218,66404,0,0,459,10607,0,0;QS=3,0;MQSB=0.95083;MQ0F=0 PL:DP:DV 0,39,203:13:0 0,15,127:5:0 0,18,180:6:0 +17 3761 . A 0 . DP=24;I16=17,7,0,0,871,32185,0,0,1218,66404,0,0,460,10624,0,0;QS=3,0;MQSB=0.95083;MQ0F=0 PL:DP:DV 0,39,215:13:0 0,15,136:5:0 0,18,188:6:0 +17 3762 . C 0 . DP=25;I16=17,7,0,0,831,29665,0,0,1241,68635,0,0,435,9983,0,0;QS=3,0;MQSB=0.69242;MQ0F=0 PL:DP:DV 0,39,209:13:0 0,18,149:6:0 0,15,159:5:0 +17 3763 . C 0 . DP=24;I16=16,8,0,0,837,30619,0,0,1218,66404,0,0,460,10510,0,0;QS=3,0;MQSB=0.844324;MQ0F=0 PL:DP:DV 0,36,213:12:0 0,18,149:6:0 0,18,186:6:0 +17 3764 . A 0 . DP=25;I16=17,7,0,0,856,31506,0,0,1241,68635,0,0,437,9903,0,0;QS=3,0;MQSB=0.69242;MQ0F=0 PL:DP:DV 0,39,212:13:0 0,18,139:6:0 0,15,167:5:0 +17 3765 . C 0 . DP=25;I16=17,7,0,0,845,31099,0,0,1218,66404,0,0,436,9750,0,0;QS=3,0;MQSB=0.95083;MQ0F=0 PL:DP:DV 0,39,200:13:0 0,15,129:5:0 0,18,189:6:0 +17 3766 . A 0 . DP=26;I16=17,9,0,0,953,35331,0,0,1338,73604,0,0,462,10340,0,0;QS=3,0;MQSB=0.811273;MQ0F=0 PL:DP:DV 0,42,248:14:0 0,18,158:6:0 0,18,191:6:0 +17 3767 . A 0 . DP=26;I16=17,9,0,0,924,33656,0,0,1338,73604,0,0,464,10328,0,0;QS=3,0;MQSB=0.811273;MQ0F=0 PL:DP:DV 0,42,246:14:0 0,18,148:6:0 0,18,191:6:0 +17 3768 . A 0 . DP=26;I16=17,9,0,0,922,33842,0,0,1338,73604,0,0,466,10340,0,0;QS=3,0;MQSB=0.811273;MQ0F=0 PL:DP:DV 0,42,237:14:0 0,18,146:6:0 0,18,195:6:0 +17 3769 . T 0 . DP=26;I16=17,8,0,0,891,32735,0,0,1278,70004,0,0,461,10327,0,0;QS=3,0;MQSB=0.884621;MQ0F=0 PL:DP:DV 0,42,246:14:0 0,15,144:5:0 0,18,191:6:0 +17 3770 . C 0 . DP=26;I16=17,9,0,0,923,34049,0,0,1338,73604,0,0,470,10436,0,0;QS=3,0;MQSB=0.811273;MQ0F=0 PL:DP:DV 0,42,252:14:0 0,18,142:6:0 0,18,180:6:0 +17 3771 . T 0 . DP=25;I16=16,8,0,0,852,31694,0,0,1218,66404,0,0,464,10438,0,0;QS=3,0;MQSB=0.844324;MQ0F=0 PL:DP:DV 0,42,253:14:0 0,15,140:5:0 0,15,157:5:0 +17 3772 . A 0 . DP=26;I16=16,10,0,0,836,28434,0,0,1338,73604,0,0,476,10624,0,0;QS=3,0;MQSB=0.685145;MQ0F=0 PL:DP:DV 0,42,236:14:0 0,18,122:6:0 0,18,160:6:0 +17 3773 . C 0 . DP=26;I16=16,10,0,0,893,31801,0,0,1338,73604,0,0,480,10752,0,0;QS=3,0;MQSB=0.685145;MQ0F=0 PL:DP:DV 0,42,253:14:0 0,18,140:6:0 0,18,171:6:0 +17 3774 . T 0 . DP=25;I16=15,10,0,0,895,33455,0,0,1278,70004,0,0,485,10903,0,0;QS=3,0;MQSB=0.624282;MQ0F=0 PL:DP:DV 0,42,253:14:0 0,18,129:6:0 0,15,178:5:0 +17 3775 . C 0 . DP=25;I16=15,9,0,0,855,31825,0,0,1241,68635,0,0,477,10883,0,0;QS=3,0;MQSB=0.439649;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,147:6:0 0,12,143:4:0 +17 3776 . T 0 . DP=24;I16=15,7,0,0,838,32738,0,0,1152,64194,0,0,457,10375,0,0;QS=3,0;MQSB=0.225079;MQ0F=0 PL:DP:DV 0,39,229:13:0 0,15,149:5:0 0,12,152:4:0 +17 3777 . C 0 . DP=24;I16=15,9,0,0,864,32180,0,0,1218,66404,0,0,492,10998,0,0;QS=3,0;MQSB=0.705785;MQ0F=0 PL:DP:DV 0,39,220:13:0 0,18,160:6:0 0,15,168:5:0 +17 3778 . T 0 . DP=24;I16=14,9,0,0,859,32957,0,0,1208,66304,0,0,468,10372,0,0;QS=3,0;MQSB=0.836049;MQ0F=0 PL:DP:DV 0,36,227:12:0 0,18,157:6:0 0,15,167:5:0 +17 3779 . G 0 . DP=24;I16=15,9,0,0,844,31206,0,0,1218,66404,0,0,493,10971,0,0;QS=3,0;MQSB=0.705785;MQ0F=0 PL:DP:DV 0,39,220:13:0 0,18,152:6:0 0,15,167:5:0 +17 3780 . C 0 . DP=25;I16=14,10,0,0,829,29949,0,0,1268,69904,0,0,467,10295,0,0;QS=3,0;MQSB=0.765017;MQ0F=0 PL:DP:DV 0,39,235:13:0 0,18,144:6:0 0,15,169:5:0 +17 3781 . C 0 . DP=26;I16=16,10,0,0,939,34725,0,0,1315,71373,0,0,492,10896,0,0;QS=3,0;MQSB=0.541994;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,139:6:0 0,15,175:5:0 +17 3782 . T 0 . DP=26;I16=16,10,0,0,989,38031,0,0,1315,71373,0,0,493,10901,0,0;QS=3,0;MQSB=0.541994;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,169:6:0 0,15,176:5:0 +17 3783 . C 0 . DP=26;I16=16,10,0,0,941,34801,0,0,1315,71373,0,0,492,10836,0,0;QS=3,0;MQSB=0.541994;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,155:6:0 0,15,162:5:0 +17 3784 . T 0 . DP=27;I16=16,11,0,0,1001,38035,0,0,1375,74973,0,0,491,10801,0,0;QS=3,0;MQSB=0.467219;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,155:6:0 0,15,178:5:0 +17 3785 . G 0 . DP=28;I16=15,10,0,0,922,36426,0,0,1305,71273,0,0,450,9916,0,0;QS=3,0;MQSB=0.674458;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,125:5:0 0,15,179:5:0 +17 3786 . T 0 . DP=28;I16=16,11,0,0,935,35697,0,0,1375,74973,0,0,490,10774,0,0;QS=3,0;MQSB=0.467219;MQ0F=0 PL:DP:DV 0,48,250:16:0 0,18,145:6:0 0,15,186:5:0 +17 3787 . G 0 . DP=28;I16=16,11,0,0,963,37951,0,0,1375,74973,0,0,489,10781,0,0;QS=3,0;MQSB=0.467219;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,143:6:0 0,15,177:5:0 +17 3788 . G 0 . DP=26;I16=14,9,0,0,849,33683,0,0,1184,65386,0,0,459,10075,0,0;QS=3,0;MQSB=0.525788;MQ0F=0 PL:DP:DV 0,39,239:13:0 0,18,144:6:0 0,12,161:4:0 +17 3789 . G 0 . DP=26;I16=13,10,0,0,807,31019,0,0,1231,68535,0,0,438,9474,0,0;QS=3,0;MQSB=0.445672;MQ0F=0 PL:DP:DV 0,39,251:13:0 0,18,133:6:0 0,12,161:4:0 +17 3790 . T 0 . DP=26;I16=13,10,0,0,829,32293,0,0,1231,68535,0,0,435,9359,0,0;QS=3,0;MQSB=0.445672;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,150:6:0 0,12,159:4:0 +17 3791 . T 0 . DP=26;I16=15,10,0,0,887,34725,0,0,1301,72235,0,0,478,10336,0,0;QS=3,0;MQSB=0.382304;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,136:6:0 0,12,159:4:0 +17 3792 . G A, 0 . DP=26;I16=14,8,1,0,809,32805,38,1444,1175,66425,37,1369,417,8991,22,484;QS=2.92629,0.0737052,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.195278;BQB=1;MQ0F=0 PL:DP:DV 0,8,238,42,241,255:15:1 0,12,109,12,109,109:4:0 0,12,157,12,157,157:4:0 +17 3793 . A 0 . DP=26;I16=15,8,0,0,833,33775,0,0,1212,67794,0,0,435,9363,0,0;QS=3,0;MQSB=0.195278;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,93:4:0 0,12,159:4:0 +17 3794 . C 0 . DP=26;I16=15,9,0,0,845,33023,0,0,1241,68635,0,0,438,9324,0,0;QS=3,0;MQSB=0.439649;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,120:5:0 0,12,157:4:0 +17 3795 . C 0 . DP=26;I16=14,9,0,0,865,35649,0,0,1231,68535,0,0,408,8622,0,0;QS=3,0;MQSB=0.563599;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,132:5:0 0,12,161:4:0 +17 3796 . T 0 . DP=27;I16=15,11,0,0,964,38998,0,0,1361,75835,0,0,453,9821,0,0;QS=3,0;MQSB=0.334895;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,149:7:0 0,12,164:4:0 +17 3797 . A 0 . DP=27;I16=15,10,0,0,848,32392,0,0,1301,72235,0,0,424,9172,0,0;QS=3,0;MQSB=0.382304;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,124:6:0 0,12,159:4:0 +17 3798 . T 0 . DP=27;I16=14,11,0,0,921,37161,0,0,1301,72235,0,0,430,9554,0,0;QS=3,0;MQSB=0.283586;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,21,148:7:0 0,12,165:4:0 +17 3799 . T 0 . DP=27;I16=15,11,0,0,913,35929,0,0,1361,75835,0,0,439,9729,0,0;QS=3,0;MQSB=0.334895;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,21,150:7:0 0,12,161:4:0 +17 3800 . C 0 . DP=26;I16=13,10,0,0,866,36182,0,0,1181,65035,0,0,406,9092,0,0;QS=3,0;MQSB=0.272532;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,104:5:0 0,12,161:4:0 +17 3801 . T 0 . DP=23;I16=12,10,0,0,804,33600,0,0,1121,61435,0,0,430,9750,0,0;QS=3,0;MQSB=0.217267;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,99:5:0 0,9,133:3:0 +17 3802 . G 0 . DP=22;I16=10,9,0,0,730,30516,0,0,994,54486,0,0,380,8550,0,0;QS=3,0;MQSB=0.472367;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,106:4:0 0,9,130:3:0 +17 3803 . G 0 . DP=22;I16=11,9,0,0,703,27393,0,0,1051,57735,0,0,405,9241,0,0;QS=3,0;MQSB=0.372419;MQ0F=0 PL:DP:DV 0,39,249:13:0 0,12,92:4:0 0,9,129:3:0 +17 3804 . A 0 . DP=22;I16=11,9,0,0,740,30360,0,0,1051,57735,0,0,404,9274,0,0;QS=3,0;MQSB=0.372419;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,98:4:0 0,9,132:3:0 +17 3805 . C 0 . DP=22;I16=12,9,0,0,737,29243,0,0,1061,57835,0,0,428,9950,0,0;QS=3,0;MQSB=0.262932;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,81:4:0 0,9,130:3:0 +17 3806 . A 0 . DP=22;I16=12,9,0,0,798,32550,0,0,1061,57835,0,0,426,9968,0,0;QS=3,0;MQSB=0.262932;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,105:4:0 0,9,128:3:0 +17 3807 . C 0 . DP=22;I16=10,9,0,0,664,25304,0,0,994,54486,0,0,377,8885,0,0;QS=3,0;MQSB=0.472367;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,83:4:0 0,9,115:3:0 +17 3808 . G 0 . DP=21;I16=9,9,0,0,653,25297,0,0,957,53117,0,0,375,8873,0,0;QS=3,0;MQSB=0.597145;MQ0F=0 PL:DP:DV 0,33,233:11:0 0,12,109:4:0 0,9,132:3:0 +17 3809 . T 0 . DP=22;I16=11,10,0,0,779,32151,0,0,1084,60066,0,0,416,9810,0,0;QS=3,0;MQSB=0.285029;MQ0F=0 PL:DP:DV 0,39,249:13:0 0,12,115:4:0 0,12,161:4:0 +17 3810 . C 0 . DP=23;I16=9,11,0,0,811,34815,0,0,1077,60317,0,0,369,8739,0,0;QS=3,0;MQSB=0.499893;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,112:4:0 0,12,153:4:0 +17 3811 . A C, 0 . DP=23;I16=9,11,2,0,777,32631,39,785,1077,60317,67,3349,367,8669,42,914;QS=2.94104,0.0589569,0;VDB=0.18;SGB=0.346553;RPB=0.425;MQB=0.25;MQSB=0.246128;BQB=0.025;MQ0F=0 PL:DP:DV 0,15,248,36,254,255:14:2 0,12,116,12,116,116:4:0 0,12,158,12,158,158:4:0 +17 3812 . T 0 . DP=23;I16=10,11,0,0,802,32860,0,0,1084,60066,0,0,405,9447,0,0;QS=3,0;MQSB=0.187115;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,114:4:0 0,12,160:4:0 +17 3813 . A 0 . DP=22;I16=10,11,0,0,815,35077,0,0,1084,60066,0,0,402,9330,0,0;QS=3,0;MQSB=0.187115;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,119:4:0 0,12,170:4:0 +17 3814 . G 0 . DP=21;I16=8,11,0,0,775,33731,0,0,1037,58597,0,0,375,8605,0,0;QS=3,0;MQSB=0.41781;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,113:4:0 0,12,163:4:0 +17 3815 . A 0 . DP=20;I16=8,11,0,0,708,29130,0,0,1010,57328,0,0,397,9049,0,0;QS=3,0;MQSB=0.373354;MQ0F=0 PL:DP:DV 0,33,239:11:0 0,12,110:4:0 0,12,162:4:0 +17 3816 . A 0 . DP=20;I16=8,11,0,0,729,31027,0,0,1010,57328,0,0,395,8933,0,0;QS=3,0;MQSB=0.373354;MQ0F=0 PL:DP:DV 0,33,248:11:0 0,12,104:4:0 0,12,160:4:0 +17 3817 . A 0 . DP=20;I16=8,11,0,0,752,31580,0,0,1010,57328,0,0,393,8833,0,0;QS=3,0;MQSB=0.373354;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,110:4:0 0,12,161:4:0 +17 3818 . T 0 . DP=20;I16=8,11,0,0,728,30466,0,0,1010,57328,0,0,391,8749,0,0;QS=3,0;MQSB=0.373354;MQ0F=0 PL:DP:DV 0,33,252:11:0 0,12,115:4:0 0,12,160:4:0 +17 3819 . A 0 . DP=21;I16=9,11,0,0,790,34094,0,0,1039,58169,0,0,389,8681,0,0;QS=3,0;MQSB=0.247381;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,121:4:0 0,12,167:4:0 +17 3820 . G 0 . DP=21;I16=9,11,0,0,788,33636,0,0,1039,58169,0,0,388,8630,0,0;QS=3,0;MQSB=0.247381;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,112:4:0 0,12,157:4:0 +17 3821 . A 0 . DP=22;I16=10,11,0,0,832,35864,0,0,1099,61769,0,0,387,8597,0,0;QS=3,0;MQSB=0.317882;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,115:4:0 0,12,168:4:0 +17 3822 . G 0 . DP=22;I16=10,11,0,0,810,33228,0,0,1099,61769,0,0,386,8532,0,0;QS=3,0;MQSB=0.317882;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,103:4:0 0,12,157:4:0 +17 3823 . T 0 . DP=22;I16=9,11,0,0,753,30705,0,0,1042,58520,0,0,380,8460,0,0;QS=3,0;MQSB=0.434285;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,102:4:0 0,12,163:4:0 +17 3824 . C 0 . DP=22;I16=10,11,0,0,802,32368,0,0,1099,61769,0,0,384,8456,0,0;QS=3,0;MQSB=0.317882;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,105:4:0 0,12,159:4:0 +17 3825 . C 0 . DP=23;I16=10,11,0,0,813,33955,0,0,1079,59889,0,0,379,8387,0,0;QS=3,0;MQSB=0.317882;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,130:5:0 0,12,157:4:0 +17 3826 . T 0 . DP=23;I16=11,11,0,0,827,34611,0,0,1136,63138,0,0,381,8357,0,0;QS=3,0;MQSB=0.232836;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,133:5:0 0,12,155:4:0 +17 3827 . G 0 . DP=23;I16=11,10,0,0,820,34130,0,0,1076,59538,0,0,355,7715,0,0;QS=3,0;MQSB=0.269397;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,121:4:0 0,12,162:4:0 +17 3828 . C 0 . DP=23;I16=11,10,0,0,805,33147,0,0,1076,59538,0,0,354,7720,0,0;QS=3,0;MQSB=0.269397;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,114:4:0 0,12,157:4:0 +17 3829 . A 0 . DP=22;I16=9,11,0,0,763,31295,0,0,1069,59789,0,0,369,8241,0,0;QS=3,0;MQSB=0.477679;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,132:5:0 0,12,158:4:0 +17 3830 . A 0 . DP=23;I16=11,11,0,0,825,32693,0,0,1136,63138,0,0,377,8321,0,0;QS=3,0;MQSB=0.232836;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,143:5:0 0,12,150:4:0 +17 3831 . C A, 0 . DP=23;I16=10,11,1,0,802,32198,14,196,1126,63038,10,100,370,8294,7,49;QS=2.97758,0.0224215,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.232836;BQB=1;MQ0F=0 PL:DP:DV 0,27,255,36,255,255:13:1 0,15,134,15,134,134:5:0 0,12,149,12,149,149:4:0 +17 3832 . A 0 . DP=24;I16=12,11,0,0,836,32436,0,0,1196,66738,0,0,377,8389,0,0;QS=3,0;MQSB=0.291845;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,136:5:0 0,12,139:4:0 +17 3833 . C 0 . DP=23;I16=10,11,0,0,690,24938,0,0,1076,59538,0,0,377,8409,0,0;QS=3,0;MQSB=0.175325;MQ0F=0 PL:DP:DV 0,36,249:12:0 0,15,113:5:0 0,12,131:4:0 +17 3834 . G 0 . DP=22;I16=9,10,0,0,684,26250,0,0,1037,58597,0,0,357,8079,0,0;QS=3,0;MQSB=0.124514;MQ0F=0 PL:DP:DV 0,33,242:11:0 0,12,122:4:0 0,12,156:4:0 +17 3835 . T 0 . DP=22;I16=10,11,0,0,773,30373,0,0,1076,59538,0,0,381,8475,0,0;QS=3,0;MQSB=0.175325;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,140:5:0 0,12,153:4:0 +17 3836 . G C, 0 . DP=24;I16=10,12,1,0,833,33183,14,196,1132,61648,10,100,378,8412,2,4;QS=2.97647,0.0235294,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.251407;BQB=1;MQ0F=0 PL:DP:DV 0,27,255,36,255,255:13:1 0,15,149,15,149,149:5:0 0,15,188,15,188,188:5:0 +17 3837 . G 0 . DP=24;I16=8,14,0,0,759,26931,0,0,1135,61999,0,0,399,8955,0,0;QS=3,0;MQSB=0.291667;MQ0F=0 PL:DP:DV 0,33,245:11:0 0,18,149:6:0 0,15,157:5:0 +17 3838 . C 0 . DP=24;I16=10,14,0,0,817,28975,0,0,1202,65348,0,0,409,8945,0,0;QS=3,0;MQSB=0.122456;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,143:6:0 0,15,148:5:0 +17 3839 . C 0 . DP=23;I16=9,13,0,0,688,22248,0,0,1132,61648,0,0,386,8238,0,0;QS=3,0;MQSB=0.248197;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,123:6:0 0,12,112:4:0 +17 3840 . G 0 . DP=23;I16=9,14,0,0,793,27941,0,0,1192,65248,0,0,413,8809,0,0;QS=3,0;MQSB=0.211072;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,160:6:0 0,15,146:5:0 +17 3841 . T 0 . DP=23;I16=9,14,0,0,867,33103,0,0,1192,65248,0,0,414,8734,0,0;QS=3,0;MQSB=0.211072;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,167:6:0 0,15,162:5:0 +17 3842 . C 0 . DP=23;I16=9,14,0,0,890,34728,0,0,1192,65248,0,0,415,8689,0,0;QS=3,0;MQSB=0.211072;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,167:6:0 0,15,159:5:0 +17 3843 . T 0 . DP=24;I16=9,14,0,0,896,35122,0,0,1192,65248,0,0,416,8674,0,0;QS=3,0;MQSB=0.211072;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,164:6:0 0,15,159:5:0 +17 3844 . G 0 . DP=26;I16=10,16,0,0,959,35715,0,0,1372,76048,0,0,442,9314,0,0;QS=3,0;MQSB=0.220358;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,177:7:0 0,18,172:6:0 +17 3845 . T 0 . DP=26;I16=10,16,0,0,970,36442,0,0,1372,76048,0,0,444,9310,0,0;QS=3,0;MQSB=0.220358;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,186:7:0 0,18,166:6:0 +17 3846 . G 0 . DP=27;I16=10,17,0,0,993,37297,0,0,1432,79648,0,0,446,9338,0,0;QS=3,0;MQSB=0.195223;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,175:7:0 0,21,172:7:0 +17 3847 . T 0 . DP=27;I16=10,16,0,0,952,35268,0,0,1372,76048,0,0,423,8723,0,0;QS=3,0;MQSB=0.220358;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,170:6:0 0,21,189:7:0 +17 3848 . C 0 . DP=27;I16=10,17,0,0,1025,39533,0,0,1432,79648,0,0,449,9341,0,0;QS=3,0;MQSB=0.195223;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,177:7:0 0,21,188:7:0 +17 3849 . T 0 . DP=27;I16=9,17,0,0,987,37685,0,0,1395,78279,0,0,450,9368,0,0;QS=3,0;MQSB=0.282527;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,179:7:0 0,21,190:7:0 +17 3850 . G 0 . DP=26;I16=9,17,0,0,957,35751,0,0,1395,78279,0,0,452,9428,0,0;QS=3,0;MQSB=0.282527;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,179:7:0 0,21,182:7:0 +17 3851 . G 0 . DP=26;I16=9,17,0,0,965,36475,0,0,1395,78279,0,0,453,9469,0,0;QS=3,0;MQSB=0.282527;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,177:7:0 0,21,183:7:0 +17 3852 . C 0 . DP=26;I16=9,16,0,0,921,34525,0,0,1335,74679,0,0,444,9440,0,0;QS=3,0;MQSB=0.310905;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,163:6:0 0,21,179:7:0 +17 3853 . T 0 . DP=28;I16=10,18,0,0,1050,40222,0,0,1484,82720,0,0,455,9641,0,0;QS=3,0;MQSB=0.515783;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,21,185:7:0 0,21,192:7:0 +17 3854 . T 0 . DP=28;I16=10,17,0,0,955,34605,0,0,1455,81879,0,0,451,9709,0,0;QS=3,0;MQSB=0.359211;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,171:6:0 0,18,178:6:0 +17 3855 . C 0 . DP=29;I16=10,18,0,0,992,36040,0,0,1515,85479,0,0,438,9264,0,0;QS=3,0;MQSB=0.331344;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,139:5:0 0,21,175:7:0 +17 3856 . T 0 . DP=30;I16=10,18,0,0,1033,38725,0,0,1546,88238,0,0,464,9982,0,0;QS=3,0;MQSB=0.190183;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,163:6:0 0,21,185:7:0 +17 3857 . C 0 . DP=30;I16=10,19,0,0,1077,40979,0,0,1575,89079,0,0,447,9505,0,0;QS=3,0;MQSB=0.306875;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,154:5:0 0,24,194:8:0 +17 3858 . T 0 . DP=31;I16=10,21,0,0,1141,42567,0,0,1695,96279,0,0,477,10255,0,0;QS=3,0;MQSB=0.266219;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,171:6:0 0,24,208:8:0 +17 3859 . C 0 . DP=32;I16=10,21,0,0,950,30078,0,0,1695,96279,0,0,484,10416,0,0;QS=3,0;MQSB=0.266219;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,136:6:0 0,24,156:8:0 +17 3860 . G 0 . DP=32;I16=10,22,0,0,1070,37794,0,0,1755,99879,0,0,516,11240,0,0;QS=3,0;MQSB=0.249261;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,154:6:0 0,27,209:9:0 +17 3861 . C 0 . DP=33;I16=11,20,0,0,1133,42547,0,0,1672,94048,0,0,517,11391,0,0;QS=3,0;MQSB=0.19205;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,162:6:0 0,24,199:8:0 +17 3862 . T 0 . DP=34;I16=11,22,0,0,1241,47443,0,0,1792,101248,0,0,526,11518,0,0;QS=3,0;MQSB=0.161533;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,185:7:0 0,27,221:9:0 +17 3863 . T 0 . DP=34;I16=12,22,0,0,1200,43542,0,0,1852,104848,0,0,541,11685,0,0;QS=3,0;MQSB=0.210327;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,199:7:0 0,27,213:9:0 +17 3864 . A 0 . DP=33;I16=11,22,0,0,1238,47448,0,0,1792,101248,0,0,550,11790,0,0;QS=3,0;MQSB=0.161533;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,210:7:0 0,27,230:9:0 +17 3865 . G 0 . DP=34;I16=11,23,0,0,1251,47113,0,0,1852,104848,0,0,559,11933,0,0;QS=3,0;MQSB=0.149071;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,200:7:0 0,27,212:9:0 +17 3866 . C 0 . DP=33;I16=11,21,0,0,1165,43545,0,0,1732,97648,0,0,545,11489,0,0;QS=3,0;MQSB=0.175751;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,189:7:0 0,24,197:8:0 +17 3867 . A 0 . DP=33;I16=11,22,0,0,1152,41510,0,0,1792,101248,0,0,580,12284,0,0;QS=3,0;MQSB=0.161533;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,188:7:0 0,27,195:9:0 +17 3868 . T 0 . DP=33;I16=11,22,0,0,1255,48141,0,0,1792,101248,0,0,590,12494,0,0;QS=3,0;MQSB=0.161533;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,202:7:0 0,27,221:9:0 +17 3869 . C 0 . DP=33;I16=11,21,0,0,1169,43987,0,0,1732,97648,0,0,589,12623,0,0;QS=3,0;MQSB=0.175751;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,164:6:0 0,27,211:9:0 +17 3870 . T 0 . DP=34;I16=11,23,0,0,1262,47808,0,0,1852,104848,0,0,608,12932,0,0;QS=3,0;MQSB=0.149071;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,215:8:0 0,27,211:9:0 +17 3871 . T 0 . DP=36;I16=11,25,0,0,1341,50655,0,0,1972,112048,0,0,617,13157,0,0;QS=3,0;MQSB=0.128391;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,24,221:8:0 0,27,223:9:0 +17 3872 . G 0 . DP=36;I16=11,25,0,0,1287,47095,0,0,1972,112048,0,0,626,13322,0,0;QS=3,0;MQSB=0.128391;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,24,211:8:0 0,27,200:9:0 +17 3873 . T 0 . DP=35;I16=10,24,0,0,1242,46680,0,0,1852,104848,0,0,626,13428,0,0;QS=3,0;MQSB=0.0982034;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,194:7:0 0,24,212:8:0 +17 3874 . T 0 . DP=36;I16=12,24,0,0,1290,47660,0,0,1972,112048,0,0,646,13774,0,0;QS=3,0;MQSB=0.182088;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,24,228:8:0 0,24,204:8:0 +17 3875 . T 0 . DP=37;I16=13,24,0,0,1324,48418,0,0,2029,115297,0,0,657,14061,0,0;QS=3,0;MQSB=0.117872;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,24,231:8:0 0,24,197:8:0 +17 3876 . C 0 . DP=37;I16=13,22,0,0,1248,45354,0,0,1909,108097,0,0,623,13325,0,0;QS=3,0;MQSB=0.140806;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,21,196:7:0 0,24,180:8:0 +17 3877 . C 0 . DP=37;I16=13,24,0,0,1363,51201,0,0,2029,115297,0,0,681,14765,0,0;QS=3,0;MQSB=0.117872;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,24,217:8:0 0,24,196:8:0 +17 3878 . A 0 . DP=37;I16=13,23,0,0,1309,48045,0,0,1969,111697,0,0,670,14654,0,0;QS=3,0;MQSB=0.128568;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,24,218:8:0 0,24,188:8:0 +17 3879 . A 0 . DP=38;I16=14,24,0,0,1453,56567,0,0,2066,116666,0,0,703,15543,0,0;QS=3,0;MQSB=0.076112;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,24,226:8:0 0,24,206:8:0 +17 3880 . G 0 . DP=37;I16=14,22,0,0,1311,48735,0,0,1946,109466,0,0,689,15267,0,0;QS=3,0;MQSB=0.094094;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,24,209:8:0 0,24,183:8:0 +17 3881 . G 0 . DP=37;I16=14,21,0,0,1200,42778,0,0,1886,105866,0,0,690,15578,0,0;QS=3,0;MQSB=0.105399;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,18,178:6:0 0,24,174:8:0 +17 3882 . T 0 . DP=37;I16=14,21,0,0,1192,42352,0,0,1886,105866,0,0,684,15348,0,0;QS=3,0;MQSB=0.105399;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,21,189:7:0 0,21,178:7:0 +17 3883 . C 0 . DP=38;I16=15,22,0,0,1295,46659,0,0,2006,113066,0,0,717,16279,0,0;QS=3,0;MQSB=0.124405;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,24,205:8:0 0,24,171:8:0 +17 3884 . C 0 . DP=39;I16=16,23,0,0,1363,49387,0,0,2103,118035,0,0,749,17141,0,0;QS=3,0;MQSB=0.0760633;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,24,202:8:0 0,27,212:9:0 +17 3885 . T 0 . DP=40;I16=16,24,0,0,1445,53663,0,0,2163,121635,0,0,754,17262,0,0;QS=3,0;MQSB=0.0679472;MQ0F=0 PL:DP:DV 0,69,255:23:0 0,24,219:8:0 0,27,214:9:0 +17 3886 . C 0 . DP=39;I16=16,23,0,0,1370,49762,0,0,2103,118035,0,0,761,17421,0,0;QS=3,0;MQSB=0.0760633;MQ0F=0 PL:DP:DV 0,69,255:23:0 0,24,199:8:0 0,24,191:8:0 +17 3887 . C 0 . DP=39;I16=16,23,0,0,1364,49222,0,0,2103,118035,0,0,767,17567,0,0;QS=3,0;MQSB=0.0760633;MQ0F=0 PL:DP:DV 0,69,255:23:0 0,24,194:8:0 0,24,201:8:0 +17 3888 . C 0 . DP=39;I16=15,23,0,0,1387,51885,0,0,2043,114435,0,0,747,17073,0,0;QS=3,0;MQSB=0.0555905;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,24,195:8:0 0,24,208:8:0 +17 3889 . A 0 . DP=38;I16=15,23,0,0,1364,49918,0,0,2066,116666,0,0,777,17811,0,0;QS=3,0;MQSB=0.112471;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,24,202:8:0 0,24,218:8:0 +17 3890 . C 0 . DP=38;I16=14,23,0,0,1362,51064,0,0,2006,113066,0,0,757,17329,0,0;QS=3,0;MQSB=0.0844255;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,24,203:8:0 0,24,216:8:0 +17 3891 . A 0 . DP=39;I16=15,24,0,0,1466,56312,0,0,2126,120266,0,0,786,18076,0,0;QS=3,0;MQSB=0.102114;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,24,203:8:0 0,27,239:9:0 +17 3892 . G 0 . DP=38;I16=15,23,0,0,1340,48838,0,0,2066,116666,0,0,792,18226,0,0;QS=3,0;MQSB=0.112471;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,24,186:8:0 0,27,208:9:0 +17 3893 . T 0 . DP=39;I16=15,24,0,0,1348,48170,0,0,2126,120266,0,0,798,18404,0,0;QS=3,0;MQSB=0.102114;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,24,196:8:0 0,27,212:9:0 +17 3894 . G 0 . DP=39;I16=15,23,0,0,1364,49900,0,0,2066,116666,0,0,779,17937,0,0;QS=3,0;MQSB=0.112471;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,24,202:8:0 0,27,208:9:0 +17 3895 . T 0 . DP=39;I16=15,24,0,0,1375,49773,0,0,2126,120266,0,0,810,18752,0,0;QS=3,0;MQSB=0.102114;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,24,202:8:0 0,27,225:9:0 +17 3896 . A 0 . DP=40;I16=15,24,0,0,1468,57326,0,0,2126,120266,0,0,815,18923,0,0;QS=3,0;MQSB=0.102114;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,24,224:8:0 0,27,233:9:0 +17 3897 . G 0 . DP=40;I16=15,24,0,0,1468,56812,0,0,2126,120266,0,0,819,19021,0,0;QS=3,0;MQSB=0.102114;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,21,199:7:0 0,30,234:10:0 +17 3898 . C 0 . DP=40;I16=15,23,0,0,1487,59351,0,0,2066,116666,0,0,813,19023,0,0;QS=3,0;MQSB=0.112471;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,18,186:6:0 0,30,238:10:0 +17 3899 . A 0 . DP=40;I16=15,24,0,0,1449,55055,0,0,2126,120266,0,0,829,19293,0,0;QS=3,0;MQSB=0.102114;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,21,191:7:0 0,30,231:10:0 +17 3900 . T 0 . DP=40;I16=15,24,0,0,1458,55516,0,0,2126,120266,0,0,833,19417,0,0;QS=3,0;MQSB=0.102114;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,21,197:7:0 0,30,240:10:0 +17 3901 . G 0 . DP=40;I16=14,22,0,0,1303,48245,0,0,1969,111697,0,0,761,17639,0,0;QS=3,0;MQSB=0.180757;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,18,154:6:0 0,27,218:9:0 +17 3902 . C 0 . DP=40;I16=15,24,0,0,1436,55412,0,0,2126,120266,0,0,837,19537,0,0;QS=3,0;MQSB=0.102114;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,21,166:7:0 0,30,217:10:0 +17 3903 . A 0 . DP=42;I16=15,24,0,0,1299,45567,0,0,2089,117417,0,0,814,19008,0,0;QS=3,0;MQSB=0.0901152;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,24,175:8:0 0,30,204:10:0 +17 3904 . C 0 . DP=42;I16=15,24,0,0,1439,54545,0,0,2086,117066,0,0,815,19113,0,0;QS=3,0;MQSB=0.0426917;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,24,191:8:0 0,30,244:10:0 +17 3905 . C 0 . DP=42;I16=15,25,0,0,1572,63314,0,0,2146,120666,0,0,822,19192,0,0;QS=3,0;MQSB=0.0381122;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,24,212:8:0 0,33,255:11:0 +17 3906 . T 0 . DP=42;I16=16,25,0,0,1593,63039,0,0,2206,124266,0,0,846,19758,0,0;QS=3,0;MQSB=0.0536599;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,24,210:8:0 0,33,253:11:0 +17 3907 . G 0 . DP=42;I16=16,25,0,0,1558,60192,0,0,2206,124266,0,0,846,19776,0,0;QS=3,0;MQSB=0.0536599;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,24,203:8:0 0,33,249:11:0 +17 3908 . C 0 . DP=42;I16=16,25,0,0,1514,58968,0,0,2206,124266,0,0,845,19777,0,0;QS=3,0;MQSB=0.0536599;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,24,193:8:0 0,33,244:11:0 +17 3909 . T 0 . DP=43;I16=16,25,0,0,1491,55895,0,0,2201,123691,0,0,835,19697,0,0;QS=3,0;MQSB=0.0757469;MQ0F=0 PL:DP:DV 0,69,255:23:0 0,24,202:8:0 0,30,237:10:0 +17 3910 . A 0 . DP=40;I16=16,23,0,0,1432,53926,0,0,2081,116491,0,0,844,19724,0,0;QS=3,0;MQSB=0.0949554;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,21,193:7:0 0,30,224:10:0 +17 3911 . C 0 . DP=40;I16=16,23,0,0,1440,55290,0,0,2081,116491,0,0,843,19613,0,0;QS=3,0;MQSB=0.0949554;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,21,184:7:0 0,30,214:10:0 +17 3912 . A C, 0 . DP=41;I16=17,22,0,1,1358,49508,16,256,2081,116491,60,3600,830,19358,11,121;QS=2.95181,0.0481928,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.125266;BQB=1;MQ0F=0 PL:DP:DV 0,69,255,69,255,255:23:0 0,21,166,21,166,166:7:0 0,14,202,27,205,208:10:1 +17 3913 . C 0 . DP=40;I16=16,23,0,0,1494,59096,0,0,2081,116491,0,0,824,19100,0,0;QS=3,0;MQSB=0.0949554;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,21,183:7:0 0,30,234:10:0 +17 3914 . T 0 . DP=42;I16=16,24,0,0,1512,59342,0,0,2141,120091,0,0,823,19007,0,0;QS=3,0;MQSB=0.0846181;MQ0F=0 PL:DP:DV 0,69,255:23:0 0,21,192:7:0 0,30,228:10:0 +17 3915 . C 0 . DP=42;I16=16,24,0,0,1537,60953,0,0,2141,120091,0,0,799,18321,0,0;QS=3,0;MQSB=0.0846181;MQ0F=0 PL:DP:DV 0,72,255:24:0 0,18,176:6:0 0,30,229:10:0 +17 3916 . C 0 . DP=42;I16=16,25,0,0,1618,66342,0,0,2201,123691,0,0,825,18919,0,0;QS=3,0;MQSB=0.0757469;MQ0F=0 PL:DP:DV 0,72,255:24:0 0,21,190:7:0 0,30,251:10:0 +17 3917 . T 0 . DP=43;I16=16,25,0,0,1601,65219,0,0,2201,123691,0,0,825,18875,0,0;QS=3,0;MQSB=0.0757469;MQ0F=0 PL:DP:DV 0,72,255:24:0 0,21,191:7:0 0,30,254:10:0 +17 3918 . T 0 . DP=43;I16=16,25,0,0,1541,60711,0,0,2201,123691,0,0,801,18239,0,0;QS=3,0;MQSB=0.0757469;MQ0F=0 PL:DP:DV 0,75,255:25:0 0,18,179:6:0 0,30,254:10:0 +17 3919 . C 0 . DP=42;I16=15,26,0,0,1621,66337,0,0,2232,126450,0,0,826,18786,0,0;QS=3,0;MQSB=0.110793;MQ0F=0 PL:DP:DV 0,72,255:24:0 0,21,200:7:0 0,30,242:10:0 +17 3920 . T 0 . DP=42;I16=15,26,0,0,1605,64327,0,0,2232,126450,0,0,825,18691,0,0;QS=3,0;MQSB=0.110793;MQ0F=0 PL:DP:DV 0,72,255:24:0 0,21,207:7:0 0,30,251:10:0 +17 3921 . T 0 . DP=42;I16=15,26,0,0,1519,58507,0,0,2232,126450,0,0,824,18630,0,0;QS=3,0;MQSB=0.110793;MQ0F=0 PL:DP:DV 0,72,255:24:0 0,21,201:7:0 0,30,242:10:0 +17 3922 . A 0 . DP=42;I16=14,26,0,0,1539,61289,0,0,2195,125081,0,0,819,18545,0,0;QS=3,0;MQSB=0.168991;MQ0F=0 PL:DP:DV 0,72,255:24:0 0,18,179:6:0 0,30,244:10:0 +17 3923 . G 0 . DP=41;I16=14,25,0,0,1515,60945,0,0,2135,121481,0,0,792,17834,0,0;QS=3,0;MQSB=0.182501;MQ0F=0 PL:DP:DV 0,69,255:23:0 0,18,172:6:0 0,30,240:10:0 +17 3924 . G 0 . DP=41;I16=13,26,0,0,1524,61106,0,0,2135,121481,0,0,808,18356,0,0;QS=3,0;MQSB=0.128469;MQ0F=0 PL:DP:DV 0,69,255:23:0 0,18,158:6:0 0,30,247:10:0 +17 3925 . G 0 . DP=41;I16=14,25,0,0,1425,55687,0,0,2135,121481,0,0,788,17758,0,0;QS=3,0;MQSB=0.182501;MQ0F=0 PL:DP:DV 0,72,255:24:0 0,15,134:5:0 0,30,245:10:0 +17 3926 . C 0 . DP=41;I16=14,26,0,0,1512,59674,0,0,2195,125081,0,0,811,18393,0,0;QS=3,0;MQSB=0.168991;MQ0F=0 PL:DP:DV 0,72,255:24:0 0,18,152:6:0 0,30,237:10:0 +17 3927 . T 0 . DP=41;I16=14,26,0,0,1512,59566,0,0,2195,125081,0,0,808,18384,0,0;QS=3,0;MQSB=0.168991;MQ0F=0 PL:DP:DV 0,72,255:24:0 0,18,160:6:0 0,30,237:10:0 +17 3928 . G 0 . DP=41;I16=14,25,0,0,1479,58495,0,0,2135,121481,0,0,779,17731,0,0;QS=3,0;MQSB=0.182501;MQ0F=0 PL:DP:DV 0,72,255:24:0 0,18,149:6:0 0,27,233:9:0 +17 3929 . A 0 . DP=41;I16=13,26,0,0,1452,56436,0,0,2135,121481,0,0,796,18256,0,0;QS=3,0;MQSB=0.128469;MQ0F=0 PL:DP:DV 0,69,255:23:0 0,18,161:6:0 0,30,220:10:0 +17 3930 . T 0 . DP=40;I16=13,25,0,0,1387,52929,0,0,2078,118232,0,0,767,17521,0,0;QS=3,0;MQSB=0.25797;MQ0F=0 PL:DP:DV 0,69,255:23:0 0,15,149:5:0 0,30,224:10:0 +17 3931 . A 0 . DP=40;I16=13,25,0,0,1387,52877,0,0,2078,118232,0,0,761,17439,0,0;QS=3,0;MQSB=0.25797;MQ0F=0 PL:DP:DV 0,69,255:23:0 0,18,166:6:0 0,27,222:9:0 +17 3932 . T 0 . DP=39;I16=12,26,0,0,1394,53644,0,0,2078,118232,0,0,780,17964,0,0;QS=3,0;MQSB=0.190372;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,18,161:6:0 0,30,231:10:0 +17 3933 . T 0 . DP=38;I16=12,24,0,0,1389,54743,0,0,1958,111032,0,0,752,17366,0,0;QS=3,0;MQSB=0.218161;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,18,166:6:0 0,24,220:8:0 +17 3934 . C 0 . DP=38;I16=12,25,0,0,1395,54915,0,0,2018,114632,0,0,768,17758,0,0;QS=3,0;MQSB=0.203497;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,18,152:6:0 0,27,209:9:0 +17 3935 . C 0 . DP=38;I16=12,24,0,0,1239,44621,0,0,1958,111032,0,0,737,17075,0,0;QS=3,0;MQSB=0.218161;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,15,134:5:0 0,27,170:9:0 +17 3936 . A G, 0 . DP=37;I16=5,6,6,17,424,16384,801,30271,609,34563,1314,77018,225,5325,511,11851;QS=0.87994,2.12006,0;VDB=0.0574114;SGB=-4.60123;RPB=0.741697;MQB=0.812605;MQSB=0.143788;BQB=0.883831;MQ0F=0 PL:DP:DV 233,0,206,255,239,255:20:11 77,0,58,83,70,141:6:4 196,24,0,196,24,196:8:8 +17 3937 . C 0 . DP=36;I16=11,24,0,0,1155,39875,0,0,1952,112422,0,0,745,17291,0,0;QS=3,0;MQSB=0.219636;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,18,143:6:0 0,24,156:8:0 +17 3938 . G 0 . DP=35;I16=11,23,0,0,1155,41761,0,0,1892,108822,0,0,737,17079,0,0;QS=3,0;MQSB=0.231054;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,15,119:5:0 0,24,176:8:0 +17 3939 . C 0 . DP=35;I16=11,22,0,0,1273,50651,0,0,1832,105222,0,0,703,16221,0,0;QS=3,0;MQSB=0.243713;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,15,135:5:0 0,21,174:7:0 +17 3940 . A 0 . DP=35;I16=11,22,0,0,1148,42754,0,0,1832,105222,0,0,691,15867,0,0;QS=3,0;MQSB=0.243713;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,15,117:5:0 0,21,163:7:0 +17 3941 . C 0 . DP=35;I16=11,22,0,0,1216,47488,0,0,1832,105222,0,0,688,15892,0,0;QS=3,0;MQSB=0.243713;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,15,133:5:0 0,21,181:7:0 +17 3942 . C 0 . DP=35;I16=11,23,0,0,1336,54166,0,0,1892,108822,0,0,690,15772,0,0;QS=3,0;MQSB=0.231054;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,15,140:5:0 0,24,195:8:0 +17 3943 . T 0 . DP=35;I16=11,23,0,0,1296,51618,0,0,1892,108822,0,0,676,15406,0,0;QS=3,0;MQSB=0.231054;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,15,142:5:0 0,24,195:8:0 +17 3944 . G 0 . DP=34;I16=10,22,0,0,1199,46445,0,0,1803,104381,0,0,654,14954,0,0;QS=3,0;MQSB=0.1117;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,149:5:0 0,24,195:8:0 +17 3945 . C 0 . DP=33;I16=10,22,0,0,1256,51226,0,0,1772,101622,0,0,649,14657,0,0;QS=3,0;MQSB=0.187579;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,15,142:5:0 0,21,177:7:0 +17 3946 . T 0 . DP=33;I16=10,21,0,0,1170,45884,0,0,1712,98022,0,0,609,13599,0,0;QS=3,0;MQSB=0.199344;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,15,144:5:0 0,18,158:6:0 +17 3947 . A 0 . DP=32;I16=10,21,0,0,1094,41048,0,0,1712,98022,0,0,620,13820,0,0;QS=3,0;MQSB=0.199344;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,15,128:5:0 0,18,149:6:0 +17 3948 . C 0 . DP=32;I16=10,20,0,0,1134,45104,0,0,1652,94422,0,0,596,13344,0,0;QS=3,0;MQSB=0.212591;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,12,105:4:0 0,18,155:6:0 +17 3949 . A C, 0 . DP=32;I16=10,17,0,1,1027,39909,24,576,1472,83622,60,3600,541,12211,25,625;QS=2.85093,0.149068,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.244621;BQB=1;MQ0F=0 PL:DP:DV 0,60,255,60,255,255:20:0 0,9,89,9,89,89:3:0 9,0,107,21,110,124:5:1 +17 3950 . C 0 . DP=33;I16=11,21,0,0,1191,46247,0,0,1772,101622,0,0,576,12680,0,0;QS=3,0;MQSB=0.257801;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,15,118:5:0 0,18,168:6:0 +17 3951 . T 0 . DP=34;I16=12,19,0,0,1148,44272,0,0,1712,98022,0,0,530,11670,0,0;QS=3,0;MQSB=0.354733;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,15,146:5:0 0,15,152:5:0 +17 3952 . C 0 . DP=35;I16=13,20,0,0,1176,43762,0,0,1832,105222,0,0,545,12025,0,0;QS=3,0;MQSB=0.394875;MQ0F=0 PL:DP:DV 0,66,255:22:0 0,18,158:6:0 0,15,143:5:0 +17 3953 . C 0 . DP=34;I16=13,20,0,0,1246,48436,0,0,1863,107981,0,0,538,11772,0,0;QS=3,0;MQSB=0.252983;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,18,163:6:0 0,18,168:6:0 +17 3954 . T 0 . DP=33;I16=13,19,0,0,1195,45815,0,0,1803,104381,0,0,526,11438,0,0;QS=3,0;MQSB=0.264585;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,18,171:6:0 0,18,167:6:0 +17 3955 . T 0 . DP=32;I16=13,18,0,0,1180,46092,0,0,1743,100781,0,0,515,11139,0,0;QS=3,0;MQSB=0.277468;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,173:6:0 0,18,174:6:0 +17 3956 . C 0 . DP=32;I16=13,18,0,0,1181,47021,0,0,1743,100781,0,0,504,10874,0,0;QS=3,0;MQSB=0.277468;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,167:6:0 0,18,167:6:0 +17 3957 . T 0 . DP=31;I16=13,17,0,0,1153,46051,0,0,1683,97181,0,0,494,10642,0,0;QS=3,0;MQSB=0.291833;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,161:6:0 0,15,162:5:0 +17 3958 . T 0 . DP=31;I16=13,16,0,0,1070,40600,0,0,1623,93581,0,0,483,10393,0,0;QS=3,0;MQSB=0.307929;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,139:5:0 0,15,157:5:0 +17 3959 . A 0 . DP=30;I16=14,15,0,0,1062,39758,0,0,1623,93581,0,0,474,10176,0,0;QS=3,0;MQSB=0.377103;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,12,118:4:0 0,15,154:5:0 +17 3960 . T 0 . DP=30;I16=14,15,0,0,995,36027,0,0,1623,93581,0,0,464,9892,0,0;QS=3,0;MQSB=0.377103;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,12,105:4:0 0,15,142:5:0 +17 3961 . G 0 . DP=29;I16=12,16,0,0,1067,40899,0,0,1586,92212,0,0,457,9739,0,0;QS=3,0;MQSB=0.455864;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,12,114:4:0 0,12,122:4:0 +17 3962 . G 0 . DP=29;I16=13,16,0,0,1025,37125,0,0,1623,93581,0,0,471,10053,0,0;QS=3,0;MQSB=0.307929;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,12,108:4:0 0,15,144:5:0 +17 3963 . C 0 . DP=28;I16=13,15,0,0,1040,39100,0,0,1563,89981,0,0,463,9871,0,0;QS=3,0;MQSB=0.326055;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,12,111:4:0 0,12,126:4:0 +17 3964 . T 0 . DP=27;I16=12,15,0,0,1036,39928,0,0,1503,86381,0,0,456,9720,0,0;QS=3,0;MQSB=0.273507;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,9,94:3:0 0,12,133:4:0 +17 3965 . G 0 . DP=26;I16=12,14,0,0,993,38165,0,0,1443,82781,0,0,450,9598,0,0;QS=3,0;MQSB=0.29215;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,9,92:3:0 0,12,134:4:0 +17 3966 . A 0 . DP=26;I16=12,13,0,0,930,34834,0,0,1406,81412,0,0,432,9310,0,0;QS=3,0;MQSB=0.520812;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,9,90:3:0 0,12,140:4:0 +17 3967 . T 0 . DP=26;I16=12,13,0,0,900,32830,0,0,1406,81412,0,0,421,9001,0,0;QS=3,0;MQSB=0.520812;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,9,90:3:0 0,9,100:3:0 +17 3968 . A 0 . DP=25;I16=12,13,0,0,885,31773,0,0,1406,81412,0,0,415,8853,0,0;QS=3,0;MQSB=0.520812;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,9,90:3:0 0,9,99:3:0 +17 3969 . T 0 . DP=24;I16=11,13,0,0,886,32972,0,0,1369,80043,0,0,410,8736,0,0;QS=3,0;MQSB=0.702671;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,9,85:3:0 0,9,108:3:0 +17 3970 . T 0 . DP=24;I16=11,13,0,0,861,31313,0,0,1369,80043,0,0,405,8649,0,0;QS=3,0;MQSB=0.702671;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,9,83:3:0 0,9,104:3:0 +17 3971 . C 0 . DP=22;I16=11,11,0,0,815,30625,0,0,1249,72843,0,0,402,8590,0,0;QS=3,0;MQSB=0.751921;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,57:2:0 0,9,103:3:0 +17 3972 . C 0 . DP=22;I16=11,11,0,0,812,30486,0,0,1249,72843,0,0,399,8557,0,0;QS=3,0;MQSB=0.751921;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,55:2:0 0,9,96:3:0 +17 3973 . A 0 . DP=22;I16=11,11,0,0,795,28873,0,0,1249,72843,0,0,395,8501,0,0;QS=3,0;MQSB=0.751921;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,52:2:0 0,9,97:3:0 +17 3974 . C 0 . DP=22;I16=11,11,0,0,729,24447,0,0,1249,72843,0,0,392,8472,0,0;QS=3,0;MQSB=0.751921;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,55:2:0 0,9,78:3:0 +17 3975 . G 0 . DP=22;I16=11,11,0,0,717,24525,0,0,1249,72843,0,0,390,8470,0,0;QS=3,0;MQSB=0.751921;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,46:2:0 0,9,96:3:0 +17 3976 . C 0 . DP=22;I16=11,11,0,0,816,30652,0,0,1249,72843,0,0,387,8445,0,0;QS=3,0;MQSB=0.751921;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,55:2:0 0,9,97:3:0 +17 3977 . A 0 . DP=23;I16=11,11,0,0,740,25384,0,0,1249,72843,0,0,382,8346,0,0;QS=3,0;MQSB=0.751921;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,48:2:0 0,9,90:3:0 +17 3978 . C 0 . DP=23;I16=11,12,0,0,769,26631,0,0,1309,76443,0,0,377,8223,0,0;QS=3,0;MQSB=0.726094;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,47:2:0 0,9,103:3:0 +17 3979 . C 0 . DP=21;I16=9,11,0,0,744,28160,0,0,1152,67874,0,0,361,7905,0,0;QS=3,0;MQSB=0.885207;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,51:2:0 0,9,104:3:0 +17 3980 . T 0 . DP=21;I16=10,11,0,0,756,27872,0,0,1212,71474,0,0,367,7855,0,0;QS=3,0;MQSB=0.914611;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,51:2:0 0,9,98:3:0 +17 3981 . G 0 . DP=21;I16=10,11,0,0,785,29641,0,0,1212,71474,0,0,362,7710,0,0;QS=3,0;MQSB=0.914611;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,50:2:0 0,9,93:3:0 +17 3982 . C 0 . DP=21;I16=10,11,0,0,779,29495,0,0,1212,71474,0,0,357,7591,0,0;QS=3,0;MQSB=0.914611;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,55:2:0 0,9,97:3:0 +17 3983 . T 0 . DP=20;I16=9,11,0,0,720,26274,0,0,1155,68225,0,0,353,7497,0,0;QS=3,0;MQSB=0.993528;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,57:2:0 0,9,93:3:0 +17 3984 . A 0 . DP=21;I16=10,11,0,0,739,26279,0,0,1192,69594,0,0,348,7378,0,0;QS=3,0;MQSB=0.885602;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,53:2:0 0,9,80:3:0 +17 3985 . C 0 . DP=20;I16=10,10,0,0,728,26998,0,0,1132,65994,0,0,344,7234,0,0;QS=3,0;MQSB=0.902256;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,55:2:0 0,9,91:3:0 +17 3986 . A 0 . DP=20;I16=10,10,0,0,685,23815,0,0,1132,65994,0,0,340,7114,0,0;QS=3,0;MQSB=0.902256;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,56:2:0 0,9,84:3:0 +17 3987 . C 0 . DP=20;I16=10,10,0,0,736,28118,0,0,1132,65994,0,0,336,7018,0,0;QS=3,0;MQSB=0.902256;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,55:2:0 0,9,94:3:0 +17 3988 . T 0 . DP=21;I16=10,10,0,0,741,27797,0,0,1132,65994,0,0,332,6946,0,0;QS=3,0;MQSB=0.902256;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,58:2:0 0,9,91:3:0 +17 3989 . C 0 . DP=21;I16=10,11,0,0,729,26185,0,0,1192,69594,0,0,327,6801,0,0;QS=3,0;MQSB=0.885602;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,55:2:0 0,9,88:3:0 +17 3990 . C 0 . DP=21;I16=10,11,0,0,766,28674,0,0,1192,69594,0,0,322,6686,0,0;QS=3,0;MQSB=0.885602;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,55:2:0 0,9,95:3:0 +17 3991 . T 0 . DP=20;I16=9,11,0,0,729,27311,0,0,1132,65994,0,0,318,6600,0,0;QS=3,0;MQSB=0.850154;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,55:2:0 0,9,89:3:0 +17 3992 . T 0 . DP=19;I16=9,10,0,0,667,24173,0,0,1072,62394,0,0,313,6441,0,0;QS=3,0;MQSB=0.868634;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,56:2:0 0,6,72:2:0 +17 3993 . C 0 . DP=18;I16=9,9,0,0,701,27529,0,0,1012,58794,0,0,309,6307,0,0;QS=3,0;MQSB=0.888755;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,59:2:0 0,6,70:2:0 +17 3994 . T 0 . DP=19;I16=10,9,0,0,718,27520,0,0,1049,60163,0,0,305,6197,0,0;QS=3,0;MQSB=0.716531;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,58:2:0 0,6,72:2:0 +17 3995 . T 0 . DP=19;I16=9,9,0,0,641,23025,0,0,989,56563,0,0,277,5487,0,0;QS=3,0;MQSB=0.650623;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,53:2:0 0,6,69:2:0 +17 3996 . A 0 . DP=19;I16=9,9,0,0,665,24815,0,0,989,56563,0,0,274,5428,0,0;QS=3,0;MQSB=0.650623;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,54:2:0 0,6,73:2:0 +17 3997 . G C, 0 . DP=19;I16=10,8,0,1,645,23703,21,441,989,56563,60,3600,287,5843,6,36;QS=2.96023,0.0397727,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.716531;BQB=1;MQ0F=0 PL:DP:DV 0,24,255,42,255,255:15:1 0,6,57,6,57,57:2:0 0,6,60,6,60,60:2:0 +17 3998 . G 0 . DP=18;I16=9,8,0,0,626,23710,0,0,929,52963,0,0,265,5203,0,0;QS=3,0;MQSB=0.687289;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,6,58:2:0 0,3,36:1:0 +17 3999 . G A, 0 . DP=18;I16=9,7,0,1,596,22974,37,1369,869,49363,60,3600,263,5387,4,16;QS=2.92871,0.0712909,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.687289;BQB=1;MQ0F=0 PL:DP:DV 0,5,255,39,255,255:14:1 0,6,56,6,56,56:2:0 0,3,38,3,38,38:1:0 +17 4000 . C 0 . DP=18;I16=10,8,0,0,669,25389,0,0,989,56563,0,0,283,5753,0,0;QS=3,0;MQSB=0.751866;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,55:2:0 0,3,36:1:0 +17 4001 . T 0 . DP=18;I16=10,8,0,0,680,26006,0,0,989,56563,0,0,279,5727,0,0;QS=3,0;MQSB=0.751866;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,56:2:0 0,3,33:1:0 +17 4002 . G 0 . DP=17;I16=10,7,0,0,621,23281,0,0,929,52963,0,0,276,5724,0,0;QS=2,0;MQSB=0.79189;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,44:2:0 0,0,0:0:0 +17 4003 . A 0 . DP=17;I16=10,7,0,0,597,21507,0,0,929,52963,0,0,272,5692,0,0;QS=2,0;MQSB=0.79189;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,6,55:2:0 0,0,0:0:0 +17 4004 . T 0 . DP=15;I16=9,6,0,0,527,19031,0,0,849,48963,0,0,270,5678,0,0;QS=2,0;MQSB=0.957526;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,3,40:1:0 0,0,0:0:0 +17 4005 . A 0 . DP=15;I16=8,5,0,0,479,17731,0,0,729,41763,0,0,237,5195,0,0;QS=2,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,35:1:0 0,0,0:0:0 +17 4006 . T 0 . DP=15;I16=9,6,0,0,554,20776,0,0,849,48963,0,0,266,5698,0,0;QS=2,0;MQSB=0.957526;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,3,40:1:0 0,0,0:0:0 +17 4007 . T G, 0 . DP=15;I16=9,5,0,1,490,17810,15,225,789,45363,60,3600,245,5371,19,361;QS=1.96746,0.032538,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.957526;BQB=1;MQ0F=0 PL:DP:DV 0,26,255,39,255,255:14:1 0,3,41,3,41,41:1:0 0,0,0,0,0,0:0:0 +17 4008 . C 0 . DP=15;I16=9,6,0,0,488,16890,0,0,849,48963,0,0,262,5782,0,0;QS=2,0;MQSB=0.957526;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,3,30:1:0 0,0,0:0:0 +17 4009 . C 0 . DP=14;I16=9,5,0,0,524,20150,0,0,794,45938,0,0,261,5847,0,0;QS=2,0;MQSB=0.800737;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,3,40:1:0 0,0,0:0:0 +17 4010 . A 0 . DP=14;I16=9,5,0,0,523,19731,0,0,794,45938,0,0,259,5875,0,0;QS=2,0;MQSB=0.800737;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,3,41:1:0 0,0,0:0:0 +17 4011 . C 0 . DP=14;I16=9,5,0,0,489,17613,0,0,794,45938,0,0,257,5915,0,0;QS=2,0;MQSB=0.800737;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,3,41:1:0 0,0,0:0:0 +17 4012 . A 0 . DP=14;I16=7,5,0,0,365,11867,0,0,674,38738,0,0,223,5293,0,0;QS=2,0;MQSB=0.6821;MQ0F=0 PL:DP:DV 0,33,231:11:0 0,3,30:1:0 0,0,0:0:0 +17 4013 . C 0 . DP=14;I16=8,5,0,0,451,15885,0,0,734,42338,0,0,247,5995,0,0;QS=2,0;MQSB=0.765017;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,3,37:1:0 0,0,0:0:0 +17 4014 . A 0 . DP=12;I16=8,2,0,0,358,13372,0,0,554,31538,0,0,222,5404,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,213:9:0 0,3,34:1:0 0,0,0:0:0 +17 4015 . C 0 . DP=12;I16=8,2,0,0,350,12812,0,0,554,31538,0,0,222,5442,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,222:9:0 0,3,21:1:0 0,0,0:0:0 +17 4016 . C 0 . DP=12;I16=8,3,0,0,350,11956,0,0,614,35138,0,0,247,6109,0,0;QS=2,0;MQSB=0.829029;MQ0F=0 PL:DP:DV 0,30,215:10:0 0,3,32:1:0 0,0,0:0:0 +17 4017 . C 0 . DP=11;I16=5,2,0,0,227,7765,0,0,374,20738,0,0,173,4279,0,0;QS=2,0;MQSB=0.6;MQ0F=0 PL:DP:DV 0,18,161:6:0 0,3,20:1:0 0,0,0:0:0 +17 4018 . G 0 . DP=11;I16=8,2,0,0,284,8442,0,0,554,31538,0,0,249,6201,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,183:9:0 0,3,17:1:0 0,0,0:0:0 +17 4019 . C 0 . DP=11;I16=9,2,0,0,383,14427,0,0,614,35138,0,0,250,6250,0,0;QS=2,0;MQSB=0.777778;MQ0F=0 PL:DP:DV 0,30,228:10:0 0,3,33:1:0 0,0,0:0:0 +17 4020 . T 0 . DP=10;I16=8,2,0,0,362,13668,0,0,554,31538,0,0,250,6250,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,213:9:0 0,3,38:1:0 0,0,0:0:0 +17 4021 . A 0 . DP=10;I16=8,1,0,0,304,10512,0,0,494,27938,0,0,225,5625,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,177:8:0 0,3,33:1:0 0,0,0:0:0 +17 4022 . C 0 . DP=10;I16=7,2,0,0,310,11582,0,0,494,27938,0,0,225,5625,0,0;QS=2,0;MQSB=0.714286;MQ0F=0 PL:DP:DV 0,24,202:8:0 0,3,36:1:0 0,0,0:0:0 +17 4023 . A 0 . DP=10;I16=8,2,0,0,354,13116,0,0,554,31538,0,0,250,6250,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,209:9:0 0,3,40:1:0 0,0,0:0:0 +17 4024 . C 0 . DP=10;I16=8,2,0,0,361,13669,0,0,554,31538,0,0,250,6250,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,214:9:0 0,3,39:1:0 0,0,0:0:0 +17 4025 . T 0 . DP=10;I16=8,1,0,0,360,14488,0,0,494,27938,0,0,224,5576,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,199:8:0 0,3,42:1:0 0,0,0:0:0 +17 4026 . C 0 . DP=10;I16=8,2,0,0,329,11655,0,0,554,31538,0,0,248,6154,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,192:9:0 0,3,39:1:0 0,0,0:0:0 +17 4027 . C 0 . DP=10;I16=8,2,0,0,380,14888,0,0,554,31538,0,0,246,6060,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,231:9:0 0,3,38:1:0 0,0,0:0:0 +17 4028 . T 0 . DP=10;I16=8,2,0,0,333,12157,0,0,554,31538,0,0,244,5970,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,202:9:0 0,3,41:1:0 0,0,0:0:0 +17 4029 . T 0 . DP=10;I16=8,2,0,0,377,14333,0,0,554,31538,0,0,242,5884,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,225:9:0 0,3,38:1:0 0,0,0:0:0 +17 4030 . C 0 . DP=10;I16=8,2,0,0,348,12558,0,0,554,31538,0,0,240,5802,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,211:9:0 0,3,30:1:0 0,0,0:0:0 +17 4031 . T 0 . DP=10;I16=8,2,0,0,388,15302,0,0,554,31538,0,0,238,5724,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,229:9:0 0,3,39:1:0 0,0,0:0:0 +17 4032 . T 0 . DP=10;I16=8,2,0,0,341,11901,0,0,554,31538,0,0,236,5650,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,204:9:0 0,3,39:1:0 0,0,0:0:0 +17 4033 . A 0 . DP=10;I16=7,2,0,0,299,10717,0,0,494,27938,0,0,218,5324,0,0;QS=2,0;MQSB=0.714286;MQ0F=0 PL:DP:DV 0,24,193:8:0 0,3,38:1:0 0,0,0:0:0 +17 4034 . G 0 . DP=10;I16=8,2,0,0,347,12527,0,0,554,31538,0,0,231,5465,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,211:9:0 0,3,39:1:0 0,0,0:0:0 +17 4035 . G T, 0 . DP=10;I16=7,2,1,0,316,11900,13,169,494,27938,60,3600,202,4682,25,625;QS=1.9547,0.0452962,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.75;BQB=1;MQ0F=0 PL:DP:DV 0,13,195,24,198,200:9:1 0,3,31,3,31,31:1:0 0,0,0,0,0,0:0:0 +17 4036 . G 0 . DP=10;I16=8,1,0,0,269,8839,0,0,494,27938,0,0,198,4532,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,156:8:0 0,3,34:1:0 0,0,0:0:0 +17 4037 . C 0 . DP=10;I16=8,2,0,0,342,12466,0,0,554,31538,0,0,219,5015,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,210:9:0 0,3,30:1:0 0,0,0:0:0 +17 4038 . T 0 . DP=10;I16=8,2,0,0,335,12149,0,0,554,31538,0,0,215,4881,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,203:9:0 0,3,29:1:0 0,0,0:0:0 +17 4039 . G 0 . DP=10;I16=8,1,0,0,302,10798,0,0,494,27938,0,0,186,4130,0,0;QS=2,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,180:8:0 0,3,31:1:0 0,0,0:0:0 +17 4040 . A 0 . DP=10;I16=8,2,0,0,380,14602,0,0,554,31538,0,0,207,4637,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,223:9:0 0,3,41:1:0 0,0,0:0:0 +17 4041 . T 0 . DP=10;I16=8,2,0,0,367,13633,0,0,554,31538,0,0,202,4478,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,216:9:0 0,3,40:1:0 0,0,0:0:0 +17 4042 . A 0 . DP=10;I16=8,2,0,0,337,11657,0,0,554,31538,0,0,197,4329,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,205:9:0 0,3,34:1:0 0,0,0:0:0 +17 4043 . T 0 . DP=10;I16=8,2,0,0,314,10428,0,0,554,31538,0,0,192,4190,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,190:9:0 0,3,35:1:0 0,0,0:0:0 +17 4044 . T 0 . DP=10;I16=8,2,0,0,333,11579,0,0,554,31538,0,0,187,4061,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,199:9:0 0,3,37:1:0 0,0,0:0:0 +17 4045 . C 0 . DP=10;I16=7,2,0,0,291,10099,0,0,494,27938,0,0,176,3906,0,0;QS=1,0;MQSB=0.714286;MQ0F=0 PL:DP:DV 0,27,204:9:0 0,0,0:0:0 0,0,0:0:0 +17 4046 . C 0 . DP=10;I16=8,2,0,0,356,13032,0,0,554,31538,0,0,177,3833,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,212:9:0 0,3,35:1:0 0,0,0:0:0 +17 4047 . A 0 . DP=10;I16=8,2,0,0,347,12557,0,0,554,31538,0,0,172,3734,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,204:9:0 0,3,40:1:0 0,0,0:0:0 +17 4048 . C 0 . DP=10;I16=8,2,0,0,342,12124,0,0,554,31538,0,0,167,3645,0,0;QS=2,0;MQSB=0.75;MQ0F=0 PL:DP:DV 0,27,202:9:0 0,3,37:1:0 0,0,0:0:0 +17 4049 . G 0 . DP=10;I16=7,2,0,0,260,7786,0,0,494,27938,0,0,146,3310,0,0;QS=2,0;MQSB=0.714286;MQ0F=0 PL:DP:DV 0,24,173:8:0 0,3,24:1:0 0,0,0:0:0 +17 4050 . C 0 . DP=9;I16=6,2,0,0,291,10813,0,0,434,24338,0,0,157,3495,0,0;QS=1,0;MQSB=0.666667;MQ0F=0 PL:DP:DV 0,24,204:8:0 0,0,0:0:0 0,0,0:0:0 +17 4051 . A 0 . DP=8;I16=5,2,0,0,259,9679,0,0,374,20738,0,0,146,3370,0,0;QS=1,0;MQSB=0.6;MQ0F=0 PL:DP:DV 0,21,192:7:0 0,0,0:0:0 0,0,0:0:0 +17 4052 . C 0 . DP=8;I16=5,2,0,0,247,9025,0,0,374,20738,0,0,143,3281,0,0;QS=1,0;MQSB=0.6;MQ0F=0 PL:DP:DV 0,21,190:7:0 0,0,0:0:0 0,0,0:0:0 +17 4053 . C 0 . DP=8;I16=6,2,0,0,254,9000,0,0,434,24338,0,0,146,3234,0,0;QS=1,0;MQSB=0.666667;MQ0F=0 PL:DP:DV 0,24,184:8:0 0,0,0:0:0 0,0,0:0:0 +17 4054 . C 0 . DP=8;I16=3,2,0,0,160,5344,0,0,254,13538,0,0,122,2984,0,0;QS=1,0;MQSB=0.333333;MQ0F=0 PL:DP:DV 0,15,134:5:0 0,0,0:0:0 0,0,0:0:0 +17 4055 . G 0 . DP=8;I16=6,2,0,0,230,6982,0,0,434,24338,0,0,138,3066,0,0;QS=1,0;MQSB=0.666667;MQ0F=0 PL:DP:DV 0,24,169:8:0 0,0,0:0:0 0,0,0:0:0 +17 4056 . C 0 . DP=8;I16=6,2,0,0,275,10153,0,0,434,24338,0,0,134,2994,0,0;QS=1,0;MQSB=0.666667;MQ0F=0 PL:DP:DV 0,24,197:8:0 0,0,0:0:0 0,0,0:0:0 +17 4057 . T 0 . DP=8;I16=5,2,0,0,243,8603,0,0,374,20738,0,0,127,2877,0,0;QS=1,0;MQSB=0.6;MQ0F=0 PL:DP:DV 0,21,182:7:0 0,0,0:0:0 0,0,0:0:0 +17 4058 . A 0 . DP=7;I16=4,2,0,0,214,7742,0,0,314,17138,0,0,116,2728,0,0;QS=1,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,18,171:6:0 0,0,0:0:0 0,0,0:0:0 +17 4059 . C 0 . DP=6;I16=4,2,0,0,204,7164,0,0,314,17138,0,0,119,2635,0,0;QS=1,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,18,168:6:0 0,0,0:0:0 0,0,0:0:0 +17 4060 . A 0 . DP=6;I16=4,2,0,0,227,8683,0,0,314,17138,0,0,115,2501,0,0;QS=1,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,18,177:6:0 0,0,0:0:0 0,0,0:0:0 +17 4061 . C 0 . DP=6;I16=4,2,0,0,193,6681,0,0,314,17138,0,0,111,2375,0,0;QS=1,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,18,157:6:0 0,0,0:0:0 0,0,0:0:0 +17 4062 . T 0 . DP=6;I16=4,1,0,0,195,7621,0,0,254,13538,0,0,82,1632,0,0;QS=1,0;MQSB=1;MQ0F=0 PL:DP:DV 0,15,151:5:0 0,0,0:0:0 0,0,0:0:0 +17 4063 . C 0 . DP=6;I16=4,2,0,0,216,7984,0,0,314,17138,0,0,102,2098,0,0;QS=1,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,18,170:6:0 0,0,0:0:0 0,0,0:0:0 +17 4064 . C 0 . DP=6;I16=4,2,0,0,227,8747,0,0,314,17138,0,0,97,1949,0,0;QS=1,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,18,177:6:0 0,0,0:0:0 0,0,0:0:0 +17 4065 . T 0 . DP=6;I16=4,2,0,0,202,6880,0,0,314,17138,0,0,92,1810,0,0;QS=1,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,18,161:6:0 0,0,0:0:0 0,0,0:0:0 +17 4066 . T 0 . DP=5;I16=3,2,0,0,180,6554,0,0,254,13538,0,0,88,1680,0,0;QS=1,0;MQSB=0.333333;MQ0F=0 PL:DP:DV 0,15,153:5:0 0,0,0:0:0 0,0,0:0:0 +17 4067 . C 0 . DP=5;I16=3,2,0,0,181,6637,0,0,254,13538,0,0,84,1558,0,0;QS=1,0;MQSB=0.333333;MQ0F=0 PL:DP:DV 0,15,153:5:0 0,0,0:0:0 0,0,0:0:0 +17 4068 . T 0 . DP=5;I16=3,2,0,0,198,7868,0,0,254,13538,0,0,80,1444,0,0;QS=1,0;MQSB=0.333333;MQ0F=0 PL:DP:DV 0,15,164:5:0 0,0,0:0:0 0,0,0:0:0 +17 4069 . T 0 . DP=5;I16=3,2,0,0,177,6325,0,0,254,13538,0,0,76,1338,0,0;QS=1,0;MQSB=0.333333;MQ0F=0 PL:DP:DV 0,15,154:5:0 0,0,0:0:0 0,0,0:0:0 +17 4070 . A 0 . DP=5;I16=3,2,0,0,161,5263,0,0,254,13538,0,0,72,1240,0,0;QS=1,0;MQSB=0.333333;MQ0F=0 PL:DP:DV 0,15,140:5:0 0,0,0:0:0 0,0,0:0:0 +17 4071 . G 0 . DP=5;I16=3,2,0,0,166,5658,0,0,254,13538,0,0,68,1150,0,0;QS=1,0;MQSB=0.333333;MQ0F=0 PL:DP:DV 0,15,142:5:0 0,0,0:0:0 0,0,0:0:0 +17 4072 . G 0 . DP=5;I16=2,2,0,0,138,4974,0,0,194,9938,0,0,55,987,0,0;QS=1,0;MQSB=0;MQ0F=0 PL:DP:DV 0,12,122:4:0 0,0,0:0:0 0,0,0:0:0 +17 4073 . G 0 . DP=5;I16=3,2,0,0,156,5082,0,0,254,13538,0,0,60,994,0,0;QS=1,0;MQSB=0.333333;MQ0F=0 PL:DP:DV 0,15,136:5:0 0,0,0:0:0 0,0,0:0:0 +17 4074 . C 0 . DP=5;I16=3,2,0,0,160,5602,0,0,254,13538,0,0,56,928,0,0;QS=1,0;MQSB=0.333333;MQ0F=0 PL:DP:DV 0,15,142:5:0 0,0,0:0:0 0,0,0:0:0 +17 4075 . T 0 . DP=5;I16=3,2,0,0,187,7069,0,0,254,13538,0,0,52,870,0,0;QS=1,0;MQSB=0.333333;MQ0F=0 PL:DP:DV 0,15,155:5:0 0,0,0:0:0 0,0,0:0:0 +17 4076 . G 0 . DP=5;I16=3,2,0,0,174,6298,0,0,254,13538,0,0,48,820,0,0;QS=1,0;MQSB=0.333333;MQ0F=0 PL:DP:DV 0,15,149:5:0 0,0,0:0:0 0,0,0:0:0 +17 4077 . A 0 . DP=4;I16=3,1,0,0,138,4810,0,0,194,9938,0,0,44,728,0,0;QS=1,0;MQSB=1;MQ0F=0 PL:DP:DV 0,12,121:4:0 0,0,0:0:0 0,0,0:0:0 +17 4078 . T 0 . DP=4;I16=3,1,0,0,143,5173,0,0,194,9938,0,0,40,644,0,0;QS=1,0;MQSB=1;MQ0F=0 PL:DP:DV 0,12,124:4:0 0,0,0:0:0 0,0,0:0:0 +17 4079 . A 0 . DP=4;I16=3,1,0,0,121,3847,0,0,194,9938,0,0,36,568,0,0;QS=1,0;MQSB=1;MQ0F=0 PL:DP:DV 0,12,107:4:0 0,0,0:0:0 0,0,0:0:0 +17 4080 . T 0 . DP=4;I16=3,0,0,0,106,3778,0,0,134,6338,0,0,25,451,0,0;QS=1,0;MQ0F=0 PL:DP:DV 0,9,87:3:0 0,0,0:0:0 0,0,0:0:0 +17 4081 . T 0 . DP=4;I16=3,1,0,0,106,2934,0,0,194,9938,0,0,28,440,0,0;QS=1,0;MQSB=1;MQ0F=0 PL:DP:DV 0,12,94:4:0 0,0,0:0:0 0,0,0:0:0 +17 4082 . C 0 . DP=3;I16=2,1,0,0,110,4042,0,0,134,6338,0,0,25,387,0,0;QS=1,0;MQSB=1;MQ0F=0 PL:DP:DV 0,9,103:3:0 0,0,0:0:0 0,0,0:0:0 +17 4083 . C 0 . DP=3;I16=2,1,0,0,104,3648,0,0,134,6338,0,0,22,340,0,0;QS=1,0;MQSB=1;MQ0F=0 PL:DP:DV 0,9,98:3:0 0,0,0:0:0 0,0,0:0:0 +17 4084 . A 0 . DP=2;I16=1,1,0,0,78,3050,0,0,97,4969,0,0,20,298,0,0;QS=1,0;MQSB=1;MQ0F=0 PL:DP:DV 0,6,74:2:0 0,0,0:0:0 0,0,0:0:0 +17 4085 . C 0 . DP=2;I16=1,1,0,0,62,1940,0,0,97,4969,0,0,18,260,0,0;QS=1,0;MQSB=1;MQ0F=0 PL:DP:DV 0,6,62:2:0 0,0,0:0:0 0,0,0:0:0 +17 4086 . G 0 . DP=2;I16=1,1,0,0,56,1640,0,0,97,4969,0,0,16,226,0,0;QS=1,0;MQSB=1;MQ0F=0 PL:DP:DV 0,6,56:2:0 0,0,0:0:0 0,0,0:0:0 +17 4087 . C 0 . DP=2;I16=1,1,0,0,69,2405,0,0,97,4969,0,0,14,196,0,0;QS=1,0;MQSB=1;MQ0F=0 PL:DP:DV 0,6,68:2:0 0,0,0:0:0 0,0,0:0:0 +17 4088 . A 0 . DP=1;I16=1,0,0,0,39,1521,0,0,37,1369,0,0,13,169,0,0;QS=1,0;MQ0F=0 PL:DP:DV 0,3,37:1:0 0,0,0:0:0 0,0,0:0:0 +17 4089 . C 0 . DP=1;I16=1,0,0,0,36,1296,0,0,37,1369,0,0,12,144,0,0;QS=1,0;MQ0F=0 PL:DP:DV 0,3,36:1:0 0,0,0:0:0 0,0,0:0:0 +17 4090 . C 0 . DP=1;I16=1,0,0,0,33,1089,0,0,37,1369,0,0,11,121,0,0;QS=1,0;MQ0F=0 PL:DP:DV 0,3,33:1:0 0,0,0:0:0 0,0,0:0:0 +17 4091 . T 0 . DP=1;I16=1,0,0,0,36,1296,0,0,37,1369,0,0,10,100,0,0;QS=1,0;MQ0F=0 PL:DP:DV 0,3,36:1:0 0,0,0:0:0 0,0,0:0:0 +17 4092 . G 0 . DP=1;I16=1,0,0,0,37,1369,0,0,37,1369,0,0,9,81,0,0;QS=1,0;MQ0F=0 PL:DP:DV 0,3,37:1:0 0,0,0:0:0 0,0,0:0:0 +17 4093 . C 0 . DP=1;I16=1,0,0,0,35,1225,0,0,37,1369,0,0,8,64,0,0;QS=1,0;MQ0F=0 PL:DP:DV 0,3,35:1:0 0,0,0:0:0 0,0,0:0:0 +17 4094 . T 0 . DP=1;I16=1,0,0,0,40,1600,0,0,37,1369,0,0,7,49,0,0;QS=1,0;MQ0F=0 PL:DP:DV 0,3,37:1:0 0,0,0:0:0 0,0,0:0:0 +17 4095 . A 0 . DP=1;I16=1,0,0,0,35,1225,0,0,37,1369,0,0,6,36,0,0;QS=1,0;MQ0F=0 PL:DP:DV 0,3,35:1:0 0,0,0:0:0 0,0,0:0:0 +17 4096 . C 0 . DP=1;I16=1,0,0,0,32,1024,0,0,37,1369,0,0,5,25,0,0;QS=1,0;MQ0F=0 PL:DP:DV 0,3,32:1:0 0,0,0:0:0 0,0,0:0:0 +17 4097 . A 0 . DP=1;I16=1,0,0,0,35,1225,0,0,37,1369,0,0,4,16,0,0;QS=1,0;MQ0F=0 PL:DP:DV 0,3,35:1:0 0,0,0:0:0 0,0,0:0:0 +17 4098 . C 0 . DP=1;I16=1,0,0,0,31,961,0,0,37,1369,0,0,3,9,0,0;QS=1,0;MQ0F=0 PL:DP:DV 0,3,31:1:0 0,0,0:0:0 0,0,0:0:0 +17 4099 . T 0 . DP=1;I16=1,0,0,0,32,1024,0,0,37,1369,0,0,2,4,0,0;QS=1,0;MQ0F=0 PL:DP:DV 0,3,32:1:0 0,0,0:0:0 0,0,0:0:0 +17 4100 . C 0 . DP=1;I16=1,0,0,0,27,729,0,0,37,1369,0,0,1,1,0,0;QS=1,0;MQ0F=0 PL:DP:DV 0,3,27:1:0 0,0,0:0:0 0,0,0:0:0 +17 4101 . C 0 . DP=1;I16=1,0,0,0,26,676,0,0,37,1369,0,0,0,0,0,0;QS=1,0;MQ0F=0 PL:DP:DV 0,3,26:1:0 0,0,0:0:0 0,0,0:0:0 diff --git a/test/test.pl b/test/test.pl index b5b12e337..899ea169a 100755 --- a/test/test.pl +++ b/test/test.pl @@ -144,10 +144,10 @@ test_vcf_call($opts,in=>'mpileup.X',out=>'mpileup.X.out',args=>'-mv --ploidy-file {PATH}/mpileup.ploidy -S {PATH}/mpileup.samples'); test_vcf_call($opts,in=>'mpileup.X',out=>'mpileup.X.out',args=>'-mv --ploidy-file {PATH}/mpileup.ploidy -S {PATH}/mpileup.ped'); test_vcf_call_cAls($opts,in=>'mpileup',out=>'mpileup.cAls.out',tab=>'mpileup'); -test_vcf_call($opts,in=>'mpileup',out=>'mpileup.c.1.out',args=>'-cv'); -# test_vcf_call($opts,in=>'mpileup',out=>'mpileup.c.2.out',args=>'-cg0'); -test_vcf_call($opts,in=>'mpileup.X',out=>'mpileup.c.X.out',args=>'-cv --ploidy-file {PATH}/mpileup.ploidy -S {PATH}/mpileup.samples'); -test_vcf_call($opts,in=>'mpileup.X',out=>'mpileup.c.X.out',args=>'-cv --ploidy-file {PATH}/mpileup.ploidy -S {PATH}/mpileup.ped'); +test_vcf_call($opts,in=>'mpileup.c',out=>'mpileup.c.1.out',args=>'-cv'); +# test_vcf_call($opts,in=>'mpileup.c',out=>'mpileup.c.2.out',args=>'-cg0'); +test_vcf_call($opts,in=>'mpileup.c.X',out=>'mpileup.c.X.out',args=>'-cv --ploidy-file {PATH}/mpileup.ploidy -S {PATH}/mpileup.samples'); +test_vcf_call($opts,in=>'mpileup.c.X',out=>'mpileup.c.X.out',args=>'-cv --ploidy-file {PATH}/mpileup.ploidy -S {PATH}/mpileup.ped'); test_vcf_filter($opts,in=>'filter.1',out=>'filter.1.out',args=>'-mx -g2 -G2'); test_vcf_filter($opts,in=>'filter.2',out=>'filter.2.out',args=>q[-e'QUAL==59.2 || (INDEL=0 & (FMT/GQ=25 | FMT/DP=10))' -sModified -S.]); test_vcf_filter($opts,in=>'filter.3',out=>'filter.3.out',args=>q[-e'DP=19'],fmt=>'%POS\\t%FILTER\\t%DP[\\t%GT]\\n'); From 71921ca39706fb7b15165ed76729c24a6b89e8cf Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Mon, 30 Nov 2015 09:58:36 +0000 Subject: [PATCH 126/211] call -mC alleles fix: Do not take X as last in ALT list for granted --- mcall.c | 29 ++++++++++++++++++++++------- test/mpileup.2.out | 2 +- test/mpileup.cAls.out | 7 +++++++ test/mpileup.tab | 7 +++++++ test/mpileup.vcf | 14 +++++++------- 5 files changed, 44 insertions(+), 15 deletions(-) diff --git a/mcall.c b/mcall.c index 70d617c79..495f849a8 100644 --- a/mcall.c +++ b/mcall.c @@ -1255,7 +1255,11 @@ void mcall_trim_numberR(call_t *call, bcf1_t *rec, int nals, int nout_als, int o } } -static void mcall_constrain_alleles(call_t *call, bcf1_t *rec, int unseen) + +// NB: in this function we temporarily use calls->als_map for a different +// purpose to store mapping from new (target) alleles to original alleles. +// +static void mcall_constrain_alleles(call_t *call, bcf1_t *rec, int *unseen) { bcf_sr_regions_t *tgt = call->srs->targets; if ( tgt->nals>5 ) error("Maximum accepted number of alleles is 5, got %d\n", tgt->nals); @@ -1278,6 +1282,8 @@ static void mcall_constrain_alleles(call_t *call, bcf1_t *rec, int unseen) call->als[nals] = tgt->als[i]; j = vcmp_find_allele(call->vcmp, rec->d.allele+1, rec->n_allele - 1, tgt->als[i]); + if ( j+1==*unseen ) error("Cannot constrain to %s\n",tgt->als[i]); + if ( j>=0 ) { // existing allele @@ -1290,11 +1296,18 @@ static void mcall_constrain_alleles(call_t *call, bcf1_t *rec, int unseen) // present at multiallelic indels sites. In that case we use the // last allele anyway, because the least likely allele comes last // in mpileup's ALT output. - call->als_map[nals] = unseen>=0 ? unseen : rec->n_allele - 1; + call->als_map[nals] = (*unseen)>=0 ? *unseen : rec->n_allele - 1; has_new = 1; } nals++; } + if ( *unseen ) + { + call->als_map[nals] = *unseen; + call->als[nals] = rec->d.allele[*unseen]; + nals++; + } + if ( !has_new && nals==rec->n_allele ) return; bcf_update_alleles(call->hdr, rec, (const char**)call->als, nals); @@ -1321,15 +1334,15 @@ static void mcall_constrain_alleles(call_t *call, bcf1_t *rec, int unseen) for (k=0; kpl_map[k]]; - if ( new_pl[k]==bcf_int32_missing && unseen>=0 ) + if ( new_pl[k]==bcf_int32_missing && *unseen>=0 ) { // missing value, and there is an unseen allele: identify the // alleles and use the lk of either AX or XX int k_ori = call->pl_map[k], ia, ib; bcf_gt2alleles(k_ori, &ia, &ib); - k_ori = bcf_alleles2gt(ia,unseen); - if ( ori_pl[k_ori]==bcf_int32_missing ) k_ori = bcf_alleles2gt(ib,unseen); - if ( ori_pl[k_ori]==bcf_int32_missing ) k_ori = bcf_alleles2gt(unseen,unseen); + k_ori = bcf_alleles2gt(ia,*unseen); + if ( ori_pl[k_ori]==bcf_int32_missing ) k_ori = bcf_alleles2gt(ib,*unseen); + if ( ori_pl[k_ori]==bcf_int32_missing ) k_ori = bcf_alleles2gt(*unseen,*unseen); new_pl[k] = ori_pl[k_ori]; } if ( !k && new_pl[k]==bcf_int32_vector_end ) new_pl[k]=bcf_int32_missing; @@ -1345,6 +1358,8 @@ static void mcall_constrain_alleles(call_t *call, bcf1_t *rec, int unseen) for (i=0; ials_map[i]qsum[call->als_map[i]] : 0; bcf_update_info_float(call->hdr, rec, "QS", qsum, nals); + + if ( *unseen ) *unseen = nals-1; } @@ -1359,7 +1374,7 @@ int mcall(call_t *call, bcf1_t *rec) int i, unseen = call->unseen; // Force alleles when calling genotypes given alleles was requested - if ( call->flag & CALL_CONSTR_ALLELES ) mcall_constrain_alleles(call, rec, unseen); + if ( call->flag & CALL_CONSTR_ALLELES ) mcall_constrain_alleles(call, rec, &unseen); int nsmpl = bcf_hdr_nsamples(call->hdr); int nals = rec->n_allele; diff --git a/test/mpileup.2.out b/test/mpileup.2.out index 1090fbd52..d6571607a 100644 --- a/test/mpileup.2.out +++ b/test/mpileup.2.out @@ -29,7 +29,7 @@ ##INFO= ##INFO= #CHROM POS ID REF ALT QUAL FILTER INFO FORMAT HG00100 HG00101 HG00102 -17 1 . A . . . END=301;MinDP=1 GT:DP 0/0:5 0/0:1 0/0:3 +17 1 . A . . . END=301;MinDP=1 GT:DP ./.:5 ./.:1 ./.:3 17 302 . T TA 488 . INDEL;IDV=7;IMF=1;DP=25;VDB=0.27613;SGB=-4.22417;MQSB=0.0443614;MQ0F=0;ICB=0.8;HOB=0.222222;AC=4;AN=6;DP4=2,4,8,11;MQ=49 GT:PL:DP:DV 0/1:167,0,96:11:6 0/1:157,0,9:7:6 1/1:201,21,0:7:7 17 303 . G . . . END=827;MinDP=2 GT:DP 0/0:9 0/0:2 0/0:3 17 828 . T C 409 . DP=25;VDB=0.842082;SGB=-4.20907;RPB=0.950652;MQB=1;MQSB=1;BQB=0.929717;MQ0F=0;ICB=0.8;HOB=0.222222;AC=4;AN=6;DP4=2,4,8,11;MQ=60 GT:PL:DP:DV 0/1:211,0,35:12:10 0/1:116,0,91:9:5 1/1:120,12,0:4:4 diff --git a/test/mpileup.cAls.out b/test/mpileup.cAls.out index 660e7f5a2..105f2944a 100644 --- a/test/mpileup.cAls.out +++ b/test/mpileup.cAls.out @@ -27,6 +27,13 @@ ##INFO= ##INFO= #CHROM POS ID REF ALT QUAL FILTER INFO FORMAT HG00100 HG00101 HG00102 +17 1 . A G,T 0 . DP=11;MQ0F=0;AC=0,0;AN=0;DP4=11,0,0,0;MQ=29 GT:PL:DP:DV ./.:0,0,0,0,0,0:5:0 ./.:.:3:0 ./.:.:3:0 +17 2 . A T,G 0 . DP=11;MQ0F=0;AC=0,0;AN=0;DP4=11,0,0,0;MQ=29 GT:PL:DP:DV ./.:0,0,0,0,0,0:5:0 ./.:.:3:0 ./.:.:3:0 +17 3 . A C 0 . DP=11;MQ0F=0;AC=0;AN=0;DP4=11,0,0,0;MQ=29 GT:PL:DP:DV ./.:0,0,0:5:0 ./.:.:3:0 ./.:.:3:0 +17 4 . A G,T,C 21.815 . DP=11;MQ0F=0;AC=0,0,0;AN=2;DP4=11,0,0,0;MQ=29 GT:PL:DP:DV 0/0:1,2,3,7,8,10,11,12,14,15:5:0 ./.:.:3:0 ./.:.:3:0 +17 5 . A G,T 0 . DP=11;MQ0F=0;AC=0,0;AN=0;DP4=11,0,0,0;MQ=29 GT:PL:DP:DV ./.:0,0,0,0,0,0:5:0 ./.:.:3:0 ./.:.:3:0 +17 6 . A T,G 0 . DP=11;MQ0F=0;AC=0,0;AN=0;DP4=11,0,0,0;MQ=29 GT:PL:DP:DV ./.:0,0,0,0,0,0:5:0 ./.:.:3:0 ./.:.:3:0 +17 7 . A T,G,C 21.5769 . DP=11;MQ0F=0;AC=0,0,0;AN=2;DP4=11,0,0,0;MQ=29 GT:PL:DP:DV 0/0:1,2,3,4,5,6,2,3,5,3:5:0 ./.:.:3:0 ./.:.:3:0 17 828 . T C 409 . DP=25;VDB=0.842082;SGB=-4.20907;RPB=0.950652;MQB=1;MQSB=1;BQB=0.929717;MQ0F=0;ICB=0.8;HOB=0.222222;AC=4;AN=6;DP4=2,4,8,11;MQ=60 GT:PL:DP:DV 0/1:211,0,35:12:10 0/1:116,0,91:9:5 1/1:120,12,0:4:4 17 1665 . T C 3.10665 . DP=20;VDB=0.1;SGB=0.346553;RPB=0.222222;MQB=0.611111;MQSB=0.988166;BQB=0.944444;MQ0F=0;ICB=0.128205;HOB=0.0555556;AC=1;AN=6;DP4=7,11,1,1;MQ=55 GT:PL:DP:DV 0/0:0,21,185:7:0 0/0:0,27,222:9:0 0/1:35,0,51:4:2 17 2220 . G C 999 . DP=21;VDB=0.532753;SGB=-3.51597;RPB=0.964198;MQB=0.898397;MQSB=0.875769;BQB=0.0354359;MQ0F=0;AC=0;AN=6;DP4=6,2,1,11;MQ=58 GT:PL:DP:DV 0/0:139,157,255:12:6 0/0:69,75,119:4:2 0/0:131,131,131:4:4 diff --git a/test/mpileup.tab b/test/mpileup.tab index c585dadf5..1930ea004 100644 --- a/test/mpileup.tab +++ b/test/mpileup.tab @@ -1,3 +1,10 @@ +17 1 A,G,T +17 2 A,T,G +17 3 A,C +17 4 A,C,T,G +17 5 A,G,T +17 6 A,T,G +17 7 A,T,G,C 17 828 T,C 17 1665 T,C 17 2220 G,C diff --git a/test/mpileup.vcf b/test/mpileup.vcf index 13c013225..155af1ba2 100644 --- a/test/mpileup.vcf +++ b/test/mpileup.vcf @@ -22,13 +22,13 @@ ##FORMAT= ##FORMAT= #CHROM POS ID REF ALT QUAL FILTER INFO FORMAT HG00100 HG00101 HG00102 -17 1 . A 0 . DP=11;I16=11,0,0,0,452,18594,0,0,319,9251,0,0,223,4959,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 -17 2 . A 0 . DP=11;I16=11,0,0,0,439,17587,0,0,319,9251,0,0,226,5030,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 -17 3 . G 0 . DP=11;I16=11,0,0,0,431,16971,0,0,319,9251,0,0,229,5111,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 -17 4 . C 0 . DP=11;I16=11,0,0,0,423,16417,0,0,319,9251,0,0,232,5202,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,71:3:0 -17 5 . T 0 . DP=11;I16=11,0,0,0,450,18520,0,0,319,9251,0,0,234,5252,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 -17 6 . T 0 . DP=11;I16=11,0,0,0,403,14847,0,0,319,9251,0,0,236,5310,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 -17 7 . C 0 . DP=11;I16=11,0,0,0,446,18114,0,0,319,9251,0,0,237,5327,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 +17 1 . A G,X,T,C 0 . DP=11;I16=11,0,0,0,452,18594,0,0,319,9251,0,0,223,4959,0,0;QS=1,1,0,1,1;MQ0F=0 PL:DP:DV 0,0,0,0,0,0,.,.,.,.,.,.,.,.,.:5:0 .:3:0 .:3:0 +17 2 . A G,X,T,C 0 . DP=11;I16=11,0,0,0,452,18594,0,0,319,9251,0,0,223,4959,0,0;QS=1,1,0,1,1;MQ0F=0 PL:DP:DV 0,0,0,0,0,0,.,.,.,.,.,.,.,.,.:5:0 .:3:0 .:3:0 +17 3 . A G,X,T,C 0 . DP=11;I16=11,0,0,0,452,18594,0,0,319,9251,0,0,223,4959,0,0;QS=1,1,0,1,1;MQ0F=0 PL:DP:DV 0,0,0,0,0,0,.,.,.,.,.,.,.,.,.:5:0 .:3:0 .:3:0 +17 4 . A G,X,T,C 0 . DP=11;I16=11,0,0,0,452,18594,0,0,319,9251,0,0,223,4959,0,0;QS=1,1,0,1,1;MQ0F=0 PL:DP:DV 1,2,3,4,5,6,7,8,9,10,11,12,13,14,15:5:0 .:3:0 .:3:0 +17 5 . A X,G 0 . DP=11;I16=11,0,0,0,452,18594,0,0,319,9251,0,0,223,4959,0,0;QS=1,0,1;MQ0F=0 PL:DP:DV 0,0,0,0,0,0:5:0 .:3:0 .:3:0 +17 6 . A X,G 0 . DP=11;I16=11,0,0,0,452,18594,0,0,319,9251,0,0,223,4959,0,0;QS=1,0,1;MQ0F=0 PL:DP:DV 0,0,0,0,0,0:5:0 .:3:0 .:3:0 +17 7 . A X,G 0 . DP=11;I16=11,0,0,0,452,18594,0,0,319,9251,0,0,223,4959,0,0;QS=1,0,1;MQ0F=0 PL:DP:DV 1,2,3,4,5,6:5:0 .:3:0 .:3:0 17 8 . T 0 . DP=11;I16=11,0,0,0,465,19677,0,0,319,9251,0,0,238,5354,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 17 9 . C 0 . DP=11;I16=11,0,0,0,447,18205,0,0,319,9251,0,0,239,5391,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,72:3:0 17 10 . A 0 . DP=11;I16=11,0,0,0,426,16756,0,0,319,9251,0,0,240,5438,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,15,100:5:0 0,9,72:3:0 0,9,69:3:0 From 6737c5c8074943b51e18fd53458f41a30d623fb7 Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Mon, 9 Nov 2015 18:28:42 +0000 Subject: [PATCH 127/211] add --threads option for output compression threads * `--threads` option added to commands that output VCF/BCF * add this new option to the docs --- doc/bcftools.txt | 34 +++++++++++++++++++-- vcfannotate.c | 39 +++++++++++++----------- vcfcall.c | 63 ++++++++++++++++++++------------------ vcfconcat.c | 31 +++++++++++-------- vcfconvert.c | 22 +++++++++++--- vcffilter.c | 35 ++++++++++++--------- vcfisec.c | 40 +++++++++++++----------- vcfmerge.c | 33 +++++++++++--------- vcfnorm.c | 39 +++++++++++++----------- vcfplugin.c | 33 +++++++++++--------- vcfview.c | 79 +++++++++++++++++++++++++----------------------- 11 files changed, 268 insertions(+), 180 deletions(-) diff --git a/doc/bcftools.txt b/doc/bcftools.txt index 9498e14a1..e26692dbd 100644 --- a/doc/bcftools.txt +++ b/doc/bcftools.txt @@ -255,6 +255,11 @@ specific commands to see if they apply. bcftools query -f'%CHROM\t%POS\t%REF,%ALT\n' file.vcf | bgzip -c > als.tsv.gz && tabix -s1 -b2 -e2 als.tsv.gz ---- +*--threads* 'INT':: + Number of output compression threads to use in addition to main thread. + Only used when '--output-type' is 'b' or 'z'. Default: 0. + + [[annotate]] === bcftools annotate '[OPTIONS]' 'FILE' @@ -359,6 +364,9 @@ This command allows to add or remove annotations. given as "src_name dst_name\n", separated by whitespaces, each pair on a separate line. +*--threads* 'INT':: + see *<>* + *-x, --remove* 'list':: List of annotations to remove. Use "FILTER" to remove all filters or "FILTER/SomeFilter" to remove a specific filter. Similarly, "INFO" can @@ -490,6 +498,9 @@ demand. The original calling model can be invoked with the *-c* option. ==== File format options: +*-o, --output* 'FILE':: + see *<>* + *-O, --output-type* 'b'|'u'|'z'|'v':: see *<>* @@ -533,6 +544,9 @@ demand. The original calling model can be invoked with the *-c* option. *-T, --targets-file* 'FILE':: see *<>* +*--threads* 'INT':: + see *<>* + ==== Input/output options: *-A, --keep-alts*:: @@ -555,9 +569,6 @@ demand. The original calling model can be invoked with the *-c* option. *-M, --keep-masked-ref*:: output sites where REF allele is N -*-o, --output* 'FILE':: - see *<>* - *-V, --skip-variants* 'snps'|'indels':: skip indel/SNP sites @@ -655,6 +666,9 @@ the *-a, --allow-overlaps* option is specified. *-R, --regions-file* 'FILE':: see *<>*. Requires *-a, --allow-overlaps*. +*--threads* 'INT':: + see *<>* + [[consensus]] === bcftools consensus '[OPTIONS]' 'FILE' @@ -731,6 +745,9 @@ Create consensus sequence by applying VCF variants to a reference fasta file. *-O, --output-type* 'b'|'u'|'z'|'v':: see *<>* +*--threads* 'INT':: + see *<>* + ==== GEN/SAMPLE conversion: *-G, --gensample2vcf* 'prefix' or 'gen-file','sample-file':: convert IMPUTE2 output to VCF. The second column must be of the form @@ -1204,6 +1221,8 @@ For "vertical" merge take a look at *<>* instead. *-R, --regions-file* 'file':: see *<>* +*--threads* 'INT':: + see *<>* [[norm]] @@ -1269,6 +1288,9 @@ the *<>* option is supplied. *-T, --targets-file* 'FILE':: see *<>* +*--threads* 'INT':: + see *<>* + *-w, --site-win* 'INT':: maximum distance between two records to consider when locally sorting variants which changed position during the realignment @@ -1307,6 +1329,9 @@ the *<>* option is supplied. *-O, --output-type* 'b'|'u'|'z'|'v':: see *<>* +*--threads* 'INT':: + see *<>* + ==== Plugin options: *-h, --help*:: @@ -1783,6 +1808,9 @@ Convert between VCF and BCF. Former *bcftools subset*. *-T, --targets-file* 'file':: see *<>* +*--threads* 'INT':: + see *<>* + ==== Subset options: *-a, --trim-alt-alleles*:: diff --git a/vcfannotate.c b/vcfannotate.c index d653bcd4d..96a1649c5 100644 --- a/vcfannotate.c +++ b/vcfannotate.c @@ -87,7 +87,7 @@ typedef struct _args_t bcf_srs_t *files; bcf_hdr_t *hdr, *hdr_out; htsFile *out_fh; - int output_type; + int output_type, n_threads; bcf_sr_regions_t *tgts; filter_t *filter; @@ -1426,6 +1426,7 @@ static void init_data(args_t *args) args->out_fh = hts_open(args->output_fname,hts_bcf_wmode(args->output_type)); if ( args->out_fh == NULL ) error("Can't write to \"%s\": %s\n", args->output_fname, strerror(errno)); + if ( args->n_threads ) hts_set_threads(args->out_fh, args->n_threads); bcf_hdr_write(args->out_fh, args->hdr_out); } } @@ -1634,6 +1635,7 @@ static void usage(args_t *args) fprintf(stderr, " -s, --samples [^] comma separated list of samples to annotate (or exclude with \"^\" prefix)\n"); fprintf(stderr, " -S, --samples-file [^] file of samples to annotate (or exclude with \"^\" prefix)\n"); fprintf(stderr, " -x, --remove list of annotations to remove (e.g. ID,INFO/DP,FORMAT/DP,FILTER). See man page for details\n"); + fprintf(stderr, " --threads number of extra output compression threads [0]\n"); fprintf(stderr, "\n"); exit(1); } @@ -1646,28 +1648,30 @@ int main_vcfannotate(int argc, char *argv[]) args->files = bcf_sr_init(); args->output_fname = "-"; args->output_type = FT_VCF; + args->n_threads = 0; args->ref_idx = args->alt_idx = args->chr_idx = args->from_idx = args->to_idx = -1; args->set_ids_replace = 1; int regions_is_file = 0; static struct option loptions[] = { - {"mark-sites",1,0,'m'}, - {"set-id",1,0,'I'}, - {"output",1,0,'o'}, - {"output-type",1,0,'O'}, - {"annotations",1,0,'a'}, - {"include",1,0,'i'}, - {"exclude",1,0,'e'}, - {"regions",1,0,'r'}, - {"regions-file",1,0,'R'}, - {"remove",1,0,'x'}, - {"columns",1,0,'c'}, - {"rename-chrs",1,0,1}, - {"header-lines",1,0,'h'}, - {"samples",1,0,'s'}, - {"samples-file",1,0,'S'}, - {0,0,0,0} + {"mark-sites",required_argument,NULL,'m'}, + {"set-id",required_argument,NULL,'I'}, + {"output",required_argument,NULL,'o'}, + {"output-type",required_argument,NULL,'O'}, + {"threads",required_argument,NULL,9}, + {"annotations",required_argument,NULL,'a'}, + {"include",required_argument,NULL,'i'}, + {"exclude",required_argument,NULL,'e'}, + {"regions",required_argument,NULL,'r'}, + {"regions-file",required_argument,NULL,'R'}, + {"remove",required_argument,NULL,'x'}, + {"columns",required_argument,NULL,'c'}, + {"rename-chrs",required_argument,NULL,1}, + {"header-lines",required_argument,NULL,'h'}, + {"samples",required_argument,NULL,'s'}, + {"samples-file",required_argument,NULL,'S'}, + {NULL,0,NULL,0} }; while ((c = getopt_long(argc, argv, "h:?o:O:r:R:a:x:c:i:e:S:s:I:m:",loptions,NULL)) >= 0) { @@ -1700,6 +1704,7 @@ int main_vcfannotate(int argc, char *argv[]) case 'R': args->regions_list = optarg; regions_is_file = 1; break; case 'h': args->header_fname = optarg; break; case 1 : args->rename_chrs = optarg; break; + case 9 : args->n_threads = strtol(optarg, 0, 0); break; case '?': usage(args); break; default: error("Unknown argument: %s\n", optarg); } diff --git a/vcfcall.c b/vcfcall.c index 2287936bc..a28caee6a 100644 --- a/vcfcall.c +++ b/vcfcall.c @@ -68,7 +68,7 @@ void error(const char *format, ...); typedef struct { int flag; // combination of CF_* flags above - int output_type; + int output_type, n_threads; htsFile *bcf_in, *out_fh; char *bcf_fname, *output_fname; char **samples; // for subsampling and ploidy @@ -425,6 +425,7 @@ static void init_data(args_t *args) args->out_fh = hts_open(args->output_fname, hts_bcf_wmode(args->output_type)); if ( args->out_fh == NULL ) error("Can't write to \"%s\": %s\n", args->output_fname, strerror(errno)); + if ( args->n_threads ) hts_set_threads(args->out_fh, args->n_threads); if ( args->flag & CF_QCALL ) return; @@ -588,6 +589,7 @@ static void usage(args_t *args) fprintf(stderr, " -S, --samples-file PED file or a file with an optional column with sex (see man page for details) [all samples]\n"); fprintf(stderr, " -t, --targets similar to -r but streams rather than index-jumps\n"); fprintf(stderr, " -T, --targets-file similar to -R but streams rather than index-jumps\n"); + fprintf(stderr, " --threads number of extra output compression threads [0]\n"); fprintf(stderr, "\n"); fprintf(stderr, "Input/output options:\n"); fprintf(stderr, " -A, --keep-alts keep all possible alternate alleles at variant sites\n"); @@ -631,40 +633,42 @@ int main_vcfcall(int argc, char *argv[]) args.flag = CF_ACGT_ONLY; args.output_fname = "-"; args.output_type = FT_VCF; + args.n_threads = 0; args.aux.trio_Pm_SNPs = 1 - 1e-8; args.aux.trio_Pm_ins = args.aux.trio_Pm_del = 1 - 1e-9; int c; static struct option loptions[] = { - {"help",0,0,'h'}, - {"format-fields",1,0,'f'}, - {"gvcf",1,0,'g'}, - {"output",1,0,'o'}, - {"output-type",1,0,'O'}, - {"regions",1,0,'r'}, - {"regions-file",1,0,'R'}, - {"samples",1,0,'s'}, - {"samples-file",1,0,'S'}, - {"targets",1,0,'t'}, - {"targets-file",1,0,'T'}, - {"keep-alts",0,0,'A'}, - {"insert-missed",0,0,'i'}, - {"skip-Ns",0,0,'N'}, // now the new default - {"keep-masked-refs",0,0,'M'}, - {"skip-variants",1,0,'V'}, - {"variants-only",0,0,'v'}, - {"consensus-caller",0,0,'c'}, - {"constrain",1,0,'C'}, - {"multiallelic-caller",0,0,'m'}, - {"pval-threshold",1,0,'p'}, - {"prior",1,0,'P'}, - {"novel-rate",1,0,'n'}, - {"ploidy",1,0,1}, - {"ploidy-file",1,0,2}, - {"chromosome-X",1,0,'X'}, - {"chromosome-Y",1,0,'Y'}, - {0,0,0,0} + {"help",no_argument,NULL,'h'}, + {"format-fields",required_argument,NULL,'f'}, + {"gvcf",required_argument,NULL,'g'}, + {"output",required_argument,NULL,'o'}, + {"output-type",required_argument,NULL,'O'}, + {"regions",required_argument,NULL,'r'}, + {"regions-file",required_argument,NULL,'R'}, + {"samples",required_argument,NULL,'s'}, + {"samples-file",required_argument,NULL,'S'}, + {"targets",required_argument,NULL,'t'}, + {"targets-file",required_argument,NULL,'T'}, + {"threads",required_argument,NULL,9}, + {"keep-alts",no_argument,NULL,'A'}, + {"insert-missed",no_argument,NULL,'i'}, + {"skip-Ns",no_argument,NULL,'N'}, // now the new default + {"keep-masked-refs",no_argument,NULL,'M'}, + {"skip-variants",required_argument,NULL,'V'}, + {"variants-only",no_argument,NULL,'v'}, + {"consensus-caller",no_argument,NULL,'c'}, + {"constrain",required_argument,NULL,'C'}, + {"multiallelic-caller",no_argument,NULL,'m'}, + {"pval-threshold",required_argument,NULL,'p'}, + {"prior",required_argument,NULL,'P'}, + {"novel-rate",required_argument,NULL,'n'}, + {"ploidy",required_argument,NULL,1}, + {"ploidy-file",required_argument,NULL,2}, + {"chromosome-X",no_argument,NULL,'X'}, + {"chromosome-Y",no_argument,NULL,'Y'}, + {NULL,0,NULL,0} }; char *tmp = NULL; @@ -722,6 +726,7 @@ int main_vcfcall(int argc, char *argv[]) case 'T': args.targets = optarg; args.targets_is_file = 1; break; case 's': args.samples_fname = optarg; break; case 'S': args.samples_fname = optarg; args.samples_is_file = 1; break; + case 9 : args.n_threads = strtol(optarg, 0, 0); break; default: usage(&args); } } diff --git a/vcfconcat.c b/vcfconcat.c index f5370f1ba..cfec7c01a 100644 --- a/vcfconcat.c +++ b/vcfconcat.c @@ -37,7 +37,7 @@ typedef struct _args_t { bcf_srs_t *files; htsFile *out_fh; - int output_type; + int output_type, n_threads; bcf_hdr_t *out_hdr; int *seen_seq; @@ -109,6 +109,7 @@ static void init_data(args_t *args) bcf_hdr_append_version(args->out_hdr, args->argc, args->argv, "bcftools_concat"); args->out_fh = hts_open(args->output_fname,hts_bcf_wmode(args->output_type)); if ( args->out_fh == NULL ) error("Can't write to \"%s\": %s\n", args->output_fname, strerror(errno)); + if ( args->n_threads ) hts_set_threads(args->out_fh, args->n_threads); bcf_hdr_write(args->out_fh, args->out_hdr); @@ -572,6 +573,7 @@ static void usage(args_t *args) fprintf(stderr, " -q, --min-PQ Break phase set if phasing quality is lower than [30]\n"); fprintf(stderr, " -r, --regions Restrict to comma-separated list of regions\n"); fprintf(stderr, " -R, --regions-file Restrict to regions listed in a file\n"); + fprintf(stderr, " --threads Number of extra output compression threads [0]\n"); fprintf(stderr, "\n"); exit(1); } @@ -583,22 +585,24 @@ int main_vcfconcat(int argc, char *argv[]) args->argc = argc; args->argv = argv; args->output_fname = "-"; args->output_type = FT_VCF; + args->n_threads = 0; args->min_PQ = 30; static struct option loptions[] = { - {"compact-PS",0,0,'c'}, - {"regions",1,0,'r'}, - {"regions-file",1,0,'R'}, - {"remove-duplicates",0,0,'D'}, - {"rm-dups",1,0,'d'}, - {"allow-overlaps",0,0,'a'}, - {"ligate",0,0,'l'}, - {"output",1,0,'o'}, - {"output-type",1,0,'O'}, - {"file-list",1,0,'f'}, - {"min-PQ",1,0,'q'}, - {0,0,0,0} + {"compact-PS",no_argument,NULL,'c'}, + {"regions",required_argument,NULL,'r'}, + {"regions-file",required_argument,NULL,'R'}, + {"remove-duplicates",no_argument,NULL,'D'}, + {"rm-dups",required_argument,NULL,'d'}, + {"allow-overlaps",no_argument,NULL,'a'}, + {"ligate",no_argument,NULL,'l'}, + {"output",required_argument,NULL,'o'}, + {"output-type",required_argument,NULL,'O'}, + {"threads",required_argument,NULL,9}, + {"file-list",required_argument,NULL,'f'}, + {"min-PQ",required_argument,NULL,'q'}, + {NULL,0,NULL,0} }; char *tmp; while ((c = getopt_long(argc, argv, "h:?o:O:f:alq:Dd:r:R:c",loptions,NULL)) >= 0) @@ -626,6 +630,7 @@ int main_vcfconcat(int argc, char *argv[]) default: error("The output type \"%s\" not recognised\n", optarg); }; break; + case 9 : args->n_threads = strtol(optarg, 0, 0); break; case 'h': case '?': usage(args); break; default: error("Unknown argument: %s\n", optarg); diff --git a/vcfconvert.c b/vcfconvert.c index 54d066602..26166dfad 100644 --- a/vcfconvert.c +++ b/vcfconvert.c @@ -66,7 +66,7 @@ struct _args_t int nsamples, *samples, sample_is_file, targets_is_file, regions_is_file, output_type; char **argv, *sample_list, *targets_list, *regions_list, *tag, *columns; char *outfname, *infname, *ref_fname; - int argc; + int argc, n_threads; }; static void destroy_data(args_t *args) @@ -383,6 +383,8 @@ static void gensample_to_vcf(args_t *args) free(samples); htsFile *out_fh = hts_open(args->outfname,hts_bcf_wmode(args->output_type)); + if ( out_fh == NULL ) error("Can't write to \"%s\": %s\n", args->outfname, strerror(errno)); + if ( args->n_threads ) hts_set_threads(out_fh, args->n_threads); bcf_hdr_write(out_fh,args->header); bcf1_t *rec = bcf_init(); @@ -506,6 +508,8 @@ static void haplegendsample_to_vcf(args_t *args) free(samples); htsFile *out_fh = hts_open(args->outfname,hts_bcf_wmode(args->output_type)); + if ( out_fh == NULL ) error("Can't write to \"%s\": %s\n", args->outfname, strerror(errno)); + if ( args->n_threads ) hts_set_threads(out_fh, args->n_threads); bcf_hdr_write(out_fh,args->header); bcf1_t *rec = bcf_init(); @@ -617,6 +621,8 @@ static void hapsample_to_vcf(args_t *args) free(samples); htsFile *out_fh = hts_open(args->outfname,hts_bcf_wmode(args->output_type)); + if ( out_fh == NULL ) error("Can't write to \"%s\": %s\n", args->outfname, strerror(errno)); + if ( args->n_threads ) hts_set_threads(out_fh, args->n_threads); bcf_hdr_write(out_fh,args->header); bcf1_t *rec = bcf_init(); @@ -1152,6 +1158,8 @@ static void tsv_to_vcf(args_t *args) args->gts = (int32_t *) malloc(sizeof(int32_t)*n*2); htsFile *out_fh = hts_open(args->outfname,hts_bcf_wmode(args->output_type)); + if ( out_fh == NULL ) error("Can't write to \"%s\": %s\n", args->outfname, strerror(errno)); + if ( args->n_threads ) hts_set_threads(out_fh, args->n_threads); bcf_hdr_write(out_fh,args->header); tsv_t *tsv = tsv_init(args->columns ? args->columns : "ID,CHROM,POS,AA"); @@ -1200,7 +1208,8 @@ static void vcf_to_vcf(args_t *args) { open_vcf(args,NULL); htsFile *out_fh = hts_open(args->outfname,hts_bcf_wmode(args->output_type)); - if ( !out_fh ) error("Failed to open: %s\n", args->outfname); + if ( out_fh == NULL ) error("Can't write to \"%s\": %s\n", args->outfname, strerror(errno)); + if ( args->n_threads ) hts_set_threads(out_fh, args->n_threads); bcf_hdr_t *hdr = bcf_sr_get_header(args->files,0); bcf_hdr_write(out_fh,hdr); @@ -1228,7 +1237,8 @@ static void gvcf_to_vcf(args_t *args) open_vcf(args,NULL); htsFile *out_fh = hts_open(args->outfname,hts_bcf_wmode(args->output_type)); - if ( !out_fh ) error("Failed to open: %s\n", args->outfname); + if ( out_fh == NULL ) error("Can't write to \"%s\": %s\n", args->outfname, strerror(errno)); + if ( args->n_threads ) hts_set_threads(out_fh, args->n_threads); bcf_hdr_t *hdr = bcf_sr_get_header(args->files,0); bcf_hdr_append_version(hdr, args->argc, args->argv, "bcftools_convert"); @@ -1294,6 +1304,7 @@ static void usage(void) fprintf(stderr, " -S, --samples-file file of samples to include\n"); fprintf(stderr, " -t, --targets similar to -r but streams rather than index-jumps\n"); fprintf(stderr, " -T, --targets-file similar to -R but streams rather than index-jumps\n"); + fprintf(stderr, " --threads number of extra output compression threads [0]\n"); fprintf(stderr, "\n"); fprintf(stderr, "VCF output options:\n"); fprintf(stderr, " -o, --output output file name [stdout]\n"); @@ -1347,6 +1358,7 @@ int main_vcfconvert(int argc, char *argv[]) args->argc = argc; args->argv = argv; args->outfname = "-"; args->output_type = FT_VCF; + args->n_threads = 0; static struct option loptions[] = { @@ -1354,6 +1366,7 @@ int main_vcfconvert(int argc, char *argv[]) {"exclude",required_argument,NULL,'e'}, {"output",required_argument,NULL,'o'}, {"output-type",required_argument,NULL,'O'}, + {"threads",required_argument,NULL,9}, {"regions",required_argument,NULL,'r'}, {"regions-file",required_argument,NULL,'R'}, {"targets",required_argument,NULL,'t'}, @@ -1374,7 +1387,7 @@ int main_vcfconvert(int argc, char *argv[]) {"haplegendsample2vcf",required_argument,NULL,'H'}, {"columns",required_argument,NULL,'c'}, {"fasta-ref",required_argument,NULL,'f'}, - {0,0,0,0} + {NULL,0,NULL,0} }; while ((c = getopt_long(argc, argv, "?h:r:R:s:S:t:T:i:e:g:G:o:O:c:f:H:",loptions,NULL)) >= 0) { switch (c) { @@ -1410,6 +1423,7 @@ int main_vcfconvert(int argc, char *argv[]) } break; case 'h': args->convert_func = vcf_to_haplegendsample; args->outfname = optarg; break; + case 9 : args->n_threads = strtol(optarg, 0, 0); break; case '?': usage(); default: error("Unknown argument: %s\n", optarg); } diff --git a/vcffilter.c b/vcffilter.c index f2abf0f4b..ac4c3a32e 100644 --- a/vcffilter.c +++ b/vcffilter.c @@ -68,7 +68,7 @@ typedef struct _args_t bcf_srs_t *files; bcf_hdr_t *hdr; htsFile *out_fh; - int output_type; + int output_type, n_threads; char **argv, *output_fname, *targets_list, *regions_list; int argc; @@ -79,6 +79,7 @@ static void init_data(args_t *args) { args->out_fh = hts_open(args->output_fname,hts_bcf_wmode(args->output_type)); if ( args->out_fh == NULL ) error("Can't write to \"%s\": %s\n", args->output_fname, strerror(errno)); + if ( args->n_threads ) hts_set_threads(args->out_fh, args->n_threads); args->hdr = args->files->readers[0].header; args->flt_pass = bcf_hdr_id2int(args->hdr,BCF_DT_ID,"PASS"); assert( !args->flt_pass ); // sanity check: required by BCF spec @@ -415,6 +416,7 @@ static void usage(args_t *args) fprintf(stderr, " -S, --set-GTs <.|0> set genotypes of failed samples to missing (.) or ref (0)\n"); fprintf(stderr, " -t, --targets similar to -r but streams rather than index-jumps\n"); fprintf(stderr, " -T, --targets-file similar to -R but streams rather than index-jumps\n"); + fprintf(stderr, " --threads number of extra output compression threads [0]\n"); fprintf(stderr, "\n"); exit(1); } @@ -427,24 +429,26 @@ int main_vcffilter(int argc, char *argv[]) args->files = bcf_sr_init(); args->output_fname = "-"; args->output_type = FT_VCF; + args->n_threads = 0; int regions_is_file = 0, targets_is_file = 0; static struct option loptions[] = { - {"set-GTs",1,0,'S'}, - {"mode",1,0,'m'}, - {"soft-filter",1,0,'s'}, - {"exclude",1,0,'e'}, - {"include",1,0,'i'}, - {"targets",1,0,'t'}, - {"targets-file",1,0,'T'}, - {"regions",1,0,'r'}, - {"regions-file",1,0,'R'}, - {"output",1,0,'o'}, - {"output-type",1,0,'O'}, - {"SnpGap",1,0,'g'}, - {"IndelGap",1,0,'G'}, - {0,0,0,0} + {"set-GTs",required_argument,NULL,'S'}, + {"mode",required_argument,NULL,'m'}, + {"soft-filter",required_argument,NULL,'s'}, + {"exclude",required_argument,NULL,'e'}, + {"include",required_argument,NULL,'i'}, + {"targets",required_argument,NULL,'t'}, + {"targets-file",required_argument,NULL,'T'}, + {"regions",required_argument,NULL,'r'}, + {"regions-file",required_argument,NULL,'R'}, + {"output",required_argument,NULL,'o'}, + {"output-type",required_argument,NULL,'O'}, + {"threads",required_argument,NULL,9}, + {"SnpGap",required_argument,NULL,'g'}, + {"IndelGap",required_argument,NULL,'G'}, + {NULL,0,NULL,0} }; char *tmp; while ((c = getopt_long(argc, argv, "e:i:t:T:r:R:h?s:m:o:O:g:G:S:",loptions,NULL)) >= 0) { @@ -483,6 +487,7 @@ int main_vcffilter(int argc, char *argv[]) else if ( !strcmp("0",optarg) ) args->set_gts = SET_GTS_REF; else error("The argument to -S not recognised: %s\n", optarg); break; + case 9 : args->n_threads = strtol(optarg, 0, 0); break; case 'h': case '?': usage(args); default: error("Unknown argument: %s\n", optarg); diff --git a/vcfisec.c b/vcfisec.c index c082d68d0..611514685 100644 --- a/vcfisec.c +++ b/vcfisec.c @@ -49,7 +49,7 @@ THE SOFTWARE. */ typedef struct { - int isec_op, isec_n, *write, iwrite, nwrite, output_type; + int isec_op, isec_n, *write, iwrite, nwrite, output_type, n_threads; int nflt, *flt_logic; filter_t **flt; char **flt_expr; @@ -142,6 +142,7 @@ void isec_vcf(args_t *args) { out_fh = hts_open(args->output_fname? args->output_fname : "-",hts_bcf_wmode(args->output_type)); if ( out_fh == NULL ) error("Can't write to %s: %s\n", args->output_fname? args->output_fname : "standard output", strerror(errno)); + if ( args->n_threads ) hts_set_threads(out_fh, args->n_threads); bcf_hdr_append_version(files->readers[args->iwrite].header,args->argc,args->argv,"bcftools_isec"); bcf_hdr_write(out_fh, files->readers[args->iwrite].header); } @@ -349,6 +350,7 @@ static void init_data(args_t *args) open_file(&args->fnames[i], NULL, "%s/%04d.%s", args->prefix, i, suffix); \ args->fh_out[i] = hts_open(args->fnames[i], hts_bcf_wmode(args->output_type)); \ if ( !args->fh_out[i] ) error("Could not open %s\n", args->fnames[i]); \ + if ( args->n_threads ) hts_set_threads(args->fh_out[i], args->n_threads); \ bcf_hdr_append_version(args->files->readers[j].header,args->argc,args->argv,"bcftools_isec"); \ bcf_hdr_write(args->fh_out[i], args->files->readers[j].header); \ } @@ -463,6 +465,7 @@ static void usage(void) fprintf(stderr, " -t, --targets similar to -r but streams rather than index-jumps\n"); fprintf(stderr, " -T, --targets-file similar to -R but streams rather than index-jumps\n"); fprintf(stderr, " -w, --write list of files to write with -p given as 1-based indexes. By default, all files are written\n"); + fprintf(stderr, " --threads number of extra output compression threads [0]\n"); fprintf(stderr, "\n"); fprintf(stderr, "Examples:\n"); fprintf(stderr, " # Create intersection and complements of two sets saving the output in dir/*\n"); @@ -488,26 +491,28 @@ int main_vcfisec(int argc, char *argv[]) args->argc = argc; args->argv = argv; args->output_fname = NULL; args->output_type = FT_VCF; + args->n_threads = 0; int targets_is_file = 0, regions_is_file = 0; static struct option loptions[] = { - {"help",0,0,'h'}, - {"exclude",1,0,'e'}, - {"include",1,0,'i'}, - {"collapse",1,0,'c'}, - {"complement",0,0,'C'}, - {"apply-filters",1,0,'f'}, - {"nfiles",1,0,'n'}, - {"prefix",1,0,'p'}, - {"write",1,0,'w'}, - {"targets",1,0,'t'}, - {"targets-file",1,0,'T'}, - {"regions",1,0,'r'}, - {"regions-file",1,0,'R'}, - {"output",1,0,'o'}, - {"output-type",1,0,'O'}, - {0,0,0,0} + {"help",no_argument,NULL,'h'}, + {"exclude",required_argument,NULL,'e'}, + {"include",required_argument,NULL,'i'}, + {"collapse",required_argument,NULL,'c'}, + {"complement",no_argument,NULL,'C'}, + {"apply-filters",required_argument,NULL,'f'}, + {"nfiles",required_argument,NULL,'n'}, + {"prefix",required_argument,NULL,'p'}, + {"write",required_argument,NULL,'w'}, + {"targets",required_argument,NULL,'t'}, + {"targets-file",required_argument,NULL,'T'}, + {"regions",required_argument,NULL,'r'}, + {"regions-file",required_argument,NULL,'R'}, + {"output",required_argument,NULL,'o'}, + {"output-type",required_argument,NULL,'O'}, + {"threads",required_argument,NULL,9}, + {NULL,0,NULL,0} }; while ((c = getopt_long(argc, argv, "hc:r:R:p:n:w:t:T:Cf:o:O:i:e:",loptions,NULL)) >= 0) { switch (c) { @@ -554,6 +559,7 @@ int main_vcfisec(int argc, char *argv[]) else if ( sscanf(p,"%d",&args->isec_n)!=1 ) error("Could not parse --nfiles %s\n", optarg); } break; + case 9 : args->n_threads = strtol(optarg, 0, 0); break; case 'h': case '?': usage(); default: error("Unknown argument: %s\n", optarg); diff --git a/vcfmerge.c b/vcfmerge.c index e876cca69..0517bd56c 100644 --- a/vcfmerge.c +++ b/vcfmerge.c @@ -118,7 +118,7 @@ typedef struct htsFile *out_fh; bcf_hdr_t *out_hdr; char **argv; - int argc; + int argc, n_threads; } args_t; @@ -1898,6 +1898,7 @@ void merge_vcf(args_t *args) { args->out_fh = hts_open(args->output_fname, hts_bcf_wmode(args->output_type)); if ( args->out_fh == NULL ) error("Can't write to \"%s\": %s\n", args->output_fname, strerror(errno)); + if ( args->n_threads ) hts_set_threads(args->out_fh, args->n_threads); args->out_hdr = bcf_hdr_init("w"); if ( args->header_fname ) @@ -1965,6 +1966,7 @@ static void usage(void) fprintf(stderr, " -O, --output-type 'b' compressed BCF; 'u' uncompressed BCF; 'z' compressed VCF; 'v' uncompressed VCF [v]\n"); fprintf(stderr, " -r, --regions restrict to comma-separated list of regions\n"); fprintf(stderr, " -R, --regions-file restrict to regions listed in a file\n"); + fprintf(stderr, " --threads number of extra output compression threads [0]\n"); fprintf(stderr, "\n"); exit(1); } @@ -1977,24 +1979,26 @@ int main_vcfmerge(int argc, char *argv[]) args->argc = argc; args->argv = argv; args->output_fname = "-"; args->output_type = FT_VCF; + args->n_threads = 0; args->collapse = COLLAPSE_BOTH; int regions_is_file = 0; static struct option loptions[] = { - {"help",0,0,'h'}, - {"merge",1,0,'m'}, - {"file-list",1,0,'l'}, - {"apply-filters",1,0,'f'}, - {"use-header",1,0,1}, - {"print-header",0,0,2}, - {"force-samples",0,0,3}, - {"output",1,0,'o'}, - {"output-type",1,0,'O'}, - {"regions",1,0,'r'}, - {"regions-file",1,0,'R'}, - {"info-rules",1,0,'i'}, - {0,0,0,0} + {"help",no_argument,NULL,'h'}, + {"merge",required_argument,NULL,'m'}, + {"file-list",required_argument,NULL,'l'}, + {"apply-filters",required_argument,NULL,'f'}, + {"use-header",required_argument,NULL,1}, + {"print-header",no_argument,NULL,2}, + {"force-samples",no_argument,NULL,3}, + {"output",required_argument,NULL,'o'}, + {"output-type",required_argument,NULL,'O'}, + {"threads",required_argument,NULL,9}, + {"regions",required_argument,NULL,'r'}, + {"regions-file",required_argument,NULL,'R'}, + {"info-rules",required_argument,NULL,'i'}, + {NULL,0,NULL,0} }; while ((c = getopt_long(argc, argv, "hm:f:r:R:o:O:i:l:",loptions,NULL)) >= 0) { switch (c) { @@ -2027,6 +2031,7 @@ int main_vcfmerge(int argc, char *argv[]) case 1 : args->header_fname = optarg; break; case 2 : args->header_only = 1; break; case 3 : args->force_samples = 1; break; + case 9 : args->n_threads = strtol(optarg, 0, 0); break; case 'h': case '?': usage(); default: error("Unknown argument: %s\n", optarg); diff --git a/vcfnorm.c b/vcfnorm.c index 9bffddbb3..732eca903 100644 --- a/vcfnorm.c +++ b/vcfnorm.c @@ -74,7 +74,7 @@ typedef struct faidx_t *fai; struct { int tot, set, swap; } nref; char **argv, *output_fname, *ref_fname, *vcf_fname, *region, *targets; - int argc, rmdup, output_type, check_ref, strict_filter, do_indels; + int argc, rmdup, output_type, n_threads, check_ref, strict_filter, do_indels; int nchanged, nskipped, nsplit, ntotal, mrows_op, mrows_collapse, parsimonious; } args_t; @@ -1580,6 +1580,7 @@ static void normalize_vcf(args_t *args) { htsFile *out = hts_open(args->output_fname, hts_bcf_wmode(args->output_type)); if ( out == NULL ) error("Can't write to \"%s\": %s\n", args->output_fname, strerror(errno)); + if ( args->n_threads ) hts_set_threads(out, args->n_threads); bcf_hdr_append_version(args->hdr, args->argc, args->argv, "bcftools_norm"); bcf_hdr_write(out, args->hdr); @@ -1674,6 +1675,7 @@ static void usage(void) fprintf(stderr, " -t, --targets similar to -r but streams rather than index-jumps\n"); fprintf(stderr, " -T, --targets-file similar to -R but streams rather than index-jumps\n"); fprintf(stderr, " -w, --site-win buffer for sorting lines which changed position during realignment [1000]\n"); + fprintf(stderr, " --threads number of extra output compression threads [0]\n"); fprintf(stderr, "\n"); exit(1); } @@ -1686,6 +1688,7 @@ int main_vcfnorm(int argc, char *argv[]) args->files = bcf_sr_init(); args->output_fname = "-"; args->output_type = FT_VCF; + args->n_threads = 0; args->aln_win = 100; args->buf_win = 1000; args->mrows_collapse = COLLAPSE_BOTH; @@ -1695,22 +1698,23 @@ int main_vcfnorm(int argc, char *argv[]) static struct option loptions[] = { - {"help",0,0,'h'}, - {"fasta-ref",1,0,'f'}, - {"do-not-normalize",0,0,'N'}, - {"multiallelics",1,0,'m'}, - {"regions",1,0,'r'}, - {"regions-file",1,0,'R'}, - {"targets",1,0,'t'}, - {"targets-file",1,0,'T'}, - {"site-win",1,0,'w'}, - {"remove-duplicates",0,0,'D'}, - {"rm-dup",1,0,'d'}, - {"output",1,0,'o'}, - {"output-type",1,0,'O'}, - {"check-ref",1,0,'c'}, - {"strict-filter",0,0,'s'}, - {0,0,0,0} + {"help",no_argument,NULL,'h'}, + {"fasta-ref",required_argument,NULL,'f'}, + {"do-not-normalize",no_argument,NULL,'N'}, + {"multiallelics",required_argument,NULL,'m'}, + {"regions",required_argument,NULL,'r'}, + {"regions-file",required_argument,NULL,'R'}, + {"targets",required_argument,NULL,'t'}, + {"targets-file",required_argument,NULL,'T'}, + {"site-win",required_argument,NULL,'w'}, + {"remove-duplicates",no_argument,NULL,'D'}, + {"rm-dup",required_argument,NULL,'d'}, + {"output",required_argument,NULL,'o'}, + {"output-type",required_argument,NULL,'O'}, + {"threads",required_argument,NULL,9}, + {"check-ref",required_argument,NULL,'c'}, + {"strict-filter",no_argument,NULL,'s'}, + {NULL,0,NULL,0} }; char *tmp; while ((c = getopt_long(argc, argv, "hr:R:f:w:Dd:o:O:c:m:t:T:sN",loptions,NULL)) >= 0) { @@ -1766,6 +1770,7 @@ int main_vcfnorm(int argc, char *argv[]) args->buf_win = strtol(optarg,&tmp,10); if ( *tmp ) error("Could not parse argument: --site-win %s\n", optarg); break; + case 9 : args->n_threads = strtol(optarg, 0, 0); break; case 'h': case '?': usage(); default: error("Unknown argument: %s\n", optarg); diff --git a/vcfplugin.c b/vcfplugin.c index 1c2921c65..e2ca04a8e 100644 --- a/vcfplugin.c +++ b/vcfplugin.c @@ -129,7 +129,7 @@ typedef struct _args_t bcf_srs_t *files; bcf_hdr_t *hdr, *hdr_out; htsFile *out_fh; - int output_type; + int output_type, n_threads; filter_t *filter; char *filter_str; @@ -423,6 +423,7 @@ static void init_data(args_t *args) { args->out_fh = hts_open(args->output_fname,hts_bcf_wmode(args->output_type)); if ( args->out_fh == NULL ) error("Can't write to \"%s\": %s\n", args->output_fname, strerror(errno)); + if ( args->n_threads ) hts_set_threads(args->out_fh, args->n_threads); bcf_hdr_write(args->out_fh, args->hdr_out); } } @@ -461,6 +462,7 @@ static void usage(args_t *args) fprintf(stderr, "VCF output options:\n"); fprintf(stderr, " -o, --output write output to a file [standard output]\n"); fprintf(stderr, " -O, --output-type 'b' compressed BCF; 'u' uncompressed BCF; 'z' compressed VCF; 'v' uncompressed VCF [v]\n"); + fprintf(stderr, " --threads number of extra output compression threads [0]\n"); fprintf(stderr, "Plugin options:\n"); fprintf(stderr, " -h, --help list plugin's options\n"); fprintf(stderr, " -l, --list-plugins list available plugins. See BCFTOOLS_PLUGINS environment variable and man page for details\n"); @@ -477,6 +479,7 @@ int main_plugin(int argc, char *argv[]) args->argc = argc; args->argv = argv; args->output_fname = "-"; args->output_type = FT_VCF; + args->n_threads = 0; args->nplugin_paths = -1; int regions_is_file = 0, targets_is_file = 0, plist_only = 0, usage_only = 0, version_only = 0; @@ -486,19 +489,20 @@ int main_plugin(int argc, char *argv[]) static struct option loptions[] = { - {"version",0,0,'V'}, - {"verbose",0,0,'v'}, - {"help",0,0,'h'}, - {"list-plugins",0,0,'l'}, - {"output",1,0,'o'}, - {"output-type",1,0,'O'}, - {"include",1,0,'i'}, - {"exclude",1,0,'e'}, - {"regions",1,0,'r'}, - {"regions-file",1,0,'R'}, - {"targets",1,0,'t'}, - {"targets-file",1,0,'T'}, - {0,0,0,0} + {"version",no_argument,NULL,'V'}, + {"verbose",no_argument,NULL,'v'}, + {"help",no_argument,NULL,'h'}, + {"list-plugins",no_argument,NULL,'l'}, + {"output",required_argument,NULL,'o'}, + {"output-type",required_argument,NULL,'O'}, + {"threads",required_argument,NULL,9}, + {"include",required_argument,NULL,'i'}, + {"exclude",required_argument,NULL,'e'}, + {"regions",required_argument,NULL,'r'}, + {"regions-file",required_argument,NULL,'R'}, + {"targets",required_argument,NULL,'t'}, + {"targets-file",required_argument,NULL,'T'}, + {NULL,0,NULL,0} }; while ((c = getopt_long(argc, argv, "h?o:O:r:R:t:T:li:e:vV",loptions,NULL)) >= 0) { @@ -522,6 +526,7 @@ int main_plugin(int argc, char *argv[]) case 't': args->targets_list = optarg; break; case 'T': args->targets_list = optarg; targets_is_file = 1; break; case 'l': plist_only = 1; break; + case 9 : args->n_threads = strtol(optarg, 0, 0); break; case '?': case 'h': usage_only = 1; break; default: error("Unknown argument: %s\n", optarg); diff --git a/vcfview.c b/vcfview.c index 5727ab6d5..ed415950b 100644 --- a/vcfview.c +++ b/vcfview.c @@ -63,7 +63,7 @@ typedef struct _args_t bcf_srs_t *files; bcf_hdr_t *hdr, *hnull, *hsub; // original header, sites-only header, subset header char **argv, *format, *sample_names, *subset_fname, *targets_list, *regions_list; - int argc, clevel, output_type, print_header, update_info, header_only, n_samples, *imap, calc_ac; + int argc, clevel, n_threads, output_type, print_header, update_info, header_only, n_samples, *imap, calc_ac; int trim_alts, sites_only, known, novel, min_alleles, max_alleles, private_vars, uncalled, phased; int min_ac, min_ac_type, max_ac, max_ac_type, min_af_type, max_af_type, gt_type; int *ac, mac; @@ -218,6 +218,7 @@ static void init_data(args_t *args) else if (args->output_type & FT_GZ) strcat(modew,"z"); // compressed VCF args->out = hts_open(args->fn_out ? args->fn_out : "-", modew); if ( !args->out ) error("%s: %s\n", args->fn_out,strerror(errno)); + if ( args->n_threads ) hts_set_threads(args->out, args->n_threads); // headers: hdr=full header, hsub=subset header, hnull=sites only header if (args->sites_only){ @@ -490,6 +491,7 @@ static void usage(args_t *args) fprintf(stderr, " -R, --regions-file restrict to regions listed in a file\n"); fprintf(stderr, " -t, --targets [^] similar to -r but streams rather than index-jumps. Exclude regions with \"^\" prefix\n"); fprintf(stderr, " -T, --targets-file [^] similar to -R but streams rather than index-jumps. Exclude regions with \"^\" prefix\n"); + fprintf(stderr, " --threads number of extra output compression threads [0]\n"); fprintf(stderr, "\n"); fprintf(stderr, "Subset options:\n"); fprintf(stderr, " -a, --trim-alt-alleles trim alternate alleles not seen in the subset\n"); @@ -526,46 +528,48 @@ int main_vcfview(int argc, char *argv[]) args->print_header = 1; args->update_info = 1; args->output_type = FT_VCF; + args->n_threads = 0; int targets_is_file = 0, regions_is_file = 0; static struct option loptions[] = { - {"genotype",1,0,'g'}, - {"compression-level",1,0,'l'}, - {"header-only",0,0,'h'}, - {"no-header",0,0,'H'}, - {"exclude",1,0,'e'}, - {"include",1,0,'i'}, - {"trim-alt-alleles",0,0,'a'}, - {"no-update",0,0,'I'}, - {"drop-genotypes",0,0,'G'}, - {"private",0,0,'x'}, - {"exclude-private",0,0,'X'}, - {"uncalled",0,0,'u'}, - {"exclude-uncalled",0,0,'U'}, - {"apply-filters",1,0,'f'}, - {"known",0,0,'k'}, - {"novel",0,0,'n'}, - {"min-alleles",1,0,'m'}, - {"max-alleles",1,0,'M'}, - {"samples",1,0,'s'}, - {"samples-file",1,0,'S'}, - {"force-samples",0,0,1}, - {"output-type",1,0,'O'}, - {"output-file",1,0,'o'}, - {"types",1,0,'v'}, - {"exclude-types",1,0,'V'}, - {"targets",1,0,'t'}, - {"targets-file",1,0,'T'}, - {"regions",1,0,'r'}, - {"regions-file",1,0,'R'}, - {"min-ac",1,0,'c'}, - {"max-ac",1,0,'C'}, - {"min-af",1,0,'q'}, - {"max-af",1,0,'Q'}, - {"phased",0,0,'p'}, - {"exclude-phased",0,0,'P'}, - {0,0,0,0} + {"genotype",required_argument,NULL,'g'}, + {"compression-level",required_argument,NULL,'l'}, + {"threads",required_argument,NULL,9}, + {"header-only",no_argument,NULL,'h'}, + {"no-header",no_argument,NULL,'H'}, + {"exclude",required_argument,NULL,'e'}, + {"include",required_argument,NULL,'i'}, + {"trim-alt-alleles",no_argument,NULL,'a'}, + {"no-update",no_argument,NULL,'I'}, + {"drop-genotypes",no_argument,NULL,'G'}, + {"private",no_argument,NULL,'x'}, + {"exclude-private",no_argument,NULL,'X'}, + {"uncalled",no_argument,NULL,'u'}, + {"exclude-uncalled",no_argument,NULL,'U'}, + {"apply-filters",required_argument,NULL,'f'}, + {"known",no_argument,NULL,'k'}, + {"novel",no_argument,NULL,'n'}, + {"min-alleles",required_argument,NULL,'m'}, + {"max-alleles",required_argument,NULL,'M'}, + {"samples",required_argument,NULL,'s'}, + {"samples-file",required_argument,NULL,'S'}, + {"force-samples",no_argument,NULL,1}, + {"output-type",required_argument,NULL,'O'}, + {"output-file",required_argument,NULL,'o'}, + {"types",required_argument,NULL,'v'}, + {"exclude-types",required_argument,NULL,'V'}, + {"targets",required_argument,NULL,'t'}, + {"targets-file",required_argument,NULL,'T'}, + {"regions",required_argument,NULL,'r'}, + {"regions-file",required_argument,NULL,'R'}, + {"min-ac",required_argument,NULL,'c'}, + {"max-ac",required_argument,NULL,'C'}, + {"min-af",required_argument,NULL,'q'}, + {"max-af",required_argument,NULL,'Q'}, + {"phased",no_argument,NULL,'p'}, + {"exclude-phased",no_argument,NULL,'P'}, + {NULL,0,NULL,0} }; char *tmp; while ((c = getopt_long(argc, argv, "l:t:T:r:R:o:O:s:S:Gf:knv:V:m:M:auUhHc:C:Ii:e:xXpPq:Q:g:",loptions,NULL)) >= 0) @@ -673,6 +677,7 @@ int main_vcfview(int argc, char *argv[]) else error("The argument to -g not recognised. Expected one of hom/het/miss/^hom/^het/^miss, got \"%s\".\n", optarg); break; } + case 9 : args->n_threads = strtol(optarg, 0, 0); break; case '?': usage(args); default: error("Unknown argument: %s\n", optarg); } From 5c0d8117b42db02aa4f4638c2b00a5505ed80460 Mon Sep 17 00:00:00 2001 From: mcshane Date: Tue, 15 Dec 2015 14:04:48 +0000 Subject: [PATCH 128/211] update manpage docs after adding --threads options --- doc/bcftools.1 | 88 +++++++++++++++++++++++++++++++++++++++++------ doc/bcftools.html | 55 ++++++++++++++++++++++++----- 2 files changed, 124 insertions(+), 19 deletions(-) diff --git a/doc/bcftools.1 b/doc/bcftools.1 index ef6ae10ed..d2783d499 100644 --- a/doc/bcftools.1 +++ b/doc/bcftools.1 @@ -2,12 +2,12 @@ .\" Title: bcftools .\" Author: [see the "AUTHORS" section] .\" Generator: DocBook XSL Stylesheets v1.76.1 -.\" Date: 2015-11-16 09:01 GMT +.\" Date: 2015-12-15 14:02 GMT .\" Manual: \ \& .\" Source: \ \& .\" Language: English .\" -.TH "BCFTOOLS" "1" "2015\-11\-16 09:01 GMT" "\ \&" "\ \&" +.TH "BCFTOOLS" "1" "2015\-12\-15 14:02 GMT" "\ \&" "\ \&" .\" ----------------------------------------------------------------- .\" * Define some portability stuff .\" ----------------------------------------------------------------- @@ -41,7 +41,7 @@ Most commands accept VCF, bgzipped VCF and BCF with filetype detected automatica BCFtools is designed to work on a stream\&. It regards an input file "\-" as the standard input (stdin) and outputs to the standard output (stdout)\&. Several commands can thus be combined with Unix pipes\&. .SS "VERSION" .sp -This manual page was last updated \fB2015\-11\-16 09:01 GMT\fR and refers to bcftools git version \fB1\&.2\-182\-g6710191+\fR\&. +This manual page was last updated \fB2015\-12\-15 14:02 GMT\fR and refers to bcftools git version \fB1\&.2\-191\-g6737c5c+\fR\&. .SS "BCF1" .sp The BCF1 format output by versions of samtools <= 0\&.1\&.19 is \fBnot\fR compatible with this version of bcftools\&. To read BCF1 files one can use the view command from old versions of bcftools packaged with samtools versions <= 0\&.1\&.19 to convert to VCF, which can then be read by this version of bcftools\&. @@ -534,6 +534,16 @@ command, third column of the targets file must be comma\-separated list of allel .if n \{\ .RE .\} +.PP +\fB\-\-threads\fR \fIINT\fR +.RS 4 +Number of output compression threads to use in addition to main thread\&. Only used when +\fI\-\-output\-type\fR +is +\fIb\fR +or +\fIz\fR\&. Default: 0\&. +.RE .SS "bcftools annotate \fI[OPTIONS]\fR \fIFILE\fR" .sp This command allows to add or remove annotations\&. @@ -670,6 +680,12 @@ subset of samples to annotate\&. If the samples are named differently in the tar VCF, the name mapping can be given as "src_name dst_name\en", separated by whitespaces, each pair on a separate line\&. .RE .PP +\fB\-\-threads\fR \fIINT\fR +.RS 4 +see +\fBCommon Options\fR +.RE +.PP \fB\-x, \-\-remove\fR \fIlist\fR .RS 4 List of annotations to remove\&. Use "FILTER" to remove all filters or "FILTER/SomeFilter" to remove a specific filter\&. Similarly, "INFO" can be used to remove all INFO tags and "FORMAT" to remove all FORMAT tags except GT\&. To remove all INFO tags except "FOO" and "BAR", use "^INFO/FOO,INFO/BAR" (and similarly for FORMAT and FILTER)\&. "INFO" can be abbreviated to "INF" and "FORMAT" to "FMT"\&. @@ -845,6 +861,12 @@ This command replaces the former \fBbcftools view\fR caller\&. Some of the origi \fBFile format options:\fR .RS 4 .PP +\fB\-o, \-\-output\fR \fIFILE\fR +.RS 4 +see +\fBCommon Options\fR +.RE +.PP \fB\-O, \-\-output\-type\fR \fIb\fR|\fIu\fR|\fIz\fR|\fIv\fR .RS 4 see @@ -917,6 +939,12 @@ see see \fBCommon Options\fR .RE +.PP +\fB\-\-threads\fR \fIINT\fR +.RS 4 +see +\fBCommon Options\fR +.RE .RE .sp .it 1 an-trap @@ -955,12 +983,6 @@ output also sites missed by mpileup but present in output sites where REF allele is N .RE .PP -\fB\-o, \-\-output\fR \fIFILE\fR -.RS 4 -see -\fBCommon Options\fR -.RE -.PP \fB\-V, \-\-skip\-variants\fR \fIsnps\fR|\fIindels\fR .RS 4 skip indel/SNP sites @@ -1119,6 +1141,12 @@ see \fBCommon Options\fR\&. Requires \fB\-a, \-\-allow\-overlaps\fR\&. .RE +.PP +\fB\-\-threads\fR \fIINT\fR +.RS 4 +see +\fBCommon Options\fR +.RE .SS "bcftools consensus \fI[OPTIONS]\fR \fIFILE\fR" .sp Create consensus sequence by applying VCF variants to a reference fasta file\&. @@ -1256,6 +1284,12 @@ see see \fBCommon Options\fR .RE +.PP +\fB\-\-threads\fR \fIINT\fR +.RS 4 +see +\fBCommon Options\fR +.RE .RE .sp .it 1 an-trap @@ -2055,6 +2089,12 @@ see see \fBCommon Options\fR .RE +.PP +\fB\-\-threads\fR \fIINT\fR +.RS 4 +see +\fBCommon Options\fR +.RE .SS "bcftools norm [\fIOPTIONS\fR] \fIfile\&.vcf\&.gz\fR" .sp Left\-align and normalize indels, check if REF alleles match the reference, split multiallelic sites into multiple rows; recover multiallelics from multiple rows\&. Left\-alignment and normalization will only be applied if the \fB\-\-fasta\-ref\fR option is supplied\&. @@ -2155,6 +2195,12 @@ see \fBCommon Options\fR .RE .PP +\fB\-\-threads\fR \fIINT\fR +.RS 4 +see +\fBCommon Options\fR +.RE +.PP \fB\-w, \-\-site\-win\fR \fIINT\fR .RS 4 maximum distance between two records to consider when locally sorting variants which changed position during the realignment @@ -2229,6 +2275,12 @@ see see \fBCommon Options\fR .RE +.PP +\fB\-\-threads\fR \fIINT\fR +.RS 4 +see +\fBCommon Options\fR +.RE .RE .sp .it 1 an-trap @@ -3077,6 +3129,12 @@ see see \fBCommon Options\fR .RE +.PP +\fB\-\-threads\fR \fIINT\fR +.RS 4 +see +\fBCommon Options\fR +.RE .RE .sp .it 1 an-trap @@ -3405,7 +3463,7 @@ INFO tags, FORMAT tags, column names .nf INFO/DP or DP FORMAT/DV, FMT/DV, or DV -FILTER, QUAL, ID, REF, ALT[0] +FILTER, QUAL, ID, POS, REF, ALT[0] .fi .if n \{\ .RE @@ -3718,6 +3776,16 @@ MAF[0]<0\&.05 \&.\&. select rare variants at 5% cutoff .RE .\} .sp +.if n \{\ +.RS 4 +.\} +.nf +POS>=100 \&.\&. restrict your range query, e\&.g\&. 20:100\-200 to strictly sites with POS in that range\&. +.fi +.if n \{\ +.RE +.\} +.sp \fBShell expansion:\fR .sp Note that expressions must often be quoted because some characters have special meaning in the shell\&. An example of expression enclosed in single quotes which cause that the whole expression is passed to the program as intended: diff --git a/doc/bcftools.html b/doc/bcftools.html index f3a14405a..012d67017 100644 --- a/doc/bcftools.html +++ b/doc/bcftools.html @@ -1,6 +1,6 @@ -bcftools

    Name

    bcftools — utilities for variant calling and manipulating VCFs and BCFs.

    Synopsis

    bcftools [--version|--version-only] [--help] [COMMAND] [OPTIONS]

    DESCRIPTION

    BCFtools is a set of utilities that manipulate variant calls in the Variant +bcftools

    Name

    bcftools — utilities for variant calling and manipulating VCFs and BCFs.

    Synopsis

    bcftools [--version|--version-only] [--help] [COMMAND] [OPTIONS]

    DESCRIPTION

    BCFtools is a set of utilities that manipulate variant calls in the Variant Call Format (VCF) and its binary counterpart BCF. All commands work transparently with both VCFs and BCFs, both uncompressed and BGZF-compressed.

    Most commands accept VCF, bgzipped VCF and BCF with filetype detected automatically even when streaming from a pipe. Indexed VCF and BCF @@ -8,7 +8,7 @@ work in most, but not all situations. In general, whenever multiple VCFs are read simultaneously, they must be indexed and therefore also compressed.

    BCFtools is designed to work on a stream. It regards an input file "-" as the standard input (stdin) and outputs to the standard output (stdout). Several -commands can thus be combined with Unix pipes.

    VERSION

    This manual page was last updated 2015-11-16 09:01 GMT and refers to bcftools git version 1.2-182-g6710191+.

    BCF1

    The BCF1 format output by versions of samtools <= 0.1.19 is not +commands can thus be combined with Unix pipes.

    VERSION

    This manual page was last updated 2015-12-15 14:02 GMT and refers to bcftools git version 1.2-191-g6737c5c+.

    BCF1

    The BCF1 format output by versions of samtools <= 0.1.19 is not compatible with this version of bcftools. To read BCF1 files one can use the view command from old versions of bcftools packaged with samtools versions <= 0.1.19 to convert to VCF, which can then be read by @@ -212,7 +212,12 @@ be comma-separated list of alleles, starting with the reference allele. Note that the file must be compressed and index. Such a file can be easily created from a VCF using: -

        bcftools query -f'%CHROM\t%POS\t%REF,%ALT\n' file.vcf | bgzip -c > als.tsv.gz && tabix -s1 -b2 -e2 als.tsv.gz

    bcftools annotate [OPTIONS] FILE

    This command allows to add or remove annotations.

    +
        bcftools query -f'%CHROM\t%POS\t%REF,%ALT\n' file.vcf | bgzip -c > als.tsv.gz && tabix -s1 -b2 -e2 als.tsv.gz
    +--threads INT +
    + Number of output compression threads to use in addition to main thread. + Only used when --output-type is b or z. Default: 0. +

    bcftools annotate [OPTIONS] FILE

    This command allows to add or remove annotations.

    -a, --annotations file
    Bgzip-compressed and tabix-indexed file with annotations. The file @@ -316,6 +321,10 @@ given as "src_name dst_name\n", separated by whitespaces, each pair on a separate line.
    +--threads INT +
    + see Common Options +
    -x, --remove list
    List of annotations to remove. Use "FILTER" to remove all filters or @@ -441,6 +450,10 @@ functionality has been temporarily lost in the process of transition under htslib, but will be added back on popular demand. The original calling model can be invoked with the -c option.

    File format options:

    +-o, --output FILE +
    + see Common Options +
    -O, --output-type b|u|z|v
    see Common Options @@ -487,6 +500,10 @@ see Common Options
    -T, --targets-file FILE +
    + see Common Options +
    +--threads INT
    see Common Options

    Input/output options:

    @@ -515,10 +532,6 @@
    output sites where REF allele is N
    --o, --output FILE -
    - see Common Options -
    -V, --skip-variants snps|indels
    skip indel/SNP sites @@ -630,6 +643,10 @@ -R, --regions-file FILE
    see Common Options. Requires -a, --allow-overlaps. +
    +--threads INT +
    + see Common Options

    bcftools consensus [OPTIONS] FILE

    Create consensus sequence by applying VCF variants to a reference fasta file.

    -f, --fasta-ref FILE
    @@ -702,6 +719,10 @@ see Common Options
    -O, --output-type b|u|z|v +
    + see Common Options +
    +--threads INT
    see Common Options

    GEN/SAMPLE conversion:

    @@ -1157,6 +1178,10 @@ see Common Options
    -R, --regions-file file +
    + see Common Options +
    +--threads INT
    see Common Options

    bcftools norm [OPTIONS] file.vcf.gz

    Left-align and normalize indels, check if REF alleles match the reference, @@ -1232,6 +1257,10 @@

    see Common Options
    +--threads INT +
    + see Common Options +
    -w, --site-win INT
    maximum distance between two records to consider when locally @@ -1268,6 +1297,10 @@ see Common Options
    -O, --output-type b|u|z|v +
    + see Common Options +
    +--threads INT
    see Common Options

    Plugin options:

    @@ -1744,6 +1777,10 @@ see Common Options
    -T, --targets-file file +
    + see Common Options +
    +--threads INT
    see Common Options

    Subset options:

    @@ -1895,7 +1932,7 @@ INFO tags, FORMAT tags, column names

    INFO/DP or DP
     FORMAT/DV, FMT/DV, or DV
    -FILTER, QUAL, ID, REF, ALT[0]
  • +FILTER, QUAL, ID, POS, REF, ALT[0]

  • 1 (or 0) to test the presence (or absence) of a flag

    FlagA=1 && FlagB=0
  • "." to test missing values @@ -1925,7 +1962,7 @@ Variables and function names are case-insensitive, but not tag names. For example, "qual" can be used instead of "QUAL", "strlen()" instead of "STRLEN()" , but not "dp" instead of "DP". -

  • Examples:

    MIN(DV)>5
    MIN(DV/DP)>0.3
    MIN(DP)>10 & MIN(DV)>3
    FMT/DP>10  & FMT/GQ>10 .. both conditions must be satisfied within one sample
    FMT/DP>10 && FMT/GQ>10 .. the conditions can be satisfied in different samples
    QUAL>10 |  FMT/GQ>10   .. selects only GQ>10 samples
    QUAL>10 || FMT/GQ>10   .. selects all samples at QUAL>10 sites
    TYPE="snp" && QUAL>=10 && (DP4[2]+DP4[3] > 2)
    MIN(DP)>35 && AVG(GQ)>50
    ID=@file       .. selects lines with ID present in the file
    ID!=@~/file    .. skip lines with ID present in the ~/file
    MAF[0]<0.05    .. select rare variants at 5% cutoff

    Shell expansion:

    Note that expressions must often be quoted because some characters +

    Examples:

    MIN(DV)>5
    MIN(DV/DP)>0.3
    MIN(DP)>10 & MIN(DV)>3
    FMT/DP>10  & FMT/GQ>10 .. both conditions must be satisfied within one sample
    FMT/DP>10 && FMT/GQ>10 .. the conditions can be satisfied in different samples
    QUAL>10 |  FMT/GQ>10   .. selects only GQ>10 samples
    QUAL>10 || FMT/GQ>10   .. selects all samples at QUAL>10 sites
    TYPE="snp" && QUAL>=10 && (DP4[2]+DP4[3] > 2)
    MIN(DP)>35 && AVG(GQ)>50
    ID=@file       .. selects lines with ID present in the file
    ID!=@~/file    .. skip lines with ID present in the ~/file
    MAF[0]<0.05    .. select rare variants at 5% cutoff
    POS>=100   .. restrict your range query, e.g. 20:100-200 to strictly sites with POS in that range.

    Shell expansion:

    Note that expressions must often be quoted because some characters have special meaning in the shell. An example of expression enclosed in single quotes which cause that the whole expression is passed to the program as intended:

    bcftools view -i '%ID!="." & MAF[0]<0.01'

    Please refer to the documentation of your shell for details.

    SCRIPTS AND OPTIONS

    plot-vcfstats [OPTIONS] file.vchk […]

    Script for processing output of bcftools stats. It can merge From 9e33c258658d5d9d3144bcc1880bf08b314e7e3b Mon Sep 17 00:00:00 2001 From: mcshane Date: Mon, 11 Jan 2016 16:15:16 +0000 Subject: [PATCH 129/211] Happy New Year --- main.c | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/main.c b/main.c index f08b5c7e1..1892c1de5 100644 --- a/main.c +++ b/main.c @@ -1,6 +1,6 @@ /* main.c -- main bcftools command front-end. - Copyright (C) 2012-2015 Genome Research Ltd. + Copyright (C) 2012-2016 Genome Research Ltd. Author: Petr Danecek @@ -219,7 +219,7 @@ int main(int argc, char *argv[]) if (argc < 2) { usage(stderr); return 1; } if (strcmp(argv[1], "version") == 0 || strcmp(argv[1], "--version") == 0 || strcmp(argv[1], "-v") == 0) { - printf("bcftools %s\nUsing htslib %s\nCopyright (C) 2015 Genome Research Ltd.\n", bcftools_version(), hts_version()); + printf("bcftools %s\nUsing htslib %s\nCopyright (C) 2016 Genome Research Ltd.\n", bcftools_version(), hts_version()); #if USE_GPL printf("License GPLv3+: GNU GPL version 3 or later \n"); #else From 781e0498dbafe8a695275ca7f742b851a9060405 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Mon, 11 Jan 2016 13:00:42 +0000 Subject: [PATCH 130/211] annotate: print more informative error message, resolves #365 --- vcfannotate.c | 8 +++++--- 1 file changed, 5 insertions(+), 3 deletions(-) diff --git a/vcfannotate.c b/vcfannotate.c index 96a1649c5..2f8aa8247 100644 --- a/vcfannotate.c +++ b/vcfannotate.c @@ -1,6 +1,6 @@ /* vcfannotate.c -- Annotate and edit VCF/BCF files. - Copyright (C) 2013-2014 Genome Research Ltd. + Copyright (C) 2013-2016 Genome Research Ltd. Author: Petr Danecek @@ -1517,8 +1517,10 @@ static void buffer_annot_lines(args_t *args, bcf1_t *line, int start_pos, int en } if ( args->ref_idx != -1 ) { - assert( args->ref_idx < tmp->ncols ); - assert( args->alt_idx < tmp->ncols ); + if ( args->ref_idx >= tmp->ncols ) + error("Could not parse the line, expected %d+ columns, found %d:\n\t%s\n",args->ref_idx+1,tmp->ncols,args->tgts->line.s); + if ( args->alt_idx >= tmp->ncols ) + error("Could not parse the line, expected %d+ columns, found %d:\n\t%s\n",args->alt_idx+1,tmp->ncols,args->tgts->line.s); tmp->nals = 2; hts_expand(char*,tmp->nals,tmp->mals,tmp->als); tmp->als[0] = tmp->cols[args->ref_idx]; From bbe1543ec463fb750d643d9c8297a573f660361f Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Mon, 11 Jan 2016 14:54:32 +0000 Subject: [PATCH 131/211] call: improvements in "bcftools call --ploidy" when all samples haploid Previously samples of unknown sex were assigned the default ploidy of 2 and the only way to override the default was to create a sample file. This is not required any more, one can assign the default ploidy for all sexes using the "* * * * " rule. If all samples are haploid, run with "--ploidy 1". Resolves #366. --- ploidy.c | 30 ++++++++++++++++++++++-------- vcfcall.c | 33 ++++++++++++++++++++++++++++----- 2 files changed, 50 insertions(+), 13 deletions(-) diff --git a/ploidy.c b/ploidy.c index 160bc3eae..719e1753c 100644 --- a/ploidy.c +++ b/ploidy.c @@ -1,5 +1,5 @@ -/* - Copyright (C) 2014 Genome Research Ltd. +/* + Copyright (C) 2014-2016 Genome Research Ltd. Author: Petr Danecek @@ -98,7 +98,7 @@ int ploidy_parse(const char *line, char **chr_beg, char **chr_end, reg_t *reg, v ploidy->id2sex[ploidy->nsex-1] = strdup(ploidy->tmp_str.s); sp->sex = khash_str2int_inc(ploidy->sex2id, ploidy->id2sex[ploidy->nsex-1]); ploidy->sex2dflt = (int*) realloc(ploidy->sex2dflt,sizeof(int)*ploidy->nsex); - ploidy->sex2dflt[ploidy->nsex-1] = ploidy->dflt; + ploidy->sex2dflt[ploidy->nsex-1] = -1; } ss = se; @@ -106,8 +106,8 @@ int ploidy_parse(const char *line, char **chr_beg, char **chr_end, reg_t *reg, v if ( !*se ) error("Could not parse: %s\n", line); sp->ploidy = strtol(ss,&se,10); if ( ss==se ) error("Could not parse: %s\n", line); - if ( sp->ploidy < ploidy->min ) ploidy->min = sp->ploidy; - if ( sp->ploidy > ploidy->max ) ploidy->max = sp->ploidy; + if ( ploidy->min<0 || sp->ploidy < ploidy->min ) ploidy->min = sp->ploidy; + if ( ploidy->max<0 || sp->ploidy > ploidy->max ) ploidy->max = sp->ploidy; // Special case, chr="*" stands for a default value if ( default_ploidy_def ) @@ -119,19 +119,32 @@ int ploidy_parse(const char *line, char **chr_beg, char **chr_end, reg_t *reg, v return 0; } +static void _set_defaults(ploidy_t *ploidy, int dflt) +{ + int i; + if ( khash_str2int_get(ploidy->sex2id, "*", &i) == 0 ) dflt = ploidy->sex2dflt[i]; + for (i=0; insex; i++) + if ( ploidy->sex2dflt[i]==-1 ) ploidy->sex2dflt[i] = dflt; + + ploidy->dflt = dflt; + if ( ploidy->min<0 || dflt < ploidy->min ) ploidy->min = dflt; + if ( ploidy->max<0 || dflt > ploidy->max ) ploidy->max = dflt; +} + ploidy_t *ploidy_init(const char *fname, int dflt) { ploidy_t *pld = (ploidy_t*) calloc(1,sizeof(ploidy_t)); if ( !pld ) return NULL; - pld->dflt = pld->min = pld->max = dflt; + pld->min = pld->max = -1; pld->sex2id = khash_str2int_init(); pld->idx = regidx_init(fname,ploidy_parse,NULL,sizeof(sex_ploidy_t),pld); if ( !pld->idx ) { ploidy_destroy(pld); - pld = NULL; + return NULL; } + _set_defaults(pld,dflt); return pld; } @@ -140,7 +153,7 @@ ploidy_t *ploidy_init_string(const char *str, int dflt) ploidy_t *pld = (ploidy_t*) calloc(1,sizeof(ploidy_t)); if ( !pld ) return NULL; - pld->dflt = pld->min = pld->max = dflt; + pld->min = pld->max = -1; pld->sex2id = khash_str2int_init(); pld->idx = regidx_init(NULL,ploidy_parse,NULL,sizeof(sex_ploidy_t),pld); @@ -160,6 +173,7 @@ ploidy_t *ploidy_init_string(const char *str, int dflt) regidx_insert(pld->idx,NULL); free(tmp.s); + _set_defaults(pld,dflt); return pld; } diff --git a/vcfcall.c b/vcfcall.c index a28caee6a..0755e6742 100644 --- a/vcfcall.c +++ b/vcfcall.c @@ -1,6 +1,6 @@ /* vcfcall.c -- SNP/indel variant calling from VCF/BCF. - Copyright (C) 2013-2014 Genome Research Ltd. + Copyright (C) 2013-2016 Genome Research Ltd. Author: Petr Danecek @@ -175,6 +175,11 @@ static ploidy_predef_t ploidy_predefs[] = "* * * M 1\n" "* * * F 0\n" }, + { .alias = "1", + .about = "Treat all samples as haploid", + .ploidy = + "* * * * 1\n" + }, { .alias = NULL, .about = NULL, @@ -396,9 +401,21 @@ static void init_data(args_t *args) if ( 3*args->aux.nfams!=args->nsamples ) error("Expected only trios in %s, sorry!\n", args->samples_fname); fprintf(stderr,"Detected %d samples in %d trio families\n", args->nsamples,args->aux.nfams); } + } + if ( args->ploidy ) + { args->nsex = ploidy_nsex(args->ploidy); args->sex2ploidy = (int*) calloc(args->nsex,sizeof(int)); args->sex2ploidy_prev = (int*) calloc(args->nsex,sizeof(int)); + if ( !args->nsamples ) + { + args->nsamples = bcf_hdr_nsamples(args->aux.hdr); + args->sample2sex = (int*) malloc(sizeof(int)*args->nsamples); + for (i=0; insamples; i++) args->sample2sex[i] = 0; + } + } + if ( args->nsamples ) + { args->aux.ploidy = (uint8_t*) malloc(args->nsamples); for (i=0; insamples; i++) args->aux.ploidy[i] = 2; for (i=0; insex; i++) args->sex2ploidy_prev[i] = 2; @@ -418,9 +435,12 @@ static void init_data(args_t *args) else { args->aux.hdr = bcf_hdr_dup(bcf_sr_get_header(args->aux.srs,0)); - for (i=0; insamples; i++) - if ( bcf_hdr_id2int(args->aux.hdr,BCF_DT_SAMPLE,args->samples[i])<0 ) - error("No such sample: %s\n", args->samples[i]); + if ( args->samples ) + { + for (i=0; insamples; i++) + if ( bcf_hdr_id2int(args->aux.hdr,BCF_DT_SAMPLE,args->samples[i])<0 ) + error("No such sample: %s\n", args->samples[i]); + } } args->out_fh = hts_open(args->output_fname, hts_bcf_wmode(args->output_type)); @@ -451,7 +471,10 @@ static void destroy_data(args_t *args) else if ( args->flag & CF_MCALL ) mcall_destroy(&args->aux); else if ( args->flag & CF_QCALL ) qcall_destroy(&args->aux); int i; - for (i=0; insamples; i++) free(args->samples[i]); + if ( args->samples ) + { + for (i=0; insamples; i++) free(args->samples[i]); + } if ( args->aux.fams ) { for (i=0; iaux.nfams; i++) free(args->aux.fams[i].name); From cba6e327b6dceec04df400788fc95dce84519b23 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Mon, 11 Jan 2016 15:09:51 +0000 Subject: [PATCH 132/211] index: do not segfault when indexing non-existent files. Fixes #367 --- vcfindex.c | 3 ++- 1 file changed, 2 insertions(+), 1 deletion(-) diff --git a/vcfindex.c b/vcfindex.c index e40fab52c..d1e9179e4 100644 --- a/vcfindex.c +++ b/vcfindex.c @@ -1,7 +1,7 @@ /* vcfindex.c -- Index bgzip compressed VCF/BCF files for random access. - Copyright (C) 2014 Genome Research Ltd. + Copyright (C) 2014-2016 Genome Research Ltd. Author: Shane McCarthy @@ -177,6 +177,7 @@ int main_vcfindex(int argc, char *argv[]) if (stats) return vcf_index_stats(fname, stats); htsFile *fp = hts_open(fname,"r"); + if ( !fp ) error("Failed to read %s\n", fname); htsFormat type = *hts_get_format(fp); hts_close(fp); From 3138e74c6958704be96807cb4f3f617db05237a3 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Mon, 11 Jan 2016 15:48:57 +0000 Subject: [PATCH 133/211] norm: remove forced flush, forgotten when fixing #336. Fixes #368 --- vcfnorm.c | 3 +-- 1 file changed, 1 insertion(+), 2 deletions(-) diff --git a/vcfnorm.c b/vcfnorm.c index 732eca903..a59854ae0 100644 --- a/vcfnorm.c +++ b/vcfnorm.c @@ -1,6 +1,6 @@ /* vcfnorm.c -- Left-align and normalize indels. - Copyright (C) 2013-2014 Genome Research Ltd. + Copyright (C) 2013-2016 Genome Research Ltd. Author: Petr Danecek @@ -1641,7 +1641,6 @@ static void normalize_vcf(args_t *args) if ( args->lines[ilast]->pos - args->lines[i]->pos < args->buf_win ) break; j++; } - if ( args->rbuf.n==args->rbuf.m ) j = 1; if ( j>0 ) flush_buffer(args, out, j); } flush_buffer(args, out, args->rbuf.n); From 611297e88188c776021af612776364ee5e62b14b Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Tue, 12 Jan 2016 10:36:54 +0000 Subject: [PATCH 134/211] reheader: support spaces in sample names - spaces can be escaped with a backslash - document this behaviour - add tests Resolves the issue brought up under #93. --- doc/bcftools.txt | 7 +++--- khash_str2str.h | 19 ++++++++++++++- reheader.c | 39 ++++++++++++++++++++++-------- test/reheader.3.out | 55 ++++++++++++++++++++++++++++++++++++++++++ test/reheader.4.out | 55 ++++++++++++++++++++++++++++++++++++++++++ test/reheader.samples3 | 2 ++ test/reheader.samples4 | 1 + test/test.pl | 2 ++ 8 files changed, 166 insertions(+), 14 deletions(-) create mode 100644 test/reheader.3.out create mode 100644 test/reheader.4.out create mode 100644 test/reheader.samples3 create mode 100644 test/reheader.samples4 diff --git a/doc/bcftools.txt b/doc/bcftools.txt index e26692dbd..4f32b7e39 100644 --- a/doc/bcftools.txt +++ b/doc/bcftools.txt @@ -1594,9 +1594,10 @@ Modify header of VCF/BCF files, change sample names. *-s, --samples* 'FILE':: new sample names, one name per line, in the same order as they appear in the VCF file. Alternatively, only samples which need to be renamed - can be listed as "old_name new_name\n" pairs separated by - whitespaces, each on separate line. - + can be listed as "old_name new_name\n" pairs separated by whitespaces, + each on a separate line. If a sample name contains spaces, the + spaces can be escaped using the backslash character, for example + "Not\ a\ good\ sample\ name". [[roh]] diff --git a/khash_str2str.h b/khash_str2str.h index ecf4e0b46..4a5bd1278 100644 --- a/khash_str2str.h +++ b/khash_str2str.h @@ -1,6 +1,6 @@ /* khash_str2str.h -- C-string to C-string hash table. - Copyright (C) 2014 Genome Research Ltd. + Copyright (C) 2014,2016 Genome Research Ltd. Author: Petr Danecek @@ -60,6 +60,23 @@ static inline void khash_str2str_destroy_free(void *_hash) kh_destroy(str2str, hash); } +/* + * Destroys the hash structure, the keys and the values + */ +static inline void khash_str2str_destroy_free_all(void *_hash) +{ + khash_t(str2str) *hash = (khash_t(str2str)*)_hash; + khint_t k; + if (hash == 0) return; + for (k = 0; k < kh_end(hash); ++k) + if (kh_exist(hash, k)) + { + free((char*)kh_key(hash, k)); + free((char*)kh_val(hash, k)); + } + kh_destroy(str2str, hash); +} + /* * Returns value if key exists or NULL if not */ diff --git a/reheader.c b/reheader.c index f32518871..132b968c5 100644 --- a/reheader.c +++ b/reheader.c @@ -1,6 +1,6 @@ /* reheader.c -- reheader subcommand. - Copyright (C) 2014 Genome Research Ltd. + Copyright (C) 2014,2016 Genome Research Ltd. Author: Petr Danecek @@ -69,22 +69,41 @@ static void read_header_file(char *fname, kstring_t *hdr) static int set_sample_pairs(char **samples, int nsamples, kstring_t *hdr, int idx) { int i, j, n; + kstring_t key = {0,0,0}; + kstring_t val = {0,0,0}; // Are these samples "old-name new-name" pairs? void *hash = khash_str2str_init(); for (i=0; is+idx+j); kputs(ori ? ori : hdr->s+idx+j, &tmp); - if ( hash ) khash_str2str_destroy(hash); + khash_str2str_destroy_free_all(hash); hdr->l = idx; kputs(tmp.s, hdr); diff --git a/test/reheader.3.out b/test/reheader.3.out new file mode 100644 index 000000000..c5207468e --- /dev/null +++ b/test/reheader.3.out @@ -0,0 +1,55 @@ +##fileformat=VCFv4.1 +##FILTER= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##INFO= +##INFO= +##FORMAT= +##FORMAT= +##FORMAT= +##contig= +##contig= +##contig= +##contig= +##contig= +##contig= +##FILTER= +#CHROM POS ID REF ALT QUAL FILTER INFO FORMAT A AA BB B +2 101 . ATTTTTTTTTTTTT ATTTTTTTTTTTTTTT 999 PASS INDEL;AN=4;AC=4 GT:DP 1/1:1 1/1:1 +2 114 . TC TTCC,TTC 999 PASS INDEL;AN=4;AC=2,2 GT:DP 1/2:1 1/2:1 +2 115 . C T 999 PASS INDEL;AN=4;AC=4 GT:DP 1/1:1 1/1:1 +20 3 . G CT 999 PASS INDEL;AN=4;AC=2 GT 0/1 0/1 +20 3 . GATG GACT 999 PASS INDEL;AN=4;AC=2 GT 1/0 1/0 +20 5 . TGGG TAC,TG,TGGGG,AC . PASS INDEL;AN=4;AC=2,2,0,0 GT:PL:DP 1/2:1,2,3,4,5,6,7,8,9,10,11,12,13,14,15:1 1/2:1,2,3,4,5,6,7,8,9,10,11,12,13,14,15:1 +20 59 . AG . 999 PASS AN=4 GT:PL:DP 0/0:0:4 0/0:0:4 +20 80 . CACAG CACAT 999 PASS AN=4;AC=2 GT:PL:DP 0/1:255,0,255:13 0/1:255,0,255:13 +20 81 . A C 999 PASS AN=4;AC=2 GT:PL:DP 0/1:255,0,255:13 0/1:255,0,255:13 +20 95 . TCACCG ACACCG 999 PASS AN=4;AC=2 GT:PL:DP 0/1:255,0,255:13 0/1:255,0,255:13 +20 95 . TCACCG AAAAAA 999 Test AN=4;AC=2 GT:PL:DP 0/1:255,0,255:13 0/1:255,0,255:13 +20 273 . CAAAAAAAAAAAAAAAAAAAAA CAAAAAAAAAAAAAAAAAAAAAAA,CAAAAAAAAAAAAAAAAAAAAAAAA 999 PASS INDEL;AN=4;AC=2,2 GT:PL:DP 1/2:0,3,5,3,5,5:1 1/2:0,3,5,3,5,5:1 +20 274 . AAAAAAAAA AAAAAAAAAAAAAAAAAAA 999 PASS INDEL;AN=0;AC=0 GT:PL:DP ./.:0,0,0:0 ./.:0,0,0:0 +20 278 . AAAAAAAAAAAAAAAAA AAAAAAAAAAAAAAAAAAA 999 PASS INDEL;AN=0;AC=0 GT:PL:DP ./.:0,0,0:0 ./.:0,0,0:0 +3 10 . GTGGAC GTGGACACAC,GTGGACAC,GTGGACACACAC,GTGG,GTGGACACACACAC,ATGGACACACAC 999 PASS INDEL;AN=0 GT:DP ./.:0 ./.:0 +3 15 . CACA CAC 999 PASS INDEL;AN=0 GT:DP ./.:0 ./.:0 +4 21 . ATTTTTTTTTTTTTTTC ATTTTTTTTTTTTTTC,ATTTTTTTTTTTTTTTT,ATTTTTTTTTTTTTTTTC 999 PASS INDEL;AN=0 GT:DP ./.:0 ./.:0 +5 22 . A AGA 999 PASS INDEL;AN=0 GT:DP ./.:0 ./.:0 diff --git a/test/reheader.4.out b/test/reheader.4.out new file mode 100644 index 000000000..8b7c1ed2e --- /dev/null +++ b/test/reheader.4.out @@ -0,0 +1,55 @@ +##fileformat=VCFv4.1 +##FILTER= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##INFO= +##INFO= +##FORMAT= +##FORMAT= +##FORMAT= +##contig= +##contig= +##contig= +##contig= +##contig= +##contig= +##FILTER= +#CHROM POS ID REF ALT QUAL FILTER INFO FORMAT XY00001 BB +2 101 . ATTTTTTTTTTTTT ATTTTTTTTTTTTTTT 999 PASS INDEL;AN=4;AC=4 GT:DP 1/1:1 1/1:1 +2 114 . TC TTCC,TTC 999 PASS INDEL;AN=4;AC=2,2 GT:DP 1/2:1 1/2:1 +2 115 . C T 999 PASS INDEL;AN=4;AC=4 GT:DP 1/1:1 1/1:1 +20 3 . G CT 999 PASS INDEL;AN=4;AC=2 GT 0/1 0/1 +20 3 . GATG GACT 999 PASS INDEL;AN=4;AC=2 GT 1/0 1/0 +20 5 . TGGG TAC,TG,TGGGG,AC . PASS INDEL;AN=4;AC=2,2,0,0 GT:PL:DP 1/2:1,2,3,4,5,6,7,8,9,10,11,12,13,14,15:1 1/2:1,2,3,4,5,6,7,8,9,10,11,12,13,14,15:1 +20 59 . AG . 999 PASS AN=4 GT:PL:DP 0/0:0:4 0/0:0:4 +20 80 . CACAG CACAT 999 PASS AN=4;AC=2 GT:PL:DP 0/1:255,0,255:13 0/1:255,0,255:13 +20 81 . A C 999 PASS AN=4;AC=2 GT:PL:DP 0/1:255,0,255:13 0/1:255,0,255:13 +20 95 . TCACCG ACACCG 999 PASS AN=4;AC=2 GT:PL:DP 0/1:255,0,255:13 0/1:255,0,255:13 +20 95 . TCACCG AAAAAA 999 Test AN=4;AC=2 GT:PL:DP 0/1:255,0,255:13 0/1:255,0,255:13 +20 273 . CAAAAAAAAAAAAAAAAAAAAA CAAAAAAAAAAAAAAAAAAAAAAA,CAAAAAAAAAAAAAAAAAAAAAAAA 999 PASS INDEL;AN=4;AC=2,2 GT:PL:DP 1/2:0,3,5,3,5,5:1 1/2:0,3,5,3,5,5:1 +20 274 . AAAAAAAAA AAAAAAAAAAAAAAAAAAA 999 PASS INDEL;AN=0;AC=0 GT:PL:DP ./.:0,0,0:0 ./.:0,0,0:0 +20 278 . AAAAAAAAAAAAAAAAA AAAAAAAAAAAAAAAAAAA 999 PASS INDEL;AN=0;AC=0 GT:PL:DP ./.:0,0,0:0 ./.:0,0,0:0 +3 10 . GTGGAC GTGGACACAC,GTGGACAC,GTGGACACACAC,GTGG,GTGGACACACACAC,ATGGACACACAC 999 PASS INDEL;AN=0 GT:DP ./.:0 ./.:0 +3 15 . CACA CAC 999 PASS INDEL;AN=0 GT:DP ./.:0 ./.:0 +4 21 . ATTTTTTTTTTTTTTTC ATTTTTTTTTTTTTTC,ATTTTTTTTTTTTTTTT,ATTTTTTTTTTTTTTTTC 999 PASS INDEL;AN=0 GT:DP ./.:0 ./.:0 +5 22 . A AGA 999 PASS INDEL;AN=0 GT:DP ./.:0 ./.:0 diff --git a/test/reheader.samples3 b/test/reheader.samples3 new file mode 100644 index 000000000..b8f870021 --- /dev/null +++ b/test/reheader.samples3 @@ -0,0 +1,2 @@ +XY00002 BB\ B +XY00001 A\ AA diff --git a/test/reheader.samples4 b/test/reheader.samples4 new file mode 100644 index 000000000..dcda975da --- /dev/null +++ b/test/reheader.samples4 @@ -0,0 +1 @@ +XY00002 BB diff --git a/test/test.pl b/test/test.pl index 899ea169a..5154a0d1e 100755 --- a/test/test.pl +++ b/test/test.pl @@ -197,6 +197,8 @@ test_vcf_reheader($opts,in=>'reheader',out=>'reheader.1.out',header=>'reheader.hdr'); test_vcf_reheader($opts,in=>'reheader',out=>'reheader.2.out',samples=>'reheader.samples'); test_vcf_reheader($opts,in=>'reheader',out=>'reheader.2.out',samples=>'reheader.samples2'); +test_vcf_reheader($opts,in=>'reheader',out=>'reheader.3.out',samples=>'reheader.samples3'); +test_vcf_reheader($opts,in=>'reheader',out=>'reheader.4.out',samples=>'reheader.samples4'); test_rename_chrs($opts,in=>'annotate'); test_vcf_convert($opts,in=>'convert',out=>'convert.gs.gt.gen',args=>'-g -,.'); test_vcf_convert($opts,in=>'convert',out=>'convert.gs.gt.samples',args=>'-g .,-'); From c0b49dcef7d09c387c2f123f3787a2914de2a8a2 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Tue, 6 Oct 2015 09:38:54 +0100 Subject: [PATCH 135/211] annotate: add to FORMAT fields from a tab-delimited file --- test/annotate10.hdr | 3 + test/annotate10.out | 18 +++++ test/annotate10.vcf | 17 ++++ test/annots10.tab | 4 + test/test.pl | 1 + vcfannotate.c | 192 +++++++++++++++++++++++++++++++++++++------- 6 files changed, 208 insertions(+), 27 deletions(-) create mode 100644 test/annotate10.hdr create mode 100644 test/annotate10.out create mode 100644 test/annotate10.vcf create mode 100644 test/annots10.tab diff --git a/test/annotate10.hdr b/test/annotate10.hdr new file mode 100644 index 000000000..2162e9dd5 --- /dev/null +++ b/test/annotate10.hdr @@ -0,0 +1,3 @@ +##FORMAT= +##FORMAT= +##FORMAT= diff --git a/test/annotate10.out b/test/annotate10.out new file mode 100644 index 000000000..c7f393b4d --- /dev/null +++ b/test/annotate10.out @@ -0,0 +1,18 @@ +##fileformat=VCFv4.1 +##FILTER= +##FILTER= +##contig= +##reference=file:///lustre/scratch105/projects/g1k/ref/main_project/human_g1k_v37.fasta +##INFO= +##INFO= +##INFO= +##INFO= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +#CHROM POS ID REF ALT QUAL FILTER INFO FORMAT B A +1 3000001 . C T . . . GT:FINT:FFLT:FSTR .:.:.:. .:.:.:. +1 3000002 id C T 99 q99 FLAG;IINT=88,99;IFLT=8.8,9.9;ISTR=888,999 GT:FINT:FFLT:FSTR 1|1:88,99:8.8,9.9:888,999 0|1:77:7.7:77 +1 3000003 id C T 99 q99 FLAG;IINT=88,99;IFLT=8.8,9.9;ISTR=888,999 GT:FINT:FFLT:FSTR 1|1:88,99:8.8,9.9:888,999 0|1:77:7.7:77 +1 3000004 id C T 99 q99 FLAG;IINT=88,99;IFLT=8.8,9.9;ISTR=888,999 GT:FINT:FFLT:FSTR 1|1:88,99:8.8,9.9:888,999 0|1:77:7.7:77 diff --git a/test/annotate10.vcf b/test/annotate10.vcf new file mode 100644 index 000000000..0557da6b1 --- /dev/null +++ b/test/annotate10.vcf @@ -0,0 +1,17 @@ +##fileformat=VCFv4.1 +##FILTER= +##FILTER= +##contig= +##reference=file:///lustre/scratch105/projects/g1k/ref/main_project/human_g1k_v37.fasta +##INFO= +##INFO= +##INFO= +##INFO= +##FORMAT= +##bcftools_annotateVersion=1.2-207-g2038312-dirty+htslib-1.2.1-158-g6876a07-dirty +##bcftools_annotateCommand=annotate -x FMT test/annots2.vcf +#CHROM POS ID REF ALT QUAL FILTER INFO FORMAT B A +1 3000001 . C T . . . GT . . +1 3000002 id C T 99 q99 FLAG;IINT=88,99;IFLT=8.8,9.9;ISTR=888,999 GT 1|1 0|1 +1 3000003 id C T 99 q99 FLAG;IINT=88,99;IFLT=8.8,9.9;ISTR=888,999 GT 1|1 0|1 +1 3000004 id C T 99 q99 FLAG;IINT=88,99;IFLT=8.8,9.9;ISTR=888,999 GT 1|1 0|1 diff --git a/test/annots10.tab b/test/annots10.tab new file mode 100644 index 000000000..5128f3c56 --- /dev/null +++ b/test/annots10.tab @@ -0,0 +1,4 @@ +1 3000001 . . . . . . +1 3000002 88,99 77 8.8,9.9 7.7 888,999 77 +1 3000003 88,99 77 8.8,9.9 7.7 888,999 77 +1 3000004 88,99 77 8.8,9.9 7.7 888,999 77 diff --git a/test/test.pl b/test/test.pl index 5154a0d1e..48ec9db08 100755 --- a/test/test.pl +++ b/test/test.pl @@ -175,6 +175,7 @@ test_vcf_annotate($opts,in=>'annotate3',out=>'annotate7.out',args=>'-x FORMAT'); test_vcf_annotate($opts,in=>'annotate4',vcf=>'annots4',out=>'annotate8.out',args=>'-c +INFO'); test_vcf_annotate($opts,in=>'annotate4',tab=>'annots4',out=>'annotate8.out',args=>'-c CHROM,POS,REF,ALT,+FA,+FR,+IA,+IR,+SA,+SR'); +test_vcf_annotate($opts,in=>'annotate10',tab=>'annots10',out=>'annotate10.out',args=>'-c CHROM,POS,FMT/FINT,FMT/FFLT,FMT/FSTR'); test_vcf_plugin($opts,in=>'plugin1',out=>'missing2ref.out',cmd=>'+missing2ref'); test_vcf_plugin($opts,in=>'plugin1',out=>'missing2ref.out',cmd=>'+setGT',args=>'-- -t . -n 0'); test_vcf_annotate($opts,in=>'annotate9',tab=>'annots9',out=>'annotate9.out',args=>'-c CHROM,POS,REF,ALT,+ID'); diff --git a/vcfannotate.c b/vcfannotate.c index 2f8aa8247..fe09f9f7b 100644 --- a/vcfannotate.c +++ b/vcfannotate.c @@ -809,6 +809,135 @@ static int vcf_setter_format_gt(args_t *args, bcf1_t *line, annot_col_t *col, vo return bcf_update_genotypes(args->hdr_out,line,args->tmpi3,nsrc*bcf_hdr_nsamples(args->hdr_out)); } } +static int count_vals(annot_line_t *tab, int icol_beg, int icol_end) +{ + int i, nmax = 0; + for (i=icol_beg; icols[i], *end = str; + if ( str[0]=='.' && !str[1] ) + { + // missing value + if ( !nmax ) nmax = 1; + continue; + } + int n = 1; + while ( *end ) + { + if ( *end==',' ) n++; + end++; + } + if ( nmaxhdr_out); + assert( col->icol+nsmpl <= tab->ncols ); + int nvals = count_vals(tab,col->icol,col->icol+nsmpl); + assert( nvals>0 ); + hts_expand(int32_t,nvals*nsmpl,args->mtmpi,args->tmpi); + + int icol = col->icol, ismpl; + for (ismpl=0; ismpltmpi + ismpl*nvals; + int ival = 0; + + char *str = tab->cols[icol]; + while ( *str ) + { + if ( str[0]=='.' && (!str[1] || str[1]==',') ) // missing value + { + ptr[ival++] = bcf_int32_missing; + str += str[1] ? 2 : 1; + continue; + } + + char *end = str; + ptr[ival] = strtol(str, &end, 10); + if ( end==str ) + error("Could not parse %s at %s:%d .. [%s]\n", col->hdr_key,bcf_seqname(args->hdr,line),line->pos+1,tab->cols[col->icol]); + + ival++; + str = *end ? end+1 : end; + } + while ( ivalhdr_out,line,col->hdr_key,args->tmpi,nsmpl*nvals); +} +static int setter_format_real(args_t *args, bcf1_t *line, annot_col_t *col, void *data) +{ + annot_line_t *tab = (annot_line_t*) data; + int nsmpl = bcf_hdr_nsamples(args->hdr_out); + assert( col->icol+nsmpl <= tab->ncols ); + int nvals = count_vals(tab,col->icol,col->icol+nsmpl); + assert( nvals>0 ); + hts_expand(float,nvals*nsmpl,args->mtmpf,args->tmpf); + + int icol = col->icol, ismpl; + for (ismpl=0; ismpltmpf + ismpl*nvals; + int ival = 0; + + char *str = tab->cols[icol]; + while ( *str ) + { + if ( str[0]=='.' && (!str[1] || str[1]==',') ) // missing value + { + bcf_float_set_missing(ptr[ival]); + ival++; + str += str[1] ? 2 : 1; + continue; + } + + char *end = str; + ptr[ival] = strtod(str, &end); + if ( end==str ) + error("Could not parse %s at %s:%d .. [%s]\n", col->hdr_key,bcf_seqname(args->hdr,line),line->pos+1,tab->cols[col->icol]); + + ival++; + str = *end ? end+1 : end; + } + while ( ivalhdr_out,line,col->hdr_key,args->tmpf,nsmpl*nvals); +} +static int setter_format_str(args_t *args, bcf1_t *line, annot_col_t *col, void *data) +{ + annot_line_t *tab = (annot_line_t*) data; + int nsmpl = bcf_hdr_nsamples(args->hdr_out); + assert( col->icol+nsmpl <= tab->ncols ); + + int i, max_len = 0; + for (i=col->icol; iicol+nsmpl; i++) + { + int len = strlen(tab->cols[i]); + if ( max_len < len ) max_len = len; + } + hts_expand(char,max_len*nsmpl,args->mtmps,args->tmps); + + int icol = col->icol, ismpl; + for (ismpl=0; ismpltmps + ismpl*max_len; + char *str = tab->cols[icol]; + i = 0; + while ( str[i] ) + { + ptr[i] = str[i]; + i++; + } + while ( ihdr_out,line,col->hdr_key,args->tmps,nsmpl*max_len); +} static int vcf_setter_format_int(args_t *args, bcf1_t *line, annot_col_t *col, void *data) { bcf1_t *rec = (bcf1_t*) data; @@ -1127,7 +1256,7 @@ static void init_columns(args_t *args) kstring_t str = {0,0,0}, tmp = {0,0,0}; char *ss = args->columns, *se = ss; args->ncols = 0; - int i = -1, has_fmt_str = 0, force_samples = -1; + int icol = -1, has_fmt_str = 0, force_samples = -1; while ( *ss ) { if ( *se && *se!=',' ) { se++; continue; } @@ -1135,22 +1264,22 @@ static void init_columns(args_t *args) if ( *ss=='+' ) { replace = REPLACE_MISSING; ss++; } else if ( *ss=='-' ) { replace = REPLACE_EXISTING; ss++; } else if ( *ss=='=' ) { replace = SET_OR_APPEND; ss++; } - i++; + icol++; str.l = 0; kputsn(ss, se-ss, &str); if ( !str.s[0] || !strcasecmp("-",str.s) ) ; - else if ( !strcasecmp("CHROM",str.s) ) args->chr_idx = i; - else if ( !strcasecmp("POS",str.s) ) args->from_idx = i; - else if ( !strcasecmp("FROM",str.s) ) args->from_idx = i; - else if ( !strcasecmp("TO",str.s) ) args->to_idx = i; - else if ( !strcasecmp("REF",str.s) ) args->ref_idx = i; - else if ( !strcasecmp("ALT",str.s) ) args->alt_idx = i; + else if ( !strcasecmp("CHROM",str.s) ) args->chr_idx = icol; + else if ( !strcasecmp("POS",str.s) ) args->from_idx = icol; + else if ( !strcasecmp("FROM",str.s) ) args->from_idx = icol; + else if ( !strcasecmp("TO",str.s) ) args->to_idx = icol; + else if ( !strcasecmp("REF",str.s) ) args->ref_idx = icol; + else if ( !strcasecmp("ALT",str.s) ) args->alt_idx = icol; else if ( !strcasecmp("ID",str.s) ) { if ( replace==REPLACE_EXISTING ) error("Apologies, the -ID feature has not been implemented yet.\n"); args->ncols++; args->cols = (annot_col_t*) realloc(args->cols,sizeof(annot_col_t)*args->ncols); annot_col_t *col = &args->cols[args->ncols-1]; - col->icol = i; + col->icol = icol; col->replace = replace; col->setter = args->tgts_is_vcf ? vcf_setter_id : setter_id; col->hdr_key = strdup(str.s); @@ -1160,7 +1289,7 @@ static void init_columns(args_t *args) if ( replace==REPLACE_EXISTING ) error("Apologies, the -FILTER feature has not been implemented yet.\n"); args->ncols++; args->cols = (annot_col_t*) realloc(args->cols,sizeof(annot_col_t)*args->ncols); annot_col_t *col = &args->cols[args->ncols-1]; - col->icol = i; + col->icol = icol; col->replace = replace; col->setter = args->tgts_is_vcf ? vcf_setter_filter : setter_filter; col->hdr_key = strdup(str.s); @@ -1187,7 +1316,7 @@ static void init_columns(args_t *args) if ( replace==SET_OR_APPEND ) error("Apologies, the =QUAL feature has not been implemented yet.\n"); args->ncols++; args->cols = (annot_col_t*) realloc(args->cols,sizeof(annot_col_t)*args->ncols); annot_col_t *col = &args->cols[args->ncols-1]; - col->icol = i; + col->icol = icol; col->replace = replace; col->setter = args->tgts_is_vcf ? vcf_setter_qual : setter_qual; col->hdr_key = strdup(str.s); @@ -1262,30 +1391,38 @@ static void init_columns(args_t *args) } else if ( !strncasecmp("FORMAT/",str.s, 7) || !strncasecmp("FMT/",str.s,4) ) { - if ( !args->tgts_is_vcf ) - error("Error: FORMAT fields can be carried over from a VCF file only.\n"); - char *key = str.s + (!strncasecmp("FMT/",str.s,4) ? 4 : 7); if ( force_samples<0 ) force_samples = replace; - if ( force_samples>=0 && replace!=REPLACE_ALL ) force_samples = replace;; - bcf_hrec_t *hrec = bcf_hdr_get_hrec(args->files->readers[1].header, BCF_HL_FMT, "ID", key, NULL); - tmp.l = 0; - bcf_hrec_format(hrec, &tmp); - bcf_hdr_append(args->hdr_out, tmp.s); - bcf_hdr_sync(args->hdr_out); + if ( force_samples>=0 && replace!=REPLACE_ALL ) force_samples = replace; + if ( args->tgts_is_vcf ) + { + bcf_hrec_t *hrec = bcf_hdr_get_hrec(args->files->readers[1].header, BCF_HL_FMT, "ID", key, NULL); + tmp.l = 0; + bcf_hrec_format(hrec, &tmp); + bcf_hdr_append(args->hdr_out, tmp.s); + bcf_hdr_sync(args->hdr_out); + } int hdr_id = bcf_hdr_id2int(args->hdr_out, BCF_DT_ID, key); + if ( !bcf_hdr_idinfo_exists(args->hdr_out,BCF_HL_FMT,hdr_id) ) + error("The tag \"%s\" is not defined in %s\n", str.s, args->targets_fname); args->ncols++; args->cols = (annot_col_t*) realloc(args->cols,sizeof(annot_col_t)*args->ncols); annot_col_t *col = &args->cols[args->ncols-1]; - col->icol = -1; + if ( !args->tgts_is_vcf ) + { + col->icol = icol; + icol += bcf_hdr_nsamples(args->hdr_out) - 1; + } + else + col->icol = -1; col->replace = replace; col->hdr_key = strdup(key); if ( !strcasecmp("GT",key) ) col->setter = vcf_setter_format_gt; else switch ( bcf_hdr_id2type(args->hdr_out,BCF_HL_FMT,hdr_id) ) { - case BCF_HT_INT: col->setter = vcf_setter_format_int; break; - case BCF_HT_REAL: col->setter = vcf_setter_format_real; break; - case BCF_HT_STR: col->setter = vcf_setter_format_str; has_fmt_str = 1; break; + case BCF_HT_INT: col->setter = args->tgts_is_vcf ? vcf_setter_format_int : setter_format_int; break; + case BCF_HT_REAL: col->setter = args->tgts_is_vcf ? vcf_setter_format_real : setter_format_real; break; + case BCF_HT_STR: col->setter = args->tgts_is_vcf ? vcf_setter_format_str : setter_format_str; has_fmt_str = 1; break; default: error("The type of %s not recognised (%d)\n", str.s,bcf_hdr_id2type(args->hdr_out,BCF_HL_FMT,hdr_id)); } } @@ -1314,7 +1451,7 @@ static void init_columns(args_t *args) args->ncols++; args->cols = (annot_col_t*) realloc(args->cols,sizeof(annot_col_t)*args->ncols); annot_col_t *col = &args->cols[args->ncols-1]; - col->icol = i; + col->icol = icol; col->replace = replace; col->hdr_key = strdup(str.s); col->number = bcf_hdr_id2length(args->hdr_out,BCF_HL_INFO,hdr_id); @@ -1338,11 +1475,12 @@ static void init_columns(args_t *args) if ( skip_fmt ) khash_str2int_destroy_free(skip_fmt); if ( has_fmt_str ) { - int n = bcf_hdr_nsamples(args->hdr_out) > bcf_hdr_nsamples(args->files->readers[1].header) ? bcf_hdr_nsamples(args->hdr_out) : bcf_hdr_nsamples(args->files->readers[1].header); + int n = bcf_hdr_nsamples(args->hdr_out); + if ( args->tgts_is_vcf && nfiles->readers[1].header) ) n = bcf_hdr_nsamples(args->files->readers[1].header); args->tmpp = (char**)malloc(sizeof(char*)*n); args->tmpp2 = (char**)malloc(sizeof(char*)*n); } - if ( force_samples>=0 ) + if ( force_samples>=0 && args->tgts_is_vcf ) set_samples(args, args->files->readers[1].header, args->hdr, force_samples==REPLACE_ALL ? 0 : 1); } From ba58f21511e9c7c34eee7dbcdc440ca4cd7982ea Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Thu, 29 Oct 2015 19:28:34 +0000 Subject: [PATCH 136/211] The fill-tags plugin can add AF. Resolves #345 --- plugins/fill-tags.c | 33 ++++++++++++++++++++++++++++----- 1 file changed, 28 insertions(+), 5 deletions(-) diff --git a/plugins/fill-tags.c b/plugins/fill-tags.c index 96f5e3391..1d2892981 100644 --- a/plugins/fill-tags.c +++ b/plugins/fill-tags.c @@ -37,6 +37,7 @@ #define SET_AC_Hom (1<<2) #define SET_AC_Het (1<<3) #define SET_AC_Hemi (1<<4) +#define SET_AF (1<<5) typedef struct { @@ -47,8 +48,9 @@ counts_t; typedef struct { bcf_hdr_t *in_hdr, *out_hdr; - int tags, marr, mcounts, gt_id; + int tags, marr, mfarr, mcounts, gt_id; int32_t *arr; + float *farr; counts_t *counts; } args_t; @@ -57,14 +59,14 @@ static args_t args; const char *about(void) { - return "Set INFO tags AN, AC, AC_Hom, AC_Het, AC_Hemi.\n"; + return "Set INFO tags AF, AN, AC, AC_Hom, AC_Het, AC_Hemi.\n"; } const char *usage(void) { return "\n" - "About: Set INFO tags AN, AC, AC_Hom, AC_Het, AC_Hemi.\n" + "About: Set INFO tags AF, AN, AC, AC_Hom, AC_Het, AC_Hemi.\n" "Usage: bcftools +fill-tags [General Options] -- [Plugin Options]\n" "Options:\n" " run \"bcftools plugin\" for a list of common options\n" @@ -89,6 +91,7 @@ int parse_tags(args_t *args, const char *str) else if ( !strcasecmp(tags[i],"AC_Hom") ) flag |= SET_AC_Hom; else if ( !strcasecmp(tags[i],"AC_Het") ) flag |= SET_AC_Het; else if ( !strcasecmp(tags[i],"AC_Hemi") ) flag |= SET_AC_Hemi; + else if ( !strcasecmp(tags[i],"AF") ) flag |= SET_AF; else { fprintf(stderr,"Error parsing \"--tags %s\": the tag \"%s\" is not supported\n", str,tags[i]); @@ -124,7 +127,7 @@ int init(int argc, char **argv, bcf_hdr_t *in, bcf_hdr_t *out) } } if ( optind != argc ) error(usage()); - if ( !args.tags ) args.tags |= SET_AN|SET_AC|SET_AC_Hom|SET_AC_Het|SET_AC_Hemi; + if ( !args.tags ) args.tags |= SET_AN|SET_AC|SET_AC_Hom|SET_AC_Het|SET_AC_Hemi|SET_AF; args.gt_id = bcf_hdr_id2int(args.in_hdr,BCF_DT_ID,"GT"); if ( args.gt_id<0 ) error("Error: GT field is not present\n"); @@ -134,6 +137,7 @@ int init(int argc, char **argv, bcf_hdr_t *in, bcf_hdr_t *out) if ( args.tags&SET_AC_Hom ) bcf_hdr_append(args.out_hdr, "##INFO="); if ( args.tags&SET_AC_Het ) bcf_hdr_append(args.out_hdr, "##INFO="); if ( args.tags&SET_AC_Hemi ) bcf_hdr_append(args.out_hdr, "##INFO="); + if ( args.tags&SET_AF ) bcf_hdr_append(args.out_hdr, "##INFO="); return 0; } @@ -149,6 +153,7 @@ bcf1_t *process(bcf1_t *rec) if ( !fmt_gt ) return rec; // no GT tag hts_expand(int32_t,rec->n_allele,args.marr,args.arr); + hts_expand(float,rec->n_allele,args.mfarr,args.farr); hts_expand(counts_t,rec->n_allele,args.mcounts,args.counts); memset(args.arr,0,sizeof(*args.arr)*rec->n_allele); memset(args.counts,0,sizeof(*args.counts)*rec->n_allele); @@ -201,6 +206,23 @@ bcf1_t *process(bcf1_t *rec) if ( bcf_update_info_int32(args.out_hdr,rec,"AN",args.arr,1)!=0 ) error("Error occurred while updating AN at %s:%d\n", bcf_seqname(args.in_hdr,rec),rec->pos+1); } + if ( args.tags&SET_AF ) + { + int n = rec->n_allele-1; + if ( n>0 ) + { + args.arr[0] = 0; + for (i=0; in_allele; i++) + args.arr[0] += args.counts[i].nhet + args.counts[i].nhom + args.counts[i].nhemi; + for (i=1; in_allele; i++) + args.farr[i] = (args.counts[i].nhet + args.counts[i].nhom + args.counts[i].nhemi)*1.0/args.arr[0]; + } + if ( args.arr[0] ) + { + if ( bcf_update_info_float(args.out_hdr,rec,"AF",args.farr+1,n)!=0 ) + error("Error occurred while updating AF at %s:%d\n", bcf_seqname(args.in_hdr,rec),rec->pos+1); + } + } if ( args.tags&SET_AC ) { int n = rec->n_allele-1; @@ -208,7 +230,7 @@ bcf1_t *process(bcf1_t *rec) { memset(args.arr,0,sizeof(*args.arr)*rec->n_allele); for (i=1; in_allele; i++) - args.arr[i] += args.counts[i].nhet + args.counts[i].nhom + args.counts[i].nhemi; + args.arr[i] = args.counts[i].nhet + args.counts[i].nhom + args.counts[i].nhemi; } if ( bcf_update_info_int32(args.out_hdr,rec,"AC",args.arr+1,n)!=0 ) error("Error occurred while updating AC at %s:%d\n", bcf_seqname(args.in_hdr,rec),rec->pos+1); @@ -256,6 +278,7 @@ void destroy(void) { free(args.counts); free(args.arr); + free(args.farr); } From 820e1d612adfcf063ef855be6510e18a4af58022 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Thu, 17 Dec 2015 07:58:56 +0000 Subject: [PATCH 137/211] roh: Viterbi training fixed, resolves #328 --- vcfroh.c | 43 +++++++++++++++++++++++++++++++++---------- 1 file changed, 33 insertions(+), 10 deletions(-) diff --git a/vcfroh.c b/vcfroh.c index fa64b798e..95605592f 100644 --- a/vcfroh.c +++ b/vcfroh.c @@ -368,14 +368,31 @@ static void flush_viterbi(args_t *args) } } - // update the transition matrix tprob + // update the transition matrix + int n = 1; for (i=0; i<2; i++) { - int n = 0; for (j=0; j<2; j++) n += MAT(tcounts,2,i,j); - if ( !n) error("fixme: state %d not observed\n", i+1); - for (j=0; j<2; j++) MAT(tcounts,2,i,j) /= n; } + for (i=0; i<2; i++) + { + for (j=0; j<2; j++) + { + // no transition to i-th state was observed, set to a small number + if ( !MAT(tcounts,2,i,j) ) MAT(tcounts,2,i,j) = 0.1/n; + else MAT(tcounts,2,i,j) /= n; + } + } + + // normalize + for (i=0; i<2; i++) + { + double norm = 0; + for (j=0; j<2; j++) norm += MAT(tcounts,2,j,i); + assert( norm!=0 ); + for (j=0; j<2; j++) MAT(tcounts,2,j,i) /= norm; + } + if ( args->genmap_fname || args->rec_rate > 0 ) hmm_set_tprob(args->hmm, tcounts, 0); else @@ -385,14 +402,16 @@ static void flush_viterbi(args_t *args) deltaz = fabs(MAT(tprob_arr,2,1,0)-t2az_prev); delthw = fabs(MAT(tprob_arr,2,0,1)-t2hw_prev); niter++; - - fprintf(stderr,"%d: %f %f\n", niter,deltaz,delthw); + fprintf(stderr,"Viterbi training, iteration %d: dAZ=%e dHW=%e\tP(HW|HW)=%e P(AZ|HW)=%e P(AZ|AZ)=%e P(HW|AZ)=%e\n", + niter,deltaz,delthw, + MAT(tprob_arr,2,STATE_HW,STATE_HW),MAT(tprob_arr,2,STATE_AZ,STATE_HW), + MAT(tprob_arr,2,STATE_AZ,STATE_AZ),MAT(tprob_arr,2,STATE_HW,STATE_AZ)); } while ( deltaz > 0.0 || delthw > 0.0 ); - fprintf(stderr, "Viterbi training converged in %d iterations to", niter); double *tprob_arr = hmm_get_tprob(args->hmm); - for (i=0; i<2; i++) for (j=0; j<2; j++) fprintf(stderr, " %f", MAT(tprob_arr,2,i,j)); - fprintf(stderr, "\n"); + fprintf(stderr, "Viterbi training converged in %d iterations to P(HW|HW)=%e P(AZ|HW)=%e P(AZ|AZ)=%e P(HW|AZ)=%e\n", niter, + MAT(tprob_arr,2,STATE_HW,STATE_HW),MAT(tprob_arr,2,STATE_AZ,STATE_HW), + MAT(tprob_arr,2,STATE_AZ,STATE_AZ),MAT(tprob_arr,2,STATE_HW,STATE_AZ)); // output the results for (i=0; inrids; i++) @@ -400,12 +419,16 @@ static void flush_viterbi(args_t *args) int ioff = args->rid_offs[i]; int nsites = (i+1==args->nrids ? args->nsites : args->rid_offs[i+1]) - ioff; hmm_run_viterbi(args->hmm, nsites, args->eprob+ioff*2, args->sites+ioff); + hmm_run_fwd_bwd(args->hmm, nsites, args->eprob+ioff*2, args->sites+ioff); uint8_t *vpath = hmm_get_viterbi_path(args->hmm); + double *fwd = hmm_get_fwd_bwd_prob(args->hmm); const char *chr = bcf_hdr_id2name(args->hdr,args->rids[i]); for (j=0; jsites[ioff+j]+1,vpath[j*2]==STATE_AZ ? 1 : 0); + int state = vpath[j*2]; + double pval = fwd[j*2 + state]; + printf("%s\t%d\t%d\t%e\n", chr,args->sites[ioff+j]+1,state==STATE_AZ ? 1 : 0, pval); } } } From 36036cf14684f9f7d21f88b7565b890329e6eb2d Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Fri, 20 Nov 2015 15:18:37 +0000 Subject: [PATCH 138/211] concat: new --naive option for fast operations on large BCFs --- Makefile | 4 +- doc/bcftools.txt | 12 ++++- reheader.c | 11 ++-- vcfconcat.c | 131 +++++++++++++++++++++++++++++++++++++++++++++-- 4 files changed, 143 insertions(+), 15 deletions(-) diff --git a/Makefile b/Makefile index 4357d7c7f..b84556523 100644 --- a/Makefile +++ b/Makefile @@ -143,7 +143,7 @@ main.o: main.c $(htslib_hts_h) version.h $(bcftools_h) vcfannotate.o: vcfannotate.c $(htslib_vcf_h) $(htslib_synced_bcf_reader_h) $(HTSDIR)/htslib/kseq.h $(bcftools_h) vcmp.h $(filter_h) vcfplugin.o: vcfplugin.c $(htslib_vcf_h) $(htslib_synced_bcf_reader_h) $(HTSDIR)/htslib/kseq.h $(bcftools_h) vcmp.h $(filter_h) vcfcall.o: vcfcall.c $(htslib_vcf_h) $(HTSDIR)/htslib/kfunc.h $(htslib_synced_bcf_reader_h) $(HTSDIR)/htslib/khash_str2int.h $(bcftools_h) $(call_h) $(prob1_h) $(ploidy_h) -vcfconcat.o: vcfconcat.c $(htslib_vcf_h) $(htslib_synced_bcf_reader_h) $(HTSDIR)/htslib/kseq.h $(bcftools_h) +vcfconcat.o: vcfconcat.c $(htslib_vcf_h) $(htslib_synced_bcf_reader_h) $(HTSDIR)/htslib/kseq.h $(htslib_bgzf_h) $(htslib_tbx_h) $(bcftools_h) vcfconvert.o: vcfconvert.c $(htslib_vcf_h) $(htslib_bgzf_h) $(htslib_synced_bcf_reader_h) $(htslib_vcfutils_h) $(bcftools_h) $(filter_h) $(convert_h) $(tsv2vcf_h) vcffilter.o: vcffilter.c $(htslib_vcf_h) $(htslib_synced_bcf_reader_h) $(htslib_vcfutils_h) $(bcftools_h) $(filter_h) rbuf.h vcfgtcheck.o: vcfgtcheck.c $(htslib_vcf_h) $(htslib_synced_bcf_reader_h) $(htslib_vcfutils_h) $(bcftools_h) @@ -157,7 +157,7 @@ vcfcnv.o: vcfcnv.c $(cnv_h) vcfsom.o: vcfsom.c $(htslib_vcf_h) $(htslib_synced_bcf_reader_h) $(htslib_vcfutils_h) $(bcftools_h) vcfstats.o: vcfstats.c $(htslib_vcf_h) $(htslib_synced_bcf_reader_h) $(htslib_vcfutils_h) $(htslib_faidx_h) $(bcftools_h) vcfview.o: vcfview.c $(htslib_vcf_h) $(htslib_synced_bcf_reader_h) $(htslib_vcfutils_h) $(bcftools_h) $(filter_h) -reheader.o: reheader.c $(htslib_vcf_h) $(htslib_bgzf_h) $(HTSDIR)/htslib/kseq.h $(bcftools_h) +reheader.o: reheader.c $(htslib_vcf_h) $(htslib_bgzf_h) $(htslib_tbx_h) $(HTSDIR)/htslib/kseq.h $(bcftools_h) tabix.o: tabix.c $(htslib_bgzf_h) $(htslib_tbx_h) ccall.o: ccall.c $(HTSDIR)/htslib/kfunc.h $(call_h) kmin.h $(prob1_h) convert.o: convert.c $(htslib_vcf_h) $(htslib_synced_bcf_reader_h) $(htslib_vcfutils_h) $(bcftools_h) $(convert_h) diff --git a/doc/bcftools.txt b/doc/bcftools.txt index 4f32b7e39..baa5b0d5d 100644 --- a/doc/bcftools.txt +++ b/doc/bcftools.txt @@ -630,7 +630,10 @@ columns appearing in the same order. Can be used, for example, to concatenate chromosome VCFs into one VCF, or combine a SNP VCF and an indel VCF into one. The input files must be sorted by chr and position. The files must be given in the correct order to produce sorted VCF on output unless -the *-a, --allow-overlaps* option is specified. +the *-a, --allow-overlaps* option is specified. With the --naive option, the files +are concatenated without being recompressed, which is very fast but dangerous +if the BCF headers differ. + *-a, --allow-overlaps*:: First coordinate of the next file can precede last record of the current file. @@ -651,6 +654,13 @@ the *-a, --allow-overlaps* option is specified. *-l, --ligate*:: Ligate phased VCFs by matching phase at overlapping haplotypes +*-n, --naive*:: + Concatenate BCF files without recompression. This is very fast but requires + that all files have the same headers. This is because all tags and + chromosome names in the BCF body rely on the implicit order of the contig + and tag definitions in the header. Currently no sanity checks + are in place and only works for compressed BCF files. Dangerous, use with caution. + *-o, --output* 'FILE':: see *<>* diff --git a/reheader.c b/reheader.c index 132b968c5..73123f942 100644 --- a/reheader.c +++ b/reheader.c @@ -34,6 +34,7 @@ THE SOFTWARE. */ #include #include #include +#include // for hts_get_bgzfp() #include #include "bcftools.h" #include "khash_str2str.h" @@ -239,11 +240,7 @@ static void reheader_vcf_gz(args_t *args) } // Output the modified header - BGZF *bgzf_out; - if ( args->output_fname ) - bgzf_out = bgzf_open(args->output_fname,"w"); - else - bgzf_out = bgzf_dopen(fileno(stdout), "w"); + BGZF *bgzf_out = bgzf_open(args->output_fname ? args->output_fname : "-","w");; bgzf_write(bgzf_out, hdr.s, hdr.l); free(hdr.s); @@ -256,8 +253,8 @@ static void reheader_vcf_gz(args_t *args) // Stream the rest of the file without as it is, without decompressing ssize_t nread; - int page_size = getpagesize(); - char *buf = (char*) valloc(page_size); + const size_t page_size = 32768; + char *buf = (char*) malloc(page_size); while (1) { nread = bgzf_raw_read(fp, buf, page_size); diff --git a/vcfconcat.c b/vcfconcat.c index cfec7c01a..8cc177b33 100644 --- a/vcfconcat.c +++ b/vcfconcat.c @@ -31,6 +31,8 @@ THE SOFTWARE. */ #include #include #include +#include +#include // for hts_get_bgzfp() #include "bcftools.h" typedef struct _args_t @@ -50,7 +52,7 @@ typedef struct _args_t char **argv, *output_fname, *file_list, **fnames, *remove_dups, *regions_list; int argc, nfnames, allow_overlaps, phased_concat, regions_is_file; - int compact_PS, phase_set_changed; + int compact_PS, phase_set_changed, naive_concat; } args_t; @@ -176,8 +178,11 @@ static void destroy_data(args_t *args) for (i=0; infnames; i++) free(args->fnames[i]); free(args->fnames); if ( args->files ) bcf_sr_destroy(args->files); - if ( hts_close(args->out_fh)!=0 ) error("hts_close error\n"); - bcf_hdr_destroy(args->out_hdr); + if ( args->out_fh ) + { + if ( hts_close(args->out_fh)!=0 ) error("hts_close error\n"); + } + if ( args->out_hdr ) bcf_hdr_destroy(args->out_hdr); free(args->seen_seq); free(args->start_pos); free(args->swap_phase); @@ -550,6 +555,108 @@ static void concat(args_t *args) } } +static void naive_concat(args_t *args) +{ + // only compressed BCF atm + BGZF *bgzf_out = bgzf_open(args->output_fname,"w");; + + const size_t page_size = 32768; + char *buf = (char*) malloc(page_size); + kstring_t tmp = {0,0,0}; + int i; + for (i=0; infnames; i++) + { + htsFile *hts_fp = hts_open(args->fnames[i],"r"); + if ( !hts_fp ) error("Failed to open: %s\n", args->fnames[i]); + htsFormat type = *hts_get_format(hts_fp); + + if ( type.format==vcf ) error("The --naive option currently works only for compressed BCFs, sorry :-/\n"); + if ( type.compression!=bgzf ) error("The --naive option currently works only for compressed BCFs, sorry :-/\n"); + + BGZF *fp = hts_get_bgzfp(hts_fp); + if ( !fp || bgzf_read_block(fp) != 0 || !fp->block_length ) + error("Failed to read %s: %s\n", args->fnames[i], strerror(errno)); + + uint8_t magic[5]; + if ( bgzf_read(fp, magic, 5)<0 ) error("Failed to read the BCF header in %s\n", args->fnames[i]); + if (strncmp((char*)magic, "BCF\2\2", 5) != 0) error("Invalid BCF magic string in %s\n", args->fnames[i]); + + bgzf_read(fp, &tmp.l, 4); + hts_expand(char,tmp.l,tmp.m,tmp.s); + bgzf_read(fp, tmp.s, tmp.l); + + // write only the first header + if ( i==0 ) + { + if ( bgzf_write(bgzf_out, "BCF\2\2", 5) !=5 ) error("Failed to write %d bytes to %s\n", 5,args->output_fname); + if ( bgzf_write(bgzf_out, &tmp.l, 4) !=4 ) error("Failed to write %d bytes to %s\n", 4,args->output_fname); + if ( bgzf_write(bgzf_out, tmp.s, tmp.l) != tmp.l) error("Failed to write %d bytes to %s\n", tmp.l,args->output_fname); + } + + // Output all non-header data that were read together with the header block + int nskip = fp->block_offset; + if ( fp->block_length - nskip > 0 ) + { + if ( bgzf_write(bgzf_out, fp->uncompressed_block+nskip, fp->block_length-nskip)<0 ) error("Error: %d\n",fp->errcode); + } + if ( bgzf_flush(bgzf_out)<0 ) error("Error: %d\n",bgzf_out->errcode); + + + // Stream the rest of the file as it is, without recompressing, but remove BGZF EOF blocks + ssize_t nread, ncached = 0, nwr; + const int neof = 28; + char cached[neof]; + while (1) + { + nread = bgzf_raw_read(fp, buf, page_size); + + // page_size boundary may occur in the middle of the EOF block, so we need to cache the blocks' ends + if ( nread<=0 ) break; + if ( nread<=neof ) // last block + { + if ( ncached ) + { + // flush the part of the cache that won't be needed + nwr = bgzf_raw_write(bgzf_out, cached, nread); + if (nwr != nread) error("Write failed, wrote %d instead of %d bytes.\n", nwr,(int)nread); + + // make space in the cache so that we can append to the end + if ( nread!=neof ) memmove(cached,cached+nread,neof-nread); + } + + // fill the cache and check for eof outside this loop + memcpy(cached+neof-nread,buf,nread); + break; + } + + // not the last block, flush the cache if full + if ( ncached ) + { + nwr = bgzf_raw_write(bgzf_out, cached, ncached); + if (nwr != ncached) error("Write failed, wrote %d instead of %d bytes.\n", nwr,(int)ncached); + ncached = 0; + } + + // fill the cache + nread -= neof; + memcpy(cached,buf+nread,neof); + ncached = neof; + + nwr = bgzf_raw_write(bgzf_out, buf, nread); + if (nwr != nread) error("Write failed, wrote %d instead of %d bytes.\n", nwr,(int)nread); + } + if ( ncached && memcmp(cached,"\037\213\010\4\0\0\0\0\0\377\6\0\102\103\2\0\033\0\3\0\0\0\0\0\0\0\0\0",neof) ) + { + nwr = bgzf_raw_write(bgzf_out, cached, neof); + if (nwr != neof) error("Write failed, wrote %d instead of %d bytes.\n", nwr,(int)neof); + } + if (hts_close(hts_fp)) error("Close failed: %s\n",args->fnames[i]); + } + free(buf); + free(tmp.s); + if (bgzf_close(bgzf_out) < 0) error("Error: %d\n",bgzf_out->errcode); +} + static void usage(args_t *args) { fprintf(stderr, "\n"); @@ -558,7 +665,9 @@ static void usage(args_t *args) fprintf(stderr, " concatenate chromosome VCFs into one VCF, or combine a SNP VCF and an indel\n"); fprintf(stderr, " VCF into one. The input files must be sorted by chr and position. The files\n"); fprintf(stderr, " must be given in the correct order to produce sorted VCF on output unless\n"); - fprintf(stderr, " the -a, --allow-overlaps option is specified.\n"); + fprintf(stderr, " the -a, --allow-overlaps option is specified. With the --naive option, the files\n"); + fprintf(stderr, " are concatenated without being recompressed, which is very fast but dangerous\n"); + fprintf(stderr, " if the BCF headers differ.\n"); fprintf(stderr, "Usage: bcftools concat [options] [ [...]]\n"); fprintf(stderr, "\n"); fprintf(stderr, "Options:\n"); @@ -568,6 +677,7 @@ static void usage(args_t *args) fprintf(stderr, " -D, --remove-duplicates Alias for -d none\n"); fprintf(stderr, " -f, --file-list Read the list of files from a file.\n"); fprintf(stderr, " -l, --ligate Ligate phased VCFs by matching phase at overlapping haplotypes\n"); + fprintf(stderr, " -n, --naive Concatenate BCF files without recompression (dangerous, use with caution)\n"); fprintf(stderr, " -o, --output Write output to a file [standard output]\n"); fprintf(stderr, " -O, --output-type b: compressed BCF, u: uncompressed BCF, z: compressed VCF, v: uncompressed VCF [v]\n"); fprintf(stderr, " -q, --min-PQ Break phase set if phasing quality is lower than [30]\n"); @@ -590,6 +700,7 @@ int main_vcfconcat(int argc, char *argv[]) static struct option loptions[] = { + {"naive",no_argument,NULL,'n'}, {"compact-PS",no_argument,NULL,'c'}, {"regions",required_argument,NULL,'r'}, {"regions-file",required_argument,NULL,'R'}, @@ -605,7 +716,7 @@ int main_vcfconcat(int argc, char *argv[]) {NULL,0,NULL,0} }; char *tmp; - while ((c = getopt_long(argc, argv, "h:?o:O:f:alq:Dd:r:R:c",loptions,NULL)) >= 0) + while ((c = getopt_long(argc, argv, "h:?o:O:f:alq:Dd:r:R:cn",loptions,NULL)) >= 0) { switch (c) { case 'c': args->compact_PS = 1; break; @@ -617,6 +728,7 @@ int main_vcfconcat(int argc, char *argv[]) args->min_PQ = strtol(optarg,&tmp,10); if ( *tmp ) error("Could not parse argument: --min-PQ %s\n", optarg); break; + case 'n': args->naive_concat = 1; break; case 'a': args->allow_overlaps = 1; break; case 'l': args->phased_concat = 1; break; case 'f': args->file_list = optarg; break; @@ -654,6 +766,15 @@ int main_vcfconcat(int argc, char *argv[]) if ( !args->nfnames ) usage(args); if ( args->remove_dups && !args->allow_overlaps ) error("The -D option is supported only with -a\n"); if ( args->regions_list && !args->allow_overlaps ) error("The -r/-R option is supported only with -a\n"); + if ( args->naive_concat ) + { + if ( args->allow_overlaps ) error("The option --naive cannot be combined with --allow-overlaps\n"); + if ( args->phased_concat ) error("The option --naive cannot be combined with --ligate\n"); + naive_concat(args); + destroy_data(args); + free(args); + return 0; + } init_data(args); concat(args); destroy_data(args); From 2cd6f08753fb2fdd45c2116fae7e129bb83351b9 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Wed, 18 Nov 2015 13:49:08 +0000 Subject: [PATCH 139/211] Pass unchanged argc,argv to plugins with run() implemented. This allows to get rid of the cumbersome "--" in command line options. Updated print_plugin_usage_hint() following 5f1756ace. --- plugins/vcf2sex.c | 8 ++++---- vcfplugin.c | 33 +++++++++++++++------------------ 2 files changed, 19 insertions(+), 22 deletions(-) diff --git a/plugins/vcf2sex.c b/plugins/vcf2sex.c index b9ce69dcc..ddba74c4d 100644 --- a/plugins/vcf2sex.c +++ b/plugins/vcf2sex.c @@ -105,8 +105,8 @@ const char *usage(void) " Y 1 59373566 F 0\n" " \n" " bcftools +vcf2sex in.vcf.gz\n" - " bcftools +vcf2sex in.vcf.gz -- -n 10\n" - " bcftools +vcf2sex in.vcf.gz -- -g GT\n" + " bcftools +vcf2sex -n 10 in.vcf.gz\n" + " bcftools +vcf2sex -g GT in.vcf.gz\n" "\n"; } @@ -420,8 +420,8 @@ int run(int argc, char **argv) args->sr = bcf_sr_init(); args->sr->require_index = 1; - if ( !argv[0] ) error("%s", usage()); - if ( !bcf_sr_add_reader(args->sr,argv[0]) ) error("Error: %s\n", bcf_sr_strerror(args->sr->errnum)); + if ( optind==argc ) error("%s", usage()); + if ( !bcf_sr_add_reader(args->sr,argv[optind]) ) error("Error: %s\n", bcf_sr_strerror(args->sr->errnum)); args->hdr = args->sr->readers[0].header; args->nsample = bcf_hdr_nsamples(args->hdr); diff --git a/vcfplugin.c b/vcfplugin.c index e2ca04a8e..ad73734bb 100644 --- a/vcfplugin.c +++ b/vcfplugin.c @@ -239,13 +239,6 @@ static void print_plugin_usage_hint(void) fprintf(stderr, " in\n\tBCFTOOLS_PLUGINS=\"%s\".\n\n" "- Is the plugin path correct?\n\n" - "- Are all shared libraries, namely libhts.so, accessible? Verify with\n" - " on Mac OS X: `otool -L your/plugin.so` and set DYLD_LIBRARY_PATH if they are not\n" - " on Linux: `ldd your/plugin.so` and set LD_LIBRARY_PATH if they are not\n" - "\n" - "- If not installed systemwide, set the environment variable LD_LIBRARY_PATH (linux) or\n" - "DYLD_LIBRARY_PATH (mac) to include directory where *libhts.so* is located.\n" - "\n" "- Run \"bcftools plugin -lv\" for more detailed error output.\n" "\n", getenv("BCFTOOLS_PLUGINS") @@ -484,8 +477,22 @@ int main_plugin(int argc, char *argv[]) int regions_is_file = 0, targets_is_file = 0, plist_only = 0, usage_only = 0, version_only = 0; if ( argc==1 ) usage(args); + char *plugin_name = NULL; - if ( argv[1][0]!='-' ) { plugin_name = argv[1]; argc--; argv++; } + if ( argv[1][0]!='-' ) + { + plugin_name = argv[1]; + argc--; + argv++; + load_plugin(args, plugin_name, 1, &args->plugin); + if ( args->plugin.run ) + { + int ret = args->plugin.run(argc, argv); + destroy_data(args); + free(args); + return ret; + } + } static struct option loptions[] = { @@ -535,7 +542,6 @@ int main_plugin(int argc, char *argv[]) if ( plist_only ) return list_plugins(args); if ( usage_only && ! plugin_name ) usage(args); - load_plugin(args, plugin_name, 1, &args->plugin); if ( version_only ) { const char *bver, *hver; @@ -554,15 +560,6 @@ int main_plugin(int argc, char *argv[]) return 0; } - if ( args->plugin.run ) - { - int iopt = optind; optind = 0; - int ret = args->plugin.run(argc-iopt, argv+iopt); - destroy_data(args); - free(args); - return ret; - } - char *fname = NULL; if ( optind>=argc || argv[optind][0]=='-' ) { From 9cf0d82493db16f74e9ff278f0d5573c50694b90 Mon Sep 17 00:00:00 2001 From: mcshane Date: Thu, 21 Jan 2016 14:20:49 +0000 Subject: [PATCH 140/211] add --no-version option to suppress appending of version and command line to output headers --- doc/bcftools.txt | 33 ++++++++++++++++++++++++++++++++- test/concat.1.a.vcf | 2 -- test/concat.1.b.vcf | 2 -- test/test.pl | 32 ++++++++++++++++---------------- vcfannotate.c | 8 ++++++-- vcfcall.c | 8 ++++++-- vcfconcat.c | 8 ++++++-- vcfconvert.c | 18 +++++++++++------- vcffilter.c | 8 ++++++-- vcfisec.c | 12 ++++++++---- vcfmerge.c | 8 ++++++-- vcfnorm.c | 9 +++++++-- vcfplugin.c | 8 ++++++-- vcfview.c | 8 +++++++- 14 files changed, 117 insertions(+), 47 deletions(-) diff --git a/doc/bcftools.txt b/doc/bcftools.txt index baa5b0d5d..6b771dfe7 100644 --- a/doc/bcftools.txt +++ b/doc/bcftools.txt @@ -159,6 +159,9 @@ specific commands to see if they apply. in 'LIST'. For example, to include only sites which have no filters set, use *-f* '.,PASS'. +*--no-version*:: + Do not append version and command line information to the output VCF header. + *-o, --output* 'FILE':: When output consists of a single stream, write it to 'FILE' rather than to standard output, where it is written by default. @@ -337,6 +340,9 @@ This command allows to add or remove annotations. *-m, --mark-sites* [+-]'TAG':: annotate sites which are present ("+") or absent ("-") in the *-a* file with a new INFO/TAG flag +*--no-version*:: + see *<>* + *-o, --output* 'FILE':: see *<>* @@ -498,6 +504,9 @@ demand. The original calling model can be invoked with the *-c* option. ==== File format options: +*--no-version*:: + see *<>* + *-o, --output* 'FILE':: see *<>* @@ -654,6 +663,9 @@ if the BCF headers differ. *-l, --ligate*:: Ligate phased VCFs by matching phase at overlapping haplotypes +*--no-version*:: + see *<>* + *-n, --naive*:: Concatenate BCF files without recompression. This is very fast but requires that all files have the same headers. This is because all tags and @@ -749,6 +761,9 @@ Create consensus sequence by applying VCF variants to a reference fasta file. ==== VCF output options: +*--no-version*:: + see *<>* + *-o, --output* 'FILE':: see *<>* @@ -946,6 +961,9 @@ And similarly here, the second is filtered: strings of failed sites instead of replacing them. The "x" mode resets filters of sites which pass to "PASS". Modes "+" and "x" can both be set. +*--no-version*:: + see *<>* + *-o, --output* 'FILE':: see *<>* @@ -971,7 +989,8 @@ And similarly here, the second is filtered: *-T, --targets-file* 'file':: see *<>* - +*--threads* 'INT':: + see *<>* @@ -1219,6 +1238,9 @@ For "vertical" merge take a look at *<>* instead. -m id .. merge by ID ---- +*--no-version*:: + see *<>* + *-o, --output* 'FILE':: see *<>* @@ -1272,6 +1294,9 @@ the *<>* option is supplied. 'both'; if SNPs and indels should be merged into a single record, specify 'any'. +*--no-version*:: + see *<>* + *-N, --do-not-normalize*[[do_not_normalize]]:: the '-c s' option can be used to fix or set the REF allele from the reference '-f'. The '-N' option will not turn on indel normalisation @@ -1333,6 +1358,9 @@ the *<>* option is supplied. ==== VCF output options: +*--no-version*:: + see *<>* + *-o, --output* 'FILE':: see *<>* @@ -1801,6 +1829,9 @@ Convert between VCF and BCF. Former *bcftools subset*. compression level. 0 stands for uncompressed, 1 for best speed and 9 for best compression. +*--no-version*:: + see *<>* + *-O, --output-type* 'b'|'u'|'z'|'v':: see *<>* diff --git a/test/concat.1.a.vcf b/test/concat.1.a.vcf index 4e9f2f0f8..77912a6ac 100644 --- a/test/concat.1.a.vcf +++ b/test/concat.1.a.vcf @@ -11,8 +11,6 @@ ##samtoolsVersion=0.2.0-rc10+htslib-0.2.0-rc10 ##samtoolsCommand=samtools mpileup -t INFO/DPR -C50 -pm3 -F0.2 -d10000 -ug -r 1:1-1000000 -b mpileup.2014-07-03//lists/chr1-pooled.list -f human_g1k_v37.fasta ##ALT= -##bcftools_callVersion=0.2.0-rc10-2-gcd94fde+htslib-0.2.0-rc10 -##bcftools_callCommand=call -vm -f GQ -S mpileup.2014-07-03//pooled/1/1:1-1000000.samples - #CHROM POS ID REF ALT QUAL FILTER INFO FORMAT A 1 100 . GTTT G 1806 q10 XX=11;DP=35 GT:GQ:DP 0/1:409:35 1 110 . C T,G 1792 Fail DP=32 GT:GQ:DP 0/1:245:32 diff --git a/test/concat.1.b.vcf b/test/concat.1.b.vcf index f21547e1f..4bb26e46e 100644 --- a/test/concat.1.b.vcf +++ b/test/concat.1.b.vcf @@ -2,8 +2,6 @@ ##samtoolsVersion=0.2.0-rc10+htslib-0.2.0-rc10 ##samtoolsCommand=samtools mpileup -t INFO/DPR -C50 -pm3 -F0.2 -d10000 -ug -r 1:1-1000000 -b mpileup.2014-07-03//lists/chr1-pooled.list -f human_g1k_v37.fasta ##ALT= -##bcftools_callVersion=0.2.0-rc10-2-gcd94fde+htslib-0.2.0-rc10 -##bcftools_callCommand=call -vm -f GQ -S mpileup.2014-07-03//pooled/1/1:1-1000000.samples - ##INFO= ##FORMAT= ##FORMAT= diff --git a/test/test.pl b/test/test.pl index 48ec9db08..7491147b9 100755 --- a/test/test.pl +++ b/test/test.pl @@ -483,7 +483,7 @@ sub test_vcf_merge } my $args = exists($args{args}) ? $args{args} : ''; my $files = join(' ',@files); - test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools merge $args $files | grep -v ^##bcftools_"); + test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools merge --no-version $args $files"); test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools merge -Ob $args $files | $$opts{bin}/bcftools view | grep -v ^##bcftools_"); } sub test_vcf_isec @@ -510,7 +510,7 @@ sub test_vcf_isec2 } my $files = join(' ',@files); bgzip_tabix($opts,file=>$args{tab_in},suffix=>'tab',args=>'-s 1 -b 2 -e 3'); - test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools isec $args{args} -T $$opts{tmp}/$args{tab_in}.tab.gz $files 2>/dev/null | grep -v ^##bcftools_"); + test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools isec --no-version $args{args} -T $$opts{tmp}/$args{tab_in}.tab.gz $files 2>/dev/null"); test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools isec -Ob $args{args} -T $$opts{tmp}/$args{tab_in}.tab.gz $files 2>/dev/null | $$opts{bin}/bcftools view | grep -v ^##bcftools_"); } sub test_vcf_query @@ -545,7 +545,7 @@ sub test_vcf_convert_gvcf { my ($opts,%args) = @_; bgzip_tabix_vcf($opts,$args{in}); - test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools convert $args{args} -f $$opts{path}/$args{fa} $$opts{tmp}/$args{in}.vcf.gz | grep -v ^##bcftools"); + test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools convert --no-version $args{args} -f $$opts{path}/$args{fa} $$opts{tmp}/$args{in}.vcf.gz"); test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools view -Ob $$opts{tmp}/$args{in}.vcf.gz | $$opts{bin}/bcftools convert $args{args} -f $$opts{path}/$args{fa} | grep -v ^##bcftools"); } sub test_vcf_convert_tsv2vcf @@ -554,7 +554,7 @@ sub test_vcf_convert_tsv2vcf my $params = ''; if ( exists($args{args}) ) { $params .= " $args{args}"; } if ( exists($args{fai} ) ) { $params .= " -f $$opts{path}/$args{fai}.fa"; } - test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools convert $params --tsv2vcf $$opts{path}/$args{in} | grep -v ^##bcftools_"); + test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools convert --no-version $params --tsv2vcf $$opts{path}/$args{in}"); test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools convert -Ou $params --tsv2vcf $$opts{path}/$args{in} | $$opts{bin}/bcftools view | grep -v ^##bcftools_"); } sub test_vcf_norm @@ -564,7 +564,7 @@ sub test_vcf_norm my $params = ''; if ( exists($args{args}) ) { $params .= " $args{args}"; } if ( exists($args{fai} ) ) { $params .= " -f $$opts{path}/$args{fai}.fa"; } - test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools norm $params $$opts{tmp}/$args{in}.vcf.gz | grep -v ^##bcftools_"); + test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools norm --no-version $params $$opts{tmp}/$args{in}.vcf.gz"); test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools norm -Ob $params $$opts{tmp}/$args{in}.vcf.gz | $$opts{bin}/bcftools view | grep -v ^##bcftools_"); } sub test_vcf_view @@ -574,7 +574,7 @@ sub test_vcf_view if ( !exists($args{args}) ) { $args{args} = ''; } if ( exists($args{tgts}) ) { $args{args} .= "-T $$opts{path}/$args{tgts}"; } - test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools view $args{args} $$opts{tmp}/$args{in}.vcf.gz $args{reg} | grep -v ^##bcftools_"); + test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools view --no-version $args{args} $$opts{tmp}/$args{in}.vcf.gz $args{reg}"); unless ($args{args} =~ /-H/) { test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools view -Ob $args{args} $$opts{tmp}/$args{in}.vcf.gz $args{reg} | $$opts{bin}/bcftools view | grep -v ^##bcftools_"); } @@ -583,14 +583,14 @@ sub test_vcf_call { my ($opts,%args) = @_; $args{args} =~ s/{PATH}/$$opts{path}/g; - test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools call $args{args} $$opts{path}/$args{in}.vcf | grep -v ^##bcftools_"); + test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools call --no-version $args{args} $$opts{path}/$args{in}.vcf"); test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools call -Ob $args{args} $$opts{path}/$args{in}.vcf | $$opts{bin}/bcftools view | grep -v ^##bcftools_"); } sub test_vcf_call_cAls { my ($opts,%args) = @_; bgzip_tabix($opts,file=>$args{tab},suffix=>'tab',args=>'-s1 -b2 -e2'); - test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools call -mA -C alleles -T $$opts{tmp}/$args{tab}.tab.gz $$opts{path}/$args{in}.vcf | grep -v ^##bcftools_"); + test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools call --no-version -mA -C alleles -T $$opts{tmp}/$args{tab}.tab.gz $$opts{path}/$args{in}.vcf"); test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools call -Ob -mA -C alleles -T $$opts{tmp}/$args{tab}.tab.gz $$opts{path}/$args{in}.vcf | $$opts{bin}/bcftools view | grep -v ^##bcftools_"); } sub test_vcf_filter @@ -767,11 +767,11 @@ sub test_vcf_plugin if ( !exists($args{args}) ) { $args{args} = ''; } $args{args} =~ s/{PATH}/$$opts{path}/g; bgzip_tabix_vcf($opts,"$args{in}"); - test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools $args{cmd} $$opts{tmp}/$args{in}.vcf.gz $args{args} | grep -v ^##bcftools_"); + test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools $args{cmd} --no-version $$opts{tmp}/$args{in}.vcf.gz $args{args}"); cmd("$$opts{bin}/bcftools view -Ob $$opts{tmp}/$args{in}.vcf.gz > $$opts{tmp}/$args{in}.bcf"); cmd("$$opts{bin}/bcftools index -f $$opts{tmp}/$args{in}.bcf"); - test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools $args{cmd} $$opts{tmp}/$args{in}.bcf $args{args} | grep -v ^##bcftools_"); + test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools $args{cmd} --no-version $$opts{tmp}/$args{in}.bcf $args{args} | grep -v ^##bcftools_"); } sub test_vcf_concat { @@ -781,7 +781,7 @@ sub test_vcf_concat { if ( $args{do_bcf} ) { - cmd("$$opts{bin}/bcftools view -Ob $$opts{tmp}/$file.vcf.gz > $$opts{tmp}/$file.bcf"); + cmd("$$opts{bin}/bcftools view --no-version -Ob $$opts{tmp}/$file.vcf.gz > $$opts{tmp}/$file.bcf"); cmd("$$opts{bin}/bcftools index -f $$opts{tmp}/$file.bcf"); $files .= " $$opts{tmp}/$file.bcf"; } @@ -791,14 +791,14 @@ sub test_vcf_concat $files .= " $$opts{tmp}/$file.vcf.gz"; } } - test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools concat $args{args} $files | grep -v ^##bcftools_"); + test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools concat --no-version $args{args} $files"); test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools concat -Ob $args{args} $files | $$opts{bin}/bcftools view | grep -v ^##bcftools_"); } sub test_vcf_reheader { my ($opts,%args) = @_; - cmd("$$opts{bin}/bcftools view -Ob $$opts{path}/$args{in}.vcf > $$opts{tmp}/$args{in}.bcf"); - cmd("$$opts{bin}/bcftools view -Oz $$opts{path}/$args{in}.vcf > $$opts{tmp}/$args{in}.vcf.gz"); + cmd("$$opts{bin}/bcftools view --no-version -Ob $$opts{path}/$args{in}.vcf > $$opts{tmp}/$args{in}.bcf"); + cmd("$$opts{bin}/bcftools view --no-version -Oz $$opts{path}/$args{in}.vcf > $$opts{tmp}/$args{in}.vcf.gz"); my $arg = exists($args{header}) ? "-h $$opts{path}/$args{header}" : "-s $$opts{path}/$args{samples}"; for my $file ("$$opts{path}/$args{in}.vcf","$$opts{tmp}/$args{in}.bcf","$$opts{tmp}/$args{in}.vcf.gz") @@ -806,8 +806,8 @@ sub test_vcf_reheader # bcf header lines can come in different order my %bcf_args = (); if ( $file=~/\.bcf$/ && -e "$$opts{path}/$args{out}.bcf" ) { %bcf_args = ( out=>"$args{out}.bcf" ); } - test_cmd($opts,%args,%bcf_args,cmd=>"$$opts{bin}/bcftools reheader $arg $file | $$opts{bin}/bcftools view | grep -v ^##bcftools_"); - test_cmd($opts,%args,%bcf_args,cmd=>"cat $file | $$opts{bin}/bcftools reheader $arg | $$opts{bin}/bcftools view | grep -v ^##bcftools_"); + test_cmd($opts,%args,%bcf_args,cmd=>"$$opts{bin}/bcftools reheader $arg $file | $$opts{bin}/bcftools view --no-version"); + test_cmd($opts,%args,%bcf_args,cmd=>"cat $file | $$opts{bin}/bcftools reheader $arg | $$opts{bin}/bcftools view --no-version"); } } sub test_rename_chrs diff --git a/vcfannotate.c b/vcfannotate.c index fe09f9f7b..8e9ba3a42 100644 --- a/vcfannotate.c +++ b/vcfannotate.c @@ -120,7 +120,7 @@ typedef struct _args_t char **argv, *output_fname, *targets_fname, *regions_list, *header_fname; char *remove_annots, *columns, *rename_chrs, *sample_names, *mark_sites; - int argc, drop_header, tgts_is_vcf, mark_sites_logic; + int argc, drop_header, record_cmd_line, tgts_is_vcf, mark_sites_logic; } args_t; @@ -1557,7 +1557,7 @@ static void init_data(args_t *args) args->mark_sites,args->mark_sites_logic==MARK_LISTED?"":"not ",args->mark_sites); } - bcf_hdr_append_version(args->hdr_out, args->argc, args->argv, "bcftools_annotate"); + if (args->record_cmd_line) bcf_hdr_append_version(args->hdr_out, args->argc, args->argv, "bcftools_annotate"); if ( !args->drop_header ) { if ( args->rename_chrs ) rename_chrs(args, args->rename_chrs); @@ -1767,6 +1767,7 @@ static void usage(args_t *args) fprintf(stderr, " -I, --set-id [+] set ID column, see man pagee for details\n"); fprintf(stderr, " -i, --include select sites for which the expression is true (see man pagee for details)\n"); fprintf(stderr, " -m, --mark-sites [+-] add INFO/tag flag to sites which are (\"+\") or are not (\"-\") listed in the -a file\n"); + fprintf(stderr, " --no-version do not append version and command line to the header\n"); fprintf(stderr, " -o, --output write output to a file [standard output]\n"); fprintf(stderr, " -O, --output-type b: compressed BCF, u: uncompressed BCF, z: compressed VCF, v: uncompressed VCF [v]\n"); fprintf(stderr, " -r, --regions restrict to comma-separated list of regions\n"); @@ -1789,6 +1790,7 @@ int main_vcfannotate(int argc, char *argv[]) args->output_fname = "-"; args->output_type = FT_VCF; args->n_threads = 0; + args->record_cmd_line = 1; args->ref_idx = args->alt_idx = args->chr_idx = args->from_idx = args->to_idx = -1; args->set_ids_replace = 1; int regions_is_file = 0; @@ -1811,6 +1813,7 @@ int main_vcfannotate(int argc, char *argv[]) {"header-lines",required_argument,NULL,'h'}, {"samples",required_argument,NULL,'s'}, {"samples-file",required_argument,NULL,'S'}, + {"no-version",no_argument,NULL,8}, {NULL,0,NULL,0} }; while ((c = getopt_long(argc, argv, "h:?o:O:r:R:a:x:c:i:e:S:s:I:m:",loptions,NULL)) >= 0) @@ -1845,6 +1848,7 @@ int main_vcfannotate(int argc, char *argv[]) case 'h': args->header_fname = optarg; break; case 1 : args->rename_chrs = optarg; break; case 9 : args->n_threads = strtol(optarg, 0, 0); break; + case 8 : args->record_cmd_line = 0; break; case '?': usage(args); break; default: error("Unknown argument: %s\n", optarg); } diff --git a/vcfcall.c b/vcfcall.c index 0755e6742..d4a19d99e 100644 --- a/vcfcall.c +++ b/vcfcall.c @@ -68,7 +68,7 @@ void error(const char *format, ...); typedef struct { int flag; // combination of CF_* flags above - int output_type, n_threads; + int output_type, n_threads, record_cmd_line; htsFile *bcf_in, *out_fh; char *bcf_fname, *output_fname; char **samples; // for subsampling and ploidy @@ -459,7 +459,7 @@ static void init_data(args_t *args) bcf_hdr_remove(args->aux.hdr, BCF_HL_INFO, "QS"); bcf_hdr_remove(args->aux.hdr, BCF_HL_INFO, "I16"); - bcf_hdr_append_version(args->aux.hdr, args->argc, args->argv, "bcftools_call"); + if (args->record_cmd_line) bcf_hdr_append_version(args->aux.hdr, args->argc, args->argv, "bcftools_call"); bcf_hdr_write(args->out_fh, args->aux.hdr); if ( args->flag&CF_INS_MISSED ) init_missed_line(args); @@ -602,6 +602,7 @@ static void usage(args_t *args) fprintf(stderr, "Usage: bcftools call [options] \n"); fprintf(stderr, "\n"); fprintf(stderr, "File format options:\n"); + fprintf(stderr, " --no-version do not append version and command line to the header\n"); fprintf(stderr, " -o, --output write output to a file [standard output]\n"); fprintf(stderr, " -O, --output-type output type: 'b' compressed BCF; 'u' uncompressed BCF; 'z' compressed VCF; 'v' uncompressed VCF [v]\n"); fprintf(stderr, " --ploidy [?] predefined ploidy, 'list' to print available settings, append '?' for details\n"); @@ -657,6 +658,7 @@ int main_vcfcall(int argc, char *argv[]) args.output_fname = "-"; args.output_type = FT_VCF; args.n_threads = 0; + args.record_cmd_line = 1; args.aux.trio_Pm_SNPs = 1 - 1e-8; args.aux.trio_Pm_ins = args.aux.trio_Pm_del = 1 - 1e-9; @@ -691,6 +693,7 @@ int main_vcfcall(int argc, char *argv[]) {"ploidy-file",required_argument,NULL,2}, {"chromosome-X",no_argument,NULL,'X'}, {"chromosome-Y",no_argument,NULL,'Y'}, + {"no-version",no_argument,NULL,8}, {NULL,0,NULL,0} }; @@ -750,6 +753,7 @@ int main_vcfcall(int argc, char *argv[]) case 's': args.samples_fname = optarg; break; case 'S': args.samples_fname = optarg; args.samples_is_file = 1; break; case 9 : args.n_threads = strtol(optarg, 0, 0); break; + case 8 : args.record_cmd_line = 0; break; default: usage(&args); } } diff --git a/vcfconcat.c b/vcfconcat.c index 8cc177b33..32421378c 100644 --- a/vcfconcat.c +++ b/vcfconcat.c @@ -39,7 +39,7 @@ typedef struct _args_t { bcf_srs_t *files; htsFile *out_fh; - int output_type, n_threads; + int output_type, n_threads, record_cmd_line; bcf_hdr_t *out_hdr; int *seen_seq; @@ -108,7 +108,7 @@ static void init_data(args_t *args) bcf_hdr_append(args->out_hdr,"##FORMAT="); bcf_hdr_append(args->out_hdr,"##FORMAT="); } - bcf_hdr_append_version(args->out_hdr, args->argc, args->argv, "bcftools_concat"); + if (args->record_cmd_line) bcf_hdr_append_version(args->out_hdr, args->argc, args->argv, "bcftools_concat"); args->out_fh = hts_open(args->output_fname,hts_bcf_wmode(args->output_type)); if ( args->out_fh == NULL ) error("Can't write to \"%s\": %s\n", args->output_fname, strerror(errno)); if ( args->n_threads ) hts_set_threads(args->out_fh, args->n_threads); @@ -677,6 +677,7 @@ static void usage(args_t *args) fprintf(stderr, " -D, --remove-duplicates Alias for -d none\n"); fprintf(stderr, " -f, --file-list Read the list of files from a file.\n"); fprintf(stderr, " -l, --ligate Ligate phased VCFs by matching phase at overlapping haplotypes\n"); + fprintf(stderr, " --no-version do not append version and command line to the header\n"); fprintf(stderr, " -n, --naive Concatenate BCF files without recompression (dangerous, use with caution)\n"); fprintf(stderr, " -o, --output Write output to a file [standard output]\n"); fprintf(stderr, " -O, --output-type b: compressed BCF, u: uncompressed BCF, z: compressed VCF, v: uncompressed VCF [v]\n"); @@ -696,6 +697,7 @@ int main_vcfconcat(int argc, char *argv[]) args->output_fname = "-"; args->output_type = FT_VCF; args->n_threads = 0; + args->record_cmd_line = 1; args->min_PQ = 30; static struct option loptions[] = @@ -713,6 +715,7 @@ int main_vcfconcat(int argc, char *argv[]) {"threads",required_argument,NULL,9}, {"file-list",required_argument,NULL,'f'}, {"min-PQ",required_argument,NULL,'q'}, + {"no-version",no_argument,NULL,8}, {NULL,0,NULL,0} }; char *tmp; @@ -743,6 +746,7 @@ int main_vcfconcat(int argc, char *argv[]) }; break; case 9 : args->n_threads = strtol(optarg, 0, 0); break; + case 8 : args->record_cmd_line = 0; break; case 'h': case '?': usage(args); break; default: error("Unknown argument: %s\n", optarg); diff --git a/vcfconvert.c b/vcfconvert.c index 26166dfad..94e90e88f 100644 --- a/vcfconvert.c +++ b/vcfconvert.c @@ -66,7 +66,7 @@ struct _args_t int nsamples, *samples, sample_is_file, targets_is_file, regions_is_file, output_type; char **argv, *sample_list, *targets_list, *regions_list, *tag, *columns; char *outfname, *infname, *ref_fname; - int argc, n_threads; + int argc, n_threads, record_cmd_line; }; static void destroy_data(args_t *args) @@ -369,7 +369,7 @@ static void gensample_to_vcf(args_t *args) bcf_hdr_append(args->header, "##FORMAT="); bcf_hdr_append(args->header, "##FORMAT="); bcf_hdr_printf(args->header, "##contig=", args->str.s,0x7fffffff); // MAX_CSI_COOR - bcf_hdr_append_version(args->header, args->argc, args->argv, "bcftools_convert"); + if (args->record_cmd_line) bcf_hdr_append_version(args->header, args->argc, args->argv, "bcftools_convert"); int i, nsamples; char **samples = hts_readlist(sample_fname, 1, &nsamples); @@ -489,7 +489,7 @@ static void haplegendsample_to_vcf(args_t *args) bcf_hdr_append(args->header, "##INFO="); bcf_hdr_append(args->header, "##FORMAT="); bcf_hdr_printf(args->header, "##contig=", args->str.s,0x7fffffff); // MAX_CSI_COOR - bcf_hdr_append_version(args->header, args->argc, args->argv, "bcftools_convert"); + if (args->record_cmd_line) bcf_hdr_append_version(args->header, args->argc, args->argv, "bcftools_convert"); int i, nrows, nsamples; char **samples = hts_readlist(sample_fname, 1, &nrows); @@ -606,7 +606,7 @@ static void hapsample_to_vcf(args_t *args) bcf_hdr_append(args->header, "##INFO="); bcf_hdr_append(args->header, "##FORMAT="); bcf_hdr_printf(args->header, "##contig=", args->str.s,0x7fffffff); // MAX_CSI_COOR - bcf_hdr_append_version(args->header, args->argc, args->argv, "bcftools_convert"); + if (args->record_cmd_line) bcf_hdr_append_version(args->header, args->argc, args->argv, "bcftools_convert"); int i, nsamples; char **samples = hts_readlist(sample_fname, 1, &nsamples); @@ -1143,7 +1143,7 @@ static void tsv_to_vcf(args_t *args) args->header = bcf_hdr_init("w"); bcf_hdr_set_chrs(args->header, args->ref); bcf_hdr_append(args->header, "##FORMAT="); - bcf_hdr_append_version(args->header, args->argc, args->argv, "bcftools_convert"); + if (args->record_cmd_line) bcf_hdr_append_version(args->header, args->argc, args->argv, "bcftools_convert"); int i, n; char **smpls = hts_readlist(args->sample_list, args->sample_is_file, &n); @@ -1241,7 +1241,7 @@ static void gvcf_to_vcf(args_t *args) if ( args->n_threads ) hts_set_threads(out_fh, args->n_threads); bcf_hdr_t *hdr = bcf_sr_get_header(args->files,0); - bcf_hdr_append_version(hdr, args->argc, args->argv, "bcftools_convert"); + if (args->record_cmd_line) bcf_hdr_append_version(hdr, args->argc, args->argv, "bcftools_convert"); bcf_hdr_write(out_fh,hdr); int32_t *itmp = NULL, nitmp = 0; @@ -1304,11 +1304,12 @@ static void usage(void) fprintf(stderr, " -S, --samples-file file of samples to include\n"); fprintf(stderr, " -t, --targets similar to -r but streams rather than index-jumps\n"); fprintf(stderr, " -T, --targets-file similar to -R but streams rather than index-jumps\n"); - fprintf(stderr, " --threads number of extra output compression threads [0]\n"); fprintf(stderr, "\n"); fprintf(stderr, "VCF output options:\n"); + fprintf(stderr, " --no-version do not append version and command line to the header\n"); fprintf(stderr, " -o, --output output file name [stdout]\n"); fprintf(stderr, " -O, --output-type b: compressed BCF, u: uncompressed BCF, z: compressed VCF, v: uncompressed VCF [v]\n"); + fprintf(stderr, " --threads number of extra output compression threads [0]\n"); fprintf(stderr, "\n"); fprintf(stderr, "GEN/SAMPLE conversion (input/output from IMPUTE2):\n"); fprintf(stderr, " -G, --gensample2vcf <...> |,\n"); @@ -1359,6 +1360,7 @@ int main_vcfconvert(int argc, char *argv[]) args->outfname = "-"; args->output_type = FT_VCF; args->n_threads = 0; + args->record_cmd_line = 1; static struct option loptions[] = { @@ -1387,6 +1389,7 @@ int main_vcfconvert(int argc, char *argv[]) {"haplegendsample2vcf",required_argument,NULL,'H'}, {"columns",required_argument,NULL,'c'}, {"fasta-ref",required_argument,NULL,'f'}, + {"no-version",no_argument,NULL,10}, {NULL,0,NULL,0} }; while ((c = getopt_long(argc, argv, "?h:r:R:s:S:t:T:i:e:g:G:o:O:c:f:H:",loptions,NULL)) >= 0) { @@ -1424,6 +1427,7 @@ int main_vcfconvert(int argc, char *argv[]) break; case 'h': args->convert_func = vcf_to_haplegendsample; args->outfname = optarg; break; case 9 : args->n_threads = strtol(optarg, 0, 0); break; + case 10 : args->record_cmd_line = 0; break; case '?': usage(); default: error("Unknown argument: %s\n", optarg); } diff --git a/vcffilter.c b/vcffilter.c index ac4c3a32e..f979d77f3 100644 --- a/vcffilter.c +++ b/vcffilter.c @@ -71,7 +71,7 @@ typedef struct _args_t int output_type, n_threads; char **argv, *output_fname, *targets_list, *regions_list; - int argc; + int argc, record_cmd_line; } args_t; @@ -149,7 +149,7 @@ static void init_data(args_t *args) } } - bcf_hdr_append_version(args->hdr, args->argc, args->argv, "bcftools_filter"); + if (args->record_cmd_line) bcf_hdr_append_version(args->hdr, args->argc, args->argv, "bcftools_filter"); if ( args->filter_str ) args->filter = filter_init(args->hdr, args->filter_str); @@ -408,6 +408,7 @@ static void usage(args_t *args) fprintf(stderr, " -G, --IndelGap filter clusters of indels separated by or fewer base pairs allowing only one to pass\n"); fprintf(stderr, " -i, --include include only sites for which the expression is true (see man page for details\n"); fprintf(stderr, " -m, --mode [+x] \"+\": do not replace but add to existing FILTER; \"x\": reset filters at sites which pass\n"); + fprintf(stderr, " --no-version do not append version and command line to the header\n"); fprintf(stderr, " -o, --output write output to a file [standard output]\n"); fprintf(stderr, " -O, --output-type b: compressed BCF, u: uncompressed BCF, z: compressed VCF, v: uncompressed VCF [v]\n"); fprintf(stderr, " -r, --regions restrict to comma-separated list of regions\n"); @@ -430,6 +431,7 @@ int main_vcffilter(int argc, char *argv[]) args->output_fname = "-"; args->output_type = FT_VCF; args->n_threads = 0; + args->record_cmd_line = 1; int regions_is_file = 0, targets_is_file = 0; static struct option loptions[] = @@ -448,6 +450,7 @@ int main_vcffilter(int argc, char *argv[]) {"threads",required_argument,NULL,9}, {"SnpGap",required_argument,NULL,'g'}, {"IndelGap",required_argument,NULL,'G'}, + {"no-version",no_argument,NULL,8}, {NULL,0,NULL,0} }; char *tmp; @@ -488,6 +491,7 @@ int main_vcffilter(int argc, char *argv[]) else error("The argument to -S not recognised: %s\n", optarg); break; case 9 : args->n_threads = strtol(optarg, 0, 0); break; + case 8 : args->record_cmd_line = 0; break; case 'h': case '?': usage(args); default: error("Unknown argument: %s\n", optarg); diff --git a/vcfisec.c b/vcfisec.c index 611514685..9afe62009 100644 --- a/vcfisec.c +++ b/vcfisec.c @@ -58,7 +58,7 @@ typedef struct htsFile **fh_out; char **argv, *prefix, *output_fname, **fnames, *write_files, *targets_list, *regions_list; char *isec_exact; - int argc; + int argc, record_cmd_line; } args_t; @@ -143,7 +143,7 @@ void isec_vcf(args_t *args) out_fh = hts_open(args->output_fname? args->output_fname : "-",hts_bcf_wmode(args->output_type)); if ( out_fh == NULL ) error("Can't write to %s: %s\n", args->output_fname? args->output_fname : "standard output", strerror(errno)); if ( args->n_threads ) hts_set_threads(out_fh, args->n_threads); - bcf_hdr_append_version(files->readers[args->iwrite].header,args->argc,args->argv,"bcftools_isec"); + if (args->record_cmd_line) bcf_hdr_append_version(files->readers[args->iwrite].header,args->argc,args->argv,"bcftools_isec"); bcf_hdr_write(out_fh, files->readers[args->iwrite].header); } if ( !args->nwrite && !out_std && !args->prefix ) @@ -351,7 +351,7 @@ static void init_data(args_t *args) args->fh_out[i] = hts_open(args->fnames[i], hts_bcf_wmode(args->output_type)); \ if ( !args->fh_out[i] ) error("Could not open %s\n", args->fnames[i]); \ if ( args->n_threads ) hts_set_threads(args->fh_out[i], args->n_threads); \ - bcf_hdr_append_version(args->files->readers[j].header,args->argc,args->argv,"bcftools_isec"); \ + if (args->record_cmd_line) bcf_hdr_append_version(args->files->readers[j].header,args->argc,args->argv,"bcftools_isec"); \ bcf_hdr_write(args->fh_out[i], args->files->readers[j].header); \ } if ( !args->nwrite || args->write[0] ) @@ -456,6 +456,7 @@ static void usage(void) fprintf(stderr, " -e, --exclude exclude sites for which the expression is true\n"); fprintf(stderr, " -f, --apply-filters require at least one of the listed FILTER strings (e.g. \"PASS,.\")\n"); fprintf(stderr, " -i, --include include only sites for which the expression is true\n"); + fprintf(stderr, " --no-version do not append version and command line to the header\n"); fprintf(stderr, " -n, --nfiles [+-=~] output positions present in this many (=), this many or more (+), this many or fewer (-), the exact (~) files\n"); fprintf(stderr, " -o, --output write output to a file [standard output]\n"); fprintf(stderr, " -O, --output-type b: compressed BCF, u: uncompressed BCF, z: compressed VCF, v: uncompressed VCF [v]\n"); @@ -464,8 +465,8 @@ static void usage(void) fprintf(stderr, " -R, --regions-file restrict to regions listed in a file\n"); fprintf(stderr, " -t, --targets similar to -r but streams rather than index-jumps\n"); fprintf(stderr, " -T, --targets-file similar to -R but streams rather than index-jumps\n"); - fprintf(stderr, " -w, --write list of files to write with -p given as 1-based indexes. By default, all files are written\n"); fprintf(stderr, " --threads number of extra output compression threads [0]\n"); + fprintf(stderr, " -w, --write list of files to write with -p given as 1-based indexes. By default, all files are written\n"); fprintf(stderr, "\n"); fprintf(stderr, "Examples:\n"); fprintf(stderr, " # Create intersection and complements of two sets saving the output in dir/*\n"); @@ -492,6 +493,7 @@ int main_vcfisec(int argc, char *argv[]) args->output_fname = NULL; args->output_type = FT_VCF; args->n_threads = 0; + args->record_cmd_line = 1; int targets_is_file = 0, regions_is_file = 0; static struct option loptions[] = @@ -512,6 +514,7 @@ int main_vcfisec(int argc, char *argv[]) {"output",required_argument,NULL,'o'}, {"output-type",required_argument,NULL,'O'}, {"threads",required_argument,NULL,9}, + {"no-version",no_argument,NULL,8}, {NULL,0,NULL,0} }; while ((c = getopt_long(argc, argv, "hc:r:R:p:n:w:t:T:Cf:o:O:i:e:",loptions,NULL)) >= 0) { @@ -560,6 +563,7 @@ int main_vcfisec(int argc, char *argv[]) } break; case 9 : args->n_threads = strtol(optarg, 0, 0); break; + case 8 : args->record_cmd_line = 0; break; case 'h': case '?': usage(); default: error("Unknown argument: %s\n", optarg); diff --git a/vcfmerge.c b/vcfmerge.c index 0517bd56c..3ab1f51ea 100644 --- a/vcfmerge.c +++ b/vcfmerge.c @@ -118,7 +118,7 @@ typedef struct htsFile *out_fh; bcf_hdr_t *out_hdr; char **argv; - int argc, n_threads; + int argc, n_threads, record_cmd_line; } args_t; @@ -1913,7 +1913,7 @@ void merge_vcf(args_t *args) char buf[10]; snprintf(buf,10,"%d",i+1); merge_headers(args->out_hdr, args->files->readers[i].header,buf,args->force_samples); } - bcf_hdr_append_version(args->out_hdr, args->argc, args->argv, "bcftools_merge"); + if (args->record_cmd_line) bcf_hdr_append_version(args->out_hdr, args->argc, args->argv, "bcftools_merge"); bcf_hdr_sync(args->out_hdr); } info_rules_init(args); @@ -1962,6 +1962,7 @@ static void usage(void) fprintf(stderr, " -i, --info-rules rules for merging INFO fields (method is one of sum,avg,min,max,join) or \"-\" to turn off the default [DP:sum,DP4:sum]\n"); fprintf(stderr, " -l, --file-list read file names from the file\n"); fprintf(stderr, " -m, --merge allow multiallelic records for , see man page for details [both]\n"); + fprintf(stderr, " --no-version do not append version and command line to the header\n"); fprintf(stderr, " -o, --output write output to a file [standard output]\n"); fprintf(stderr, " -O, --output-type 'b' compressed BCF; 'u' uncompressed BCF; 'z' compressed VCF; 'v' uncompressed VCF [v]\n"); fprintf(stderr, " -r, --regions restrict to comma-separated list of regions\n"); @@ -1980,6 +1981,7 @@ int main_vcfmerge(int argc, char *argv[]) args->output_fname = "-"; args->output_type = FT_VCF; args->n_threads = 0; + args->record_cmd_line = 1; args->collapse = COLLAPSE_BOTH; int regions_is_file = 0; @@ -1998,6 +2000,7 @@ int main_vcfmerge(int argc, char *argv[]) {"regions",required_argument,NULL,'r'}, {"regions-file",required_argument,NULL,'R'}, {"info-rules",required_argument,NULL,'i'}, + {"no-version",no_argument,NULL,8}, {NULL,0,NULL,0} }; while ((c = getopt_long(argc, argv, "hm:f:r:R:o:O:i:l:",loptions,NULL)) >= 0) { @@ -2032,6 +2035,7 @@ int main_vcfmerge(int argc, char *argv[]) case 2 : args->header_only = 1; break; case 3 : args->force_samples = 1; break; case 9 : args->n_threads = strtol(optarg, 0, 0); break; + case 8 : args->record_cmd_line = 0; break; case 'h': case '?': usage(); default: error("Unknown argument: %s\n", optarg); diff --git a/vcfnorm.c b/vcfnorm.c index a59854ae0..f473fe158 100644 --- a/vcfnorm.c +++ b/vcfnorm.c @@ -76,6 +76,7 @@ typedef struct char **argv, *output_fname, *ref_fname, *vcf_fname, *region, *targets; int argc, rmdup, output_type, n_threads, check_ref, strict_filter, do_indels; int nchanged, nskipped, nsplit, ntotal, mrows_op, mrows_collapse, parsimonious; + int record_cmd_line; } args_t; @@ -1581,7 +1582,7 @@ static void normalize_vcf(args_t *args) htsFile *out = hts_open(args->output_fname, hts_bcf_wmode(args->output_type)); if ( out == NULL ) error("Can't write to \"%s\": %s\n", args->output_fname, strerror(errno)); if ( args->n_threads ) hts_set_threads(out, args->n_threads); - bcf_hdr_append_version(args->hdr, args->argc, args->argv, "bcftools_norm"); + if (args->record_cmd_line) bcf_hdr_append_version(args->hdr, args->argc, args->argv, "bcftools_norm"); bcf_hdr_write(out, args->hdr); int prev_rid = -1, prev_pos = -1, prev_type = 0; @@ -1665,6 +1666,7 @@ static void usage(void) fprintf(stderr, " -d, --rm-dup remove duplicate snps|indels|both|any\n"); fprintf(stderr, " -f, --fasta-ref reference sequence\n"); fprintf(stderr, " -m, --multiallelics <-|+>[type] split multiallelics (-) or join biallelics (+), type: snps|indels|both|any [both]\n"); + fprintf(stderr, " --no-version do not append version and command line to the header\n"); fprintf(stderr, " -N, --do-not-normalize do not normalize indels (with -m or -c s)\n"); fprintf(stderr, " -o, --output write output to a file [standard output]\n"); fprintf(stderr, " -O, --output-type 'b' compressed BCF; 'u' uncompressed BCF; 'z' compressed VCF; 'v' uncompressed VCF [v]\n"); @@ -1673,8 +1675,8 @@ static void usage(void) fprintf(stderr, " -s, --strict-filter when merging (-m+), merged site is PASS only if all sites being merged PASS\n"); fprintf(stderr, " -t, --targets similar to -r but streams rather than index-jumps\n"); fprintf(stderr, " -T, --targets-file similar to -R but streams rather than index-jumps\n"); - fprintf(stderr, " -w, --site-win buffer for sorting lines which changed position during realignment [1000]\n"); fprintf(stderr, " --threads number of extra output compression threads [0]\n"); + fprintf(stderr, " -w, --site-win buffer for sorting lines which changed position during realignment [1000]\n"); fprintf(stderr, "\n"); exit(1); } @@ -1688,6 +1690,7 @@ int main_vcfnorm(int argc, char *argv[]) args->output_fname = "-"; args->output_type = FT_VCF; args->n_threads = 0; + args->record_cmd_line = 1; args->aln_win = 100; args->buf_win = 1000; args->mrows_collapse = COLLAPSE_BOTH; @@ -1713,6 +1716,7 @@ int main_vcfnorm(int argc, char *argv[]) {"threads",required_argument,NULL,9}, {"check-ref",required_argument,NULL,'c'}, {"strict-filter",no_argument,NULL,'s'}, + {"no-version",no_argument,NULL,8}, {NULL,0,NULL,0} }; char *tmp; @@ -1770,6 +1774,7 @@ int main_vcfnorm(int argc, char *argv[]) if ( *tmp ) error("Could not parse argument: --site-win %s\n", optarg); break; case 9 : args->n_threads = strtol(optarg, 0, 0); break; + case 8 : args->record_cmd_line = 0; break; case 'h': case '?': usage(); default: error("Unknown argument: %s\n", optarg); diff --git a/vcfplugin.c b/vcfplugin.c index ad73734bb..87a773f50 100644 --- a/vcfplugin.c +++ b/vcfplugin.c @@ -140,7 +140,7 @@ typedef struct _args_t char **plugin_paths; char **argv, *output_fname, *regions_list, *targets_list; - int argc, drop_header, verbose; + int argc, drop_header, verbose, record_cmd_line; } args_t; @@ -411,7 +411,7 @@ static void init_data(args_t *args) if ( args->filter_str ) args->filter = filter_init(args->hdr, args->filter_str); - bcf_hdr_append_version(args->hdr_out, args->argc, args->argv, "bcftools_plugin"); + if (args->record_cmd_line) bcf_hdr_append_version(args->hdr_out, args->argc, args->argv, "bcftools_plugin"); if ( !args->drop_header ) { args->out_fh = hts_open(args->output_fname,hts_bcf_wmode(args->output_type)); @@ -453,6 +453,7 @@ static void usage(args_t *args) fprintf(stderr, " -t, --targets similar to -r but streams rather than index-jumps\n"); fprintf(stderr, " -T, --targets-file similar to -R but streams rather than index-jumps\n"); fprintf(stderr, "VCF output options:\n"); + fprintf(stderr, " --no-version do not append version and command line to the header\n"); fprintf(stderr, " -o, --output write output to a file [standard output]\n"); fprintf(stderr, " -O, --output-type 'b' compressed BCF; 'u' uncompressed BCF; 'z' compressed VCF; 'v' uncompressed VCF [v]\n"); fprintf(stderr, " --threads number of extra output compression threads [0]\n"); @@ -473,6 +474,7 @@ int main_plugin(int argc, char *argv[]) args->output_fname = "-"; args->output_type = FT_VCF; args->n_threads = 0; + args->record_cmd_line = 1; args->nplugin_paths = -1; int regions_is_file = 0, targets_is_file = 0, plist_only = 0, usage_only = 0, version_only = 0; @@ -509,6 +511,7 @@ int main_plugin(int argc, char *argv[]) {"regions-file",required_argument,NULL,'R'}, {"targets",required_argument,NULL,'t'}, {"targets-file",required_argument,NULL,'T'}, + {"no-version",no_argument,NULL,8}, {NULL,0,NULL,0} }; while ((c = getopt_long(argc, argv, "h?o:O:r:R:t:T:li:e:vV",loptions,NULL)) >= 0) @@ -534,6 +537,7 @@ int main_plugin(int argc, char *argv[]) case 'T': args->targets_list = optarg; targets_is_file = 1; break; case 'l': plist_only = 1; break; case 9 : args->n_threads = strtol(optarg, 0, 0); break; + case 8 : args->record_cmd_line = 0; break; case '?': case 'h': usage_only = 1; break; default: error("Unknown argument: %s\n", optarg); diff --git a/vcfview.c b/vcfview.c index ed415950b..c14075d63 100644 --- a/vcfview.c +++ b/vcfview.c @@ -72,6 +72,7 @@ typedef struct _args_t int sample_is_file, force_samples; char *include_types, *exclude_types; int include, exclude; + int record_cmd_line; htsFile *out; } args_t; @@ -86,7 +87,8 @@ static void init_data(args_t *args) bcf_hdr_append(args->hdr,"##INFO="); bcf_hdr_append(args->hdr,"##INFO="); } - bcf_hdr_append_version(args->hdr, args->argc, args->argv, "bcftools_view"); + if (args->record_cmd_line) bcf_hdr_append_version(args->hdr, args->argc, args->argv, "bcftools_view"); + else bcf_hdr_sync(args->hdr); // setup sample data if (args->sample_names) @@ -485,6 +487,7 @@ static void usage(args_t *args) fprintf(stderr, " -G, --drop-genotypes drop individual genotype information (after subsetting if -s option set)\n"); fprintf(stderr, " -h/H, --header-only/--no-header print the header only/suppress the header in VCF output\n"); fprintf(stderr, " -l, --compression-level [0-9] compression level: 0 uncompressed, 1 best speed, 9 best compression [%d]\n", args->clevel); + fprintf(stderr, " --no-version do not append version and command line to the header\n"); fprintf(stderr, " -o, --output-file output file name [stdout]\n"); fprintf(stderr, " -O, --output-type b: compressed BCF, u: uncompressed BCF, z: compressed VCF, v: uncompressed VCF [v]\n"); fprintf(stderr, " -r, --regions restrict to comma-separated list of regions\n"); @@ -529,6 +532,7 @@ int main_vcfview(int argc, char *argv[]) args->update_info = 1; args->output_type = FT_VCF; args->n_threads = 0; + args->record_cmd_line = 1; int targets_is_file = 0, regions_is_file = 0; static struct option loptions[] = @@ -569,6 +573,7 @@ int main_vcfview(int argc, char *argv[]) {"max-af",required_argument,NULL,'Q'}, {"phased",no_argument,NULL,'p'}, {"exclude-phased",no_argument,NULL,'P'}, + {"no-version",no_argument,NULL,8}, {NULL,0,NULL,0} }; char *tmp; @@ -678,6 +683,7 @@ int main_vcfview(int argc, char *argv[]) break; } case 9 : args->n_threads = strtol(optarg, 0, 0); break; + case 8 : args->record_cmd_line = 0; break; case '?': usage(args); default: error("Unknown argument: %s\n", optarg); } From e0890a1c47d0e8608b5f35e67a0ef4e3a1590baa Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Fri, 22 Jan 2016 16:21:52 +0000 Subject: [PATCH 141/211] reheader: allow empty body with vcf.gz. Fixes #356 --- reheader.c | 10 ++++++---- test/reheader.empty.hdr | 7 +++++++ test/reheader.empty.out | 8 ++++++++ test/test.pl | 1 + 4 files changed, 22 insertions(+), 4 deletions(-) create mode 100644 test/reheader.empty.hdr create mode 100644 test/reheader.empty.out diff --git a/reheader.c b/reheader.c index 73123f942..7248cbb4b 100644 --- a/reheader.c +++ b/reheader.c @@ -203,7 +203,8 @@ static void reheader_vcf_gz(args_t *args) if ( skip_until>=fp->block_length ) { kputsn(buffer,skip_until,&hdr); - if ( bgzf_read_block(fp) != 0 || !fp->block_length ) error("FIXME: No body in the file: %s\n", args->fname); + if ( bgzf_read_block(fp) != 0 ) error("Error reading %s\n", args->fname); + if ( !fp->block_length ) break; skip_until = 0; } // The header has finished @@ -217,7 +218,8 @@ static void reheader_vcf_gz(args_t *args) if ( skip_until>=fp->block_length ) { kputsn(buffer,fp->block_length,&hdr); - if (bgzf_read_block(fp) != 0 || !fp->block_length) error("FIXME: No body in the file: %s\n", args->fname); + if ( bgzf_read_block(fp) != 0 ) error("Error reading %s\n", args->fname); + if ( !fp->block_length ) break; skip_until = 0; } } @@ -263,8 +265,8 @@ static void reheader_vcf_gz(args_t *args) int count = bgzf_raw_write(bgzf_out, buf, nread); if (count != nread) error("Write failed, wrote %d instead of %d bytes.\n", count,(int)nread); } - if (bgzf_close(bgzf_out) < 0) error("Error: %d\n",bgzf_out->errcode); - if (bgzf_close(fp) < 0) error("Error: %d\n",fp->errcode); + if (bgzf_close(bgzf_out) < 0) error("Error closing %s: %d\n",args->output_fname ? args->output_fname : "-",bgzf_out->errcode); + if (hts_close(args->fp)) error("Error closing %s: %d\n",args->fname,fp->errcode); free(buf); } static void reheader_vcf(args_t *args) diff --git a/test/reheader.empty.hdr b/test/reheader.empty.hdr new file mode 100644 index 000000000..cd5a018c5 --- /dev/null +++ b/test/reheader.empty.hdr @@ -0,0 +1,7 @@ +##fileformat=VCFv4.1 +##contig= +##contig= +##contig= +##contig= +##contig= +#CHROM POS ID REF ALT QUAL FILTER INFO FORMAT NA00001 NA00002 NA00003 diff --git a/test/reheader.empty.out b/test/reheader.empty.out new file mode 100644 index 000000000..cbc236bf0 --- /dev/null +++ b/test/reheader.empty.out @@ -0,0 +1,8 @@ +##fileformat=VCFv4.1 +##FILTER= +##contig= +##contig= +##contig= +##contig= +##contig= +#CHROM POS ID REF ALT QUAL FILTER INFO FORMAT NA00001 NA00002 NA00003 diff --git a/test/test.pl b/test/test.pl index 48ec9db08..80ecacd9a 100755 --- a/test/test.pl +++ b/test/test.pl @@ -200,6 +200,7 @@ test_vcf_reheader($opts,in=>'reheader',out=>'reheader.2.out',samples=>'reheader.samples2'); test_vcf_reheader($opts,in=>'reheader',out=>'reheader.3.out',samples=>'reheader.samples3'); test_vcf_reheader($opts,in=>'reheader',out=>'reheader.4.out',samples=>'reheader.samples4'); +test_vcf_reheader($opts,in=>'empty',out=>'reheader.empty.out',header=>'reheader.empty.hdr'); test_rename_chrs($opts,in=>'annotate'); test_vcf_convert($opts,in=>'convert',out=>'convert.gs.gt.gen',args=>'-g -,.'); test_vcf_convert($opts,in=>'convert',out=>'convert.gs.gt.samples',args=>'-g .,-'); From 5d252954d950230408781a0627e1ed08e95d9c09 Mon Sep 17 00:00:00 2001 From: John Marshall Date: Mon, 1 Feb 2016 16:02:41 +0000 Subject: [PATCH 142/211] Fix merging of Number=G format strings Format strings appear to be adjacently-placed-in-memory fixed-length (max_len, src_len, etc) optionally-NUL-terminated arrays, i.e., the same sort of variable-up-to-a-fixed-length strings as operated on by strncpy(). In copy_string_field(), don't copy trailing NULs. In merge_format_string(), pad the *output* string with NULs. --- test/norm.merge.out | 2 +- test/norm.merge.strict.out | 2 +- test/norm.merge.vcf | 4 ++-- vcfmerge.c | 2 +- vcfnorm.c | 2 +- 5 files changed, 6 insertions(+), 6 deletions(-) diff --git a/test/norm.merge.out b/test/norm.merge.out index f5b1092ff..449daba01 100644 --- a/test/norm.merge.out +++ b/test/norm.merge.out @@ -36,7 +36,7 @@ 1 105 . TAAACCCTAAA TAA,TAACCCTAAA 999 PASS INDEL;AN=4;AC=2,2;DP=19;ISTR=SomeString;XRF=1e+06,2e+06,500000;XRI=1111,2222,5555;XRS=AAA,BBB,DDD;XAF=1e+06,500000;XAI=1111,5555;XAS=AAA,DDD;XGF=1e+06,2e+06,3e+06,500000,.,9e+09;XGI=1111,2222,3333,5555,.,9999;XGS=A,B,C,E,.,F GT:PL:DP:FRF:FRI:FRS:FAF:FAI:FAS:FGF:FGI:FGS 1/2:1,2,3,4,.,6:1:1e+06,2e+06,500000:1111,2222,5555:AAAA,BBB,CC:1e+06,500000:1111,5555:A,BB:1e+06,2e+06,3e+06,500000,.,9e+09:1111,2222,3333,5555,.,9999:A,BB,CCC,EEEE,.,FFFFF 1/2:1,2,3,4,.,6:1:1e+06,2e+06,500000:1111,2222,5555:AAAA,BBB,CC:1e+06,500000:1111,5555:A,BB:1e+06,2e+06,3e+06,500000,.,9e+09:1111,2222,3333,5555,.,9999:A,BB,CCC,EEEE,.,FFFFF 2 1 . GGGCGTCTCATAGCTGGAGCAATGGCGAGCGCCTGGACAAGGGAGGGGAAGGGGTTCTTATTACTGACGCGGGTAGCCCCTACTGCTGTGTGGTTCCCCTATTTTTTTTTTTTTCTTTTTGAGACGGAGTCTCGCTCTGTCACCCAGGCTGGAGTGCAGTGGCACAATCTCGGCTCACTGCAAGCTCCACCT ACGT 999 PASS INDEL;AN=4;AC=2 GT:DP 1/0:1 1/0:1 2 101 . ATTTTTTTTTTTTT ATTTTTTTTTTTTTTT 999 PASS INDEL;AN=4;AC=4 GT:DP 1/1:1 1/1:1 -2 114 . TC TTCC,TTC 999 FAIL1 INDEL;AN=4;AC=2,2 GT:DP 1/2:1 1/2:1 +2 114 . TC TTCC,TTC 999 FAIL1 INDEL;AN=4;AC=2,2 GT:DP:FGS 1/2:1:A,BB,CCC,EEEE,.,FFFFF 1/2:1:AA,BB,CCC,EEEE,.,FFFFF 2 115 . C T 999 PASS INDEL;AN=4;AC=4 GT:DP 1/1:1 1/1:1 20 3 . GATG CTATG,GACT 999 PASS INDEL;AN=4;AC=2,2 GT 2/1 2/1 20 5 id0001;id0002 TGGG TAC,TG,TGGGG,AC . PASS INDEL;AN=4;AC=2,2,0,0 GT:PL:DP 1/2:1,2,3,4,.,6,7,.,.,10,11,.,.,.,15:1 1/2:1,2,3,4,.,6,7,.,.,10,11,.,.,.,15:1 diff --git a/test/norm.merge.strict.out b/test/norm.merge.strict.out index 1395d2224..92f6f8826 100644 --- a/test/norm.merge.strict.out +++ b/test/norm.merge.strict.out @@ -36,7 +36,7 @@ 1 105 . TAAACCCTAAA TAA,TAACCCTAAA 999 PASS INDEL;AN=4;AC=2,2;DP=19;ISTR=SomeString;XRF=1e+06,2e+06,500000;XRI=1111,2222,5555;XRS=AAA,BBB,DDD;XAF=1e+06,500000;XAI=1111,5555;XAS=AAA,DDD;XGF=1e+06,2e+06,3e+06,500000,.,9e+09;XGI=1111,2222,3333,5555,.,9999;XGS=A,B,C,E,.,F GT:PL:DP:FRF:FRI:FRS:FAF:FAI:FAS:FGF:FGI:FGS 1/2:1,2,3,4,.,6:1:1e+06,2e+06,500000:1111,2222,5555:AAAA,BBB,CC:1e+06,500000:1111,5555:A,BB:1e+06,2e+06,3e+06,500000,.,9e+09:1111,2222,3333,5555,.,9999:A,BB,CCC,EEEE,.,FFFFF 1/2:1,2,3,4,.,6:1:1e+06,2e+06,500000:1111,2222,5555:AAAA,BBB,CC:1e+06,500000:1111,5555:A,BB:1e+06,2e+06,3e+06,500000,.,9e+09:1111,2222,3333,5555,.,9999:A,BB,CCC,EEEE,.,FFFFF 2 1 . GGGCGTCTCATAGCTGGAGCAATGGCGAGCGCCTGGACAAGGGAGGGGAAGGGGTTCTTATTACTGACGCGGGTAGCCCCTACTGCTGTGTGGTTCCCCTATTTTTTTTTTTTTCTTTTTGAGACGGAGTCTCGCTCTGTCACCCAGGCTGGAGTGCAGTGGCACAATCTCGGCTCACTGCAAGCTCCACCT ACGT 999 PASS INDEL;AN=4;AC=2 GT:DP 1/0:1 1/0:1 2 101 . ATTTTTTTTTTTTT ATTTTTTTTTTTTTTT 999 PASS INDEL;AN=4;AC=4 GT:DP 1/1:1 1/1:1 -2 114 . TC TTCC,TTC 999 PASS INDEL;AN=4;AC=2,2 GT:DP 1/2:1 1/2:1 +2 114 . TC TTCC,TTC 999 PASS INDEL;AN=4;AC=2,2 GT:DP:FGS 1/2:1:A,BB,CCC,EEEE,.,FFFFF 1/2:1:AA,BB,CCC,EEEE,.,FFFFF 2 115 . C T 999 PASS INDEL;AN=4;AC=4 GT:DP 1/1:1 1/1:1 20 3 . GATG CTATG,GACT 999 PASS INDEL;AN=4;AC=2,2 GT 2/1 2/1 20 5 id0001;id0002 TGGG TAC,TG,TGGGG,AC . PASS INDEL;AN=4;AC=2,2,0,0 GT:PL:DP 1/2:1,2,3,4,.,6,7,.,.,10,11,.,.,.,15:1 1/2:1,2,3,4,.,6,7,.,.,10,11,.,.,.,15:1 diff --git a/test/norm.merge.vcf b/test/norm.merge.vcf index e89178e78..c702f6d91 100644 --- a/test/norm.merge.vcf +++ b/test/norm.merge.vcf @@ -37,8 +37,8 @@ 1 105 . TAAACCCTAAA TAACCCTAAA 999 PASS INDEL;AN=4;AC=2;DP=19;ISTR=SomeString;XRF=1e+06,500000;XRI=1111,5555;XRS=AAA,DDD;XAF=500000;XAI=5555;XAS=DDD;XGF=1e+06,500000,9e+09;XGI=1111,5555,9999;XGS=A,E,F GT:PL:DP:FRF:FRI:FRS:FAF:FAI:FAS:FGF:FGI:FGS 0/1:1,4,6:1:1e+06,500000:1111,5555:AAAA,CC:500000:5555:BB:1e+06,500000,9e+09:1111,5555,9999:A,EEEE,FFFFF 0/1:1,4,6:1:1e+06,500000:1111,5555:AAAA,CC:500000:5555:BB:1e+06,500000,9e+09:1111,5555,9999:A,EEEE,FFFFF 2 1 . GGGCGTCTCATAGCTGGAGCAATGGCGAGCGCCTGGACAAGGGAGGGGAAGGGGTTCTTATTACTGACGCGGGTAGCCCCTACTGCTGTGTGGTTCCCCTATTTTTTTTTTTTTCTTTTTGAGACGGAGTCTCGCTCTGTCACCCAGGCTGGAGTGCAGTGGCACAATCTCGGCTCACTGCAAGCTCCACCT ACGT 999 PASS INDEL;AN=4;AC=2 GT:DP 1/0:1 1/0:1 2 101 . ATTTTTTTTTTTTT ATTTTTTTTTTTTTTT 999 PASS INDEL;AN=4;AC=4 GT:DP 1/1:1 1/1:1 -2 114 . TC TTCC 999 FAIL1 INDEL;AN=4;AC=2 GT:DP 1/0:1 1/0:1 -2 114 . TC TTC 999 PASS INDEL;AN=4;AC=2 GT:DP 0/1:1 0/1:1 +2 114 . TC TTCC 999 FAIL1 INDEL;AN=4;AC=2 GT:DP:FGS 1/0:1:A,BB,CCC 1/0:1:AA,BB,CCC +2 114 . TC TTC 999 PASS INDEL;AN=4;AC=2 GT:DP:FGS 0/1:1:A,EEEE,FFFFF 0/1:1:AA,EEEE,FFFFF 2 115 . C T 999 PASS INDEL;AN=4;AC=4 GT:DP 1/1:1 1/1:1 20 3 . G CT 999 PASS INDEL;AN=4;AC=2 GT 0/1 0/1 20 3 . GATG GACT 999 PASS INDEL;AN=4;AC=2 GT 1/0 1/0 diff --git a/vcfmerge.c b/vcfmerge.c index 0517bd56c..5b610fba8 100644 --- a/vcfmerge.c +++ b/vcfmerge.c @@ -858,7 +858,7 @@ int copy_string_field(char *src, int isrc, int src_len, kstring_t *dst, int idst } if ( ith_src!=isrc ) return -1; // requested field not found int end_src = start_src; - while ( end_srctmp_str[i]; kputsn(tmp->s,tmp->l,&str); - for (j=tmp->l; jl; jntmp_arr2 = str.m; args->tmp_arr2 = (uint8_t*)str.s; From 4e041a4fd0ff31939333f94ec935d96f32a303e8 Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Wed, 10 Feb 2016 22:05:45 +0000 Subject: [PATCH 143/211] remove some chatter from test suite --- test/test.pl | 50 +++++++++++++++++++----------------- test/view.filter.annovar.vcf | 1 + 2 files changed, 27 insertions(+), 24 deletions(-) diff --git a/test/test.pl b/test/test.pl index 9108fb772..68226c7c2 100755 --- a/test/test.pl +++ b/test/test.pl @@ -1,6 +1,6 @@ #!/usr/bin/env perl # -# Copyright (C) 2012-2015 Genome Research Ltd. +# Copyright (C) 2012-2016 Genome Research Ltd. # # Author: Petr Danecek # @@ -435,8 +435,10 @@ sub test_vcf_idxstats cmd("$$opts{bin}/bcftools view -Oz $$opts{path}/$args{in}.vcf > $$opts{tmp}/$args{in}.vcf.gz"); cmd("$$opts{bin}/bcftools index --tbi -f $$opts{tmp}/$args{in}.vcf.gz"); test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools index $args{args} $$opts{tmp}/$args{in}.vcf.gz"); + unlink("$$opts{tmp}/$args{in}.vcf.gz.tbi"); cmd("$$opts{bin}/bcftools index --csi -f $$opts{tmp}/$args{in}.vcf.gz"); test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools index $args{args} $$opts{tmp}/$args{in}.vcf.gz"); + unlink("$$opts{tmp}/$args{in}.vcf.gz.csi"); cmd("$$opts{bin}/bcftools view -Ob $$opts{path}/$args{in}.vcf > $$opts{tmp}/$args{in}.bcf"); cmd("$$opts{bin}/bcftools index -f $$opts{tmp}/$args{in}.bcf"); @@ -459,7 +461,7 @@ sub test_vcf_check_merge cmd("$$opts{bin}/bcftools stats -r 2 $$opts{tmp}/$args{in}.vcf.gz > $$opts{tmp}/$args{in}.2.chk"); cmd("$$opts{bin}/bcftools stats -r 3 $$opts{tmp}/$args{in}.vcf.gz > $$opts{tmp}/$args{in}.3.chk"); cmd("$$opts{bin}/bcftools stats -r 4 $$opts{tmp}/$args{in}.vcf.gz > $$opts{tmp}/$args{in}.4.chk"); - test_cmd($opts,%args,cmd=>"$$opts{bin}/plot-vcfstats -m $$opts{tmp}/$args{in}.1.chk $$opts{tmp}/$args{in}.2.chk $$opts{tmp}/$args{in}.3.chk $$opts{tmp}/$args{in}.4.chk | grep -v 'plot-vcfstats' | grep -v '^# The command' | grep -v '^# This' | grep -v '^ID\t'"); + test_cmd($opts,%args,cmd=>"$$opts{bin}/plot-vcfstats -m $$opts{tmp}/$args{in}.1.chk $$opts{tmp}/$args{in}.2.chk $$opts{tmp}/$args{in}.3.chk $$opts{tmp}/$args{in}.4.chk 2>/dev/null | grep -v 'plot-vcfstats' | grep -v '^# The command' | grep -v '^# This' | grep -v '^ID\t'"); } sub test_vcf_stats @@ -497,8 +499,8 @@ sub test_vcf_isec push @files, "$$opts{tmp}/$file.vcf.gz"; } my $files = join(' ',@files); - test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools isec $args{args} $files"); - test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools isec -Ob $args{args} $files"); + test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools isec $args{args} $files 2>/dev/null"); + test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools isec -Ob $args{args} $files 2>/dev/null"); } sub test_vcf_isec2 { @@ -525,29 +527,29 @@ sub test_vcf_convert { my ($opts,%args) = @_; bgzip_tabix_vcf($opts,$args{in}); - test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools convert $args{args} $$opts{tmp}/$args{in}.vcf.gz"); - test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools view -Ob $$opts{tmp}/$args{in}.vcf.gz | $$opts{bin}/bcftools convert $args{args}"); + test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools convert $args{args} $$opts{tmp}/$args{in}.vcf.gz 2>/dev/null"); + test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools view -Ob $$opts{tmp}/$args{in}.vcf.gz | $$opts{bin}/bcftools convert $args{args} 2>/dev/null"); } sub test_vcf_convert_hls2vcf { my ($opts,%args) = @_; my $hls = join(',', map { "$$opts{path}/$_" }( $args{h}, $args{l}, $args{s} ) ); - test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools convert $args{args} $hls | grep -v ^##"); - test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools convert $args{args} $hls -Ou | $$opts{bin}/bcftools view | grep -v ^##"); + test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools convert $args{args} $hls 2>/dev/null | grep -v ^##"); + test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools convert $args{args} $hls -Ou 2>/dev/null | $$opts{bin}/bcftools view | grep -v ^##"); } sub test_vcf_convert_hs2vcf { my ($opts,%args) = @_; my $hs = join(',', map { "$$opts{path}/$_" }( $args{h}, $args{s} ) ); - test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools convert $args{args} $hs | grep -v ^##"); - test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools convert $args{args} $hs -Ou | $$opts{bin}/bcftools view | grep -v ^##"); + test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools convert $args{args} $hs 2>/dev/null | grep -v ^##"); + test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools convert $args{args} $hs -Ou 2>/dev/null | $$opts{bin}/bcftools view | grep -v ^##"); } sub test_vcf_convert_gvcf { my ($opts,%args) = @_; bgzip_tabix_vcf($opts,$args{in}); - test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools convert --no-version $args{args} -f $$opts{path}/$args{fa} $$opts{tmp}/$args{in}.vcf.gz"); - test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools view -Ob $$opts{tmp}/$args{in}.vcf.gz | $$opts{bin}/bcftools convert $args{args} -f $$opts{path}/$args{fa} | grep -v ^##bcftools"); + test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools convert --no-version $args{args} -f $$opts{path}/$args{fa} $$opts{tmp}/$args{in}.vcf.gz 2>/dev/null"); + test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools view -Ob $$opts{tmp}/$args{in}.vcf.gz | $$opts{bin}/bcftools convert $args{args} -f $$opts{path}/$args{fa} 2>/dev/null | grep -v ^##bcftools"); } sub test_vcf_convert_tsv2vcf { @@ -555,8 +557,8 @@ sub test_vcf_convert_tsv2vcf my $params = ''; if ( exists($args{args}) ) { $params .= " $args{args}"; } if ( exists($args{fai} ) ) { $params .= " -f $$opts{path}/$args{fai}.fa"; } - test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools convert --no-version $params --tsv2vcf $$opts{path}/$args{in}"); - test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools convert -Ou $params --tsv2vcf $$opts{path}/$args{in} | $$opts{bin}/bcftools view | grep -v ^##bcftools_"); + test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools convert --no-version $params --tsv2vcf $$opts{path}/$args{in} 2>/dev/null"); + test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools convert -Ou $params --tsv2vcf $$opts{path}/$args{in} 2>/dev/null | $$opts{bin}/bcftools view | grep -v ^##bcftools_"); } sub test_vcf_norm { @@ -565,8 +567,8 @@ sub test_vcf_norm my $params = ''; if ( exists($args{args}) ) { $params .= " $args{args}"; } if ( exists($args{fai} ) ) { $params .= " -f $$opts{path}/$args{fai}.fa"; } - test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools norm --no-version $params $$opts{tmp}/$args{in}.vcf.gz"); - test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools norm -Ob $params $$opts{tmp}/$args{in}.vcf.gz | $$opts{bin}/bcftools view | grep -v ^##bcftools_"); + test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools norm --no-version $params $$opts{tmp}/$args{in}.vcf.gz 2>/dev/null"); + test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools norm -Ob $params $$opts{tmp}/$args{in}.vcf.gz 2>/dev/null | $$opts{bin}/bcftools view | grep -v ^##bcftools_"); } sub test_vcf_view { @@ -584,15 +586,15 @@ sub test_vcf_call { my ($opts,%args) = @_; $args{args} =~ s/{PATH}/$$opts{path}/g; - test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools call --no-version $args{args} $$opts{path}/$args{in}.vcf"); - test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools call -Ob $args{args} $$opts{path}/$args{in}.vcf | $$opts{bin}/bcftools view | grep -v ^##bcftools_"); + test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools call --no-version $args{args} $$opts{path}/$args{in}.vcf 2>/dev/null"); + test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools call -Ob $args{args} $$opts{path}/$args{in}.vcf 2>/dev/null | $$opts{bin}/bcftools view | grep -v ^##bcftools_"); } sub test_vcf_call_cAls { my ($opts,%args) = @_; bgzip_tabix($opts,file=>$args{tab},suffix=>'tab',args=>'-s1 -b2 -e2'); - test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools call --no-version -mA -C alleles -T $$opts{tmp}/$args{tab}.tab.gz $$opts{path}/$args{in}.vcf"); - test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools call -Ob -mA -C alleles -T $$opts{tmp}/$args{tab}.tab.gz $$opts{path}/$args{in}.vcf | $$opts{bin}/bcftools view | grep -v ^##bcftools_"); + test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools call --no-version -mA -C alleles -T $$opts{tmp}/$args{tab}.tab.gz $$opts{path}/$args{in}.vcf 2>/dev/null"); + test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools call -Ob -mA -C alleles -T $$opts{tmp}/$args{tab}.tab.gz $$opts{path}/$args{in}.vcf 2>/dev/null | $$opts{bin}/bcftools view | grep -v ^##bcftools_"); } sub test_vcf_filter { @@ -757,8 +759,8 @@ sub test_vcf_annotate $annot_fname = ''; $hdr = ''; } - test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools annotate $annot_fname $hdr $args{args} $in_fname | $$opts{bin}/bcftools view | grep -v ^##bcftools_"); - test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools annotate -Ob $annot_fname $hdr $args{args} $in_fname | $$opts{bin}/bcftools view | grep -v ^##bcftools_"); + test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools annotate $annot_fname $hdr $args{args} $in_fname 2>/dev/null | $$opts{bin}/bcftools view | grep -v ^##bcftools_"); + test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools annotate -Ob $annot_fname $hdr $args{args} $in_fname 2>/dev/null | $$opts{bin}/bcftools view | grep -v ^##bcftools_"); } sub test_vcf_plugin { @@ -831,7 +833,7 @@ sub test_vcf_consensus bgzip_tabix_vcf($opts,$args{in}); my $mask = $args{mask} ? "-m $$opts{path}/$args{mask}" : ''; my $chain = $args{chain} ? "-c $$opts{tmp}/$args{chain}" : ''; - test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools consensus $$opts{tmp}/$args{in}.vcf.gz -f $$opts{path}/$args{fa} $args{args} $mask $chain"); + test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools consensus $$opts{tmp}/$args{in}.vcf.gz -f $$opts{path}/$args{fa} $args{args} $mask $chain 2>/dev/null"); } sub test_vcf_consensus_chain { @@ -839,6 +841,6 @@ sub test_vcf_consensus_chain bgzip_tabix_vcf($opts,$args{in}); my $mask = $args{mask} ? "-m $$opts{path}/$args{mask}" : ''; my $chain = $args{chain} ? "-c $$opts{tmp}/$args{chain}.new" : ''; - test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools consensus $$opts{tmp}/$args{in}.vcf.gz -f $$opts{path}/$args{fa} $args{args} $mask $chain > /dev/null; cat $$opts{tmp}/$args{chain}.new"); + test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools consensus $$opts{tmp}/$args{in}.vcf.gz -f $$opts{path}/$args{fa} $args{args} $mask $chain > /dev/null 2>/dev/null; cat $$opts{tmp}/$args{chain}.new"); } diff --git a/test/view.filter.annovar.vcf b/test/view.filter.annovar.vcf index 7613667ad..c19aa25f9 100644 --- a/test/view.filter.annovar.vcf +++ b/test/view.filter.annovar.vcf @@ -18,6 +18,7 @@ ##INFO= ##INFO= ##INFO= +##INFO= ##INFO= ##INFO= ##INFO= From e915fd6baba32691c8336288419a501d6c627528 Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Fri, 12 Feb 2016 14:42:19 +0000 Subject: [PATCH 144/211] fill-tags plugin: add NS tag also fix some tests so that make test-plugins no passes --- plugins/fill-tags.c | 17 +++++++++++---- test/fill-tags.2.out | 49 ++++++++++++++++++++++++++++++++++++++++++++ test/test.pl | 17 +++++++-------- 3 files changed, 71 insertions(+), 12 deletions(-) create mode 100644 test/fill-tags.2.out diff --git a/plugins/fill-tags.c b/plugins/fill-tags.c index 1d2892981..2fff25803 100644 --- a/plugins/fill-tags.c +++ b/plugins/fill-tags.c @@ -38,6 +38,7 @@ #define SET_AC_Het (1<<3) #define SET_AC_Hemi (1<<4) #define SET_AF (1<<5) +#define SET_NS (1<<6) typedef struct { @@ -59,14 +60,14 @@ static args_t args; const char *about(void) { - return "Set INFO tags AF, AN, AC, AC_Hom, AC_Het, AC_Hemi.\n"; + return "Set INFO tags AF, AN, AC, NS, AC_Hom, AC_Het, AC_Hemi.\n"; } const char *usage(void) { return "\n" - "About: Set INFO tags AF, AN, AC, AC_Hom, AC_Het, AC_Hemi.\n" + "About: Set INFO tags AF, AN, AC, NS, AC_Hom, AC_Het, AC_Hemi.\n" "Usage: bcftools +fill-tags [General Options] -- [Plugin Options]\n" "Options:\n" " run \"bcftools plugin\" for a list of common options\n" @@ -88,6 +89,7 @@ int parse_tags(args_t *args, const char *str) { if ( !strcasecmp(tags[i],"AN") ) flag |= SET_AN; else if ( !strcasecmp(tags[i],"AC") ) flag |= SET_AC; + else if ( !strcasecmp(tags[i],"NS") ) flag |= SET_NS; else if ( !strcasecmp(tags[i],"AC_Hom") ) flag |= SET_AC_Hom; else if ( !strcasecmp(tags[i],"AC_Het") ) flag |= SET_AC_Het; else if ( !strcasecmp(tags[i],"AC_Hemi") ) flag |= SET_AC_Hemi; @@ -127,13 +129,14 @@ int init(int argc, char **argv, bcf_hdr_t *in, bcf_hdr_t *out) } } if ( optind != argc ) error(usage()); - if ( !args.tags ) args.tags |= SET_AN|SET_AC|SET_AC_Hom|SET_AC_Het|SET_AC_Hemi|SET_AF; + if ( !args.tags ) args.tags |= SET_AN|SET_AC|SET_NS|SET_AC_Hom|SET_AC_Het|SET_AC_Hemi|SET_AF; args.gt_id = bcf_hdr_id2int(args.in_hdr,BCF_DT_ID,"GT"); if ( args.gt_id<0 ) error("Error: GT field is not present\n"); if ( args.tags&SET_AN ) bcf_hdr_append(args.out_hdr, "##INFO="); if ( args.tags&SET_AC ) bcf_hdr_append(args.out_hdr, "##INFO="); + if ( args.tags&SET_NS ) bcf_hdr_append(args.out_hdr, "##INFO="); if ( args.tags&SET_AC_Hom ) bcf_hdr_append(args.out_hdr, "##INFO="); if ( args.tags&SET_AC_Het ) bcf_hdr_append(args.out_hdr, "##INFO="); if ( args.tags&SET_AC_Hemi ) bcf_hdr_append(args.out_hdr, "##INFO="); @@ -144,7 +147,7 @@ int init(int argc, char **argv, bcf_hdr_t *in, bcf_hdr_t *out) bcf1_t *process(bcf1_t *rec) { - int i; + int i, ns = 0; bcf_unpack(rec, BCF_UN_FMT); bcf_fmt_t *fmt_gt = NULL; @@ -174,6 +177,7 @@ bcf1_t *process(bcf1_t *rec) als |= (1<type, bcf_seqname(args.in_hdr,rec),rec->pos+1); break; } #undef BRANCH_INT + if ( args.tags&SET_NS ) + { + if ( bcf_update_info_int32(args.out_hdr,rec,"NS",&ns,1)!=0 ) + error("Error occurred while updating NS at %s:%d\n", bcf_seqname(args.in_hdr,rec),rec->pos+1); + } if ( args.tags&SET_AN ) { args.arr[0] = 0; diff --git a/test/fill-tags.2.out b/test/fill-tags.2.out new file mode 100644 index 000000000..01fe9c965 --- /dev/null +++ b/test/fill-tags.2.out @@ -0,0 +1,49 @@ +##fileformat=VCFv4.1 +##FILTER= +##reference=file:///seq/references/1000Genomes-NCBI37.fasta +##contig= +##contig= +##contig= +##contig= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##FILTER= +##FILTER= +##FILTER= +##FILTER= +##FILTER= +##INFO= +##INFO= +#CHROM POS ID REF ALT QUAL FILTER INFO FORMAT NA00001 NA00002 NA00003 +11 2343543 . A . 999 PASS DP=100223;NS=3;AN=6 GT:PL:DP:GQ 0/0:0,255,255:193:99 0/0:0,255,255:211:99 0/0:0,255,255:182:99 +11 5464562 . C T 999 PASS DP=0;NS=0;AN=0;AC=0 GT:PL:DP:GQ ./.:0,0,0:.:. ./.:0,0,0:.:. ./.:0,0,0:.:. +20 76962 rs6111385 T C 999 PASS DP4=110138,70822,421911,262673;DP=911531;Dels=0;FS=21.447;HWE=0.491006;ICF=-0.01062;MQ0=1;MQ=46;PV4=2.5e-09,0,0,1;QD=22.31;NS=3;AN=6;AF=0.833333;AC=5 GT:PL:DP:GQ 0/1:255,0,255:193:99 1/1:255,255,0:211:99 1/1:255,255,0:182:99 +20 126310 . ACC A 999 StrandBias;EndDistBias DP4=125718,95950,113812,80890;DP=461867;HWE=0.24036;ICF=0.01738;INDEL;IS=374,0.937343;MQ=49;PV4=9e-30,1,0,3.8e-13;QD=0.0172;AN=6;AC=4;NS=3;AF=0.666667 GT:DP:GQ:PL 0/1:117:99:255,0,132 0/1:111:99:255,0,139 1/1:78:99:255,213,0 +20 138125 rs2298108 G T 999 PASS DP4=174391,20849,82080,4950;DP=286107;Dels=0;FS=3200;HWE=0.199462;ICF=0.01858;MQ0=0;MQ=46;PV4=0,0,0,1;QD=17.22;AN=6;AC=4;NS=3;AF=0.666667 GT:PL:DP:GQ 0/1:135,0,163:66:99 0/1:140,0,255:71:99 1/1:255,199,0:66:99 +20 138148 rs2298109 C T 999 PASS DP4=194136,45753,94945,14367;DP=356657;Dels=0;FS=3200;HWE=0.177865;ICF=0.0198;MQ0=0;MQ=47;PV4=0,0,0,1;QD=14.57;AN=6;AC=4;NS=3;AF=0.666667 GT:PL:DP:GQ 0/1:195,0,255:87:99 0/1:192,0,255:82:99 1/1:255,235,0:78:99 +20 271225 . T TTTA,TA 999 StrandBias DP4=29281,42401,27887,29245;DP=272732;INDEL;IS=95,0.748031;MQ=47;PV4=0,1,0,1;QD=0.0948;AN=6;AC=2,2;NS=3;AF=0.333333,0.333333 GT:DP:GQ:PL 0/2:33:49:151,53,203,0,52,159 0/1:51:99:255,0,213,255,255,255 1/2:47:99:255,255,255,255,0,241 +20 304568 . C T 999 PASS DP4=16413,4543,945,156;DP=43557;Dels=0;FS=3200;HWE=0.076855;ICF=0.0213;MQ0=0;MQ=50;PV4=0,0,0,1;QD=15.45;AN=6;AC=4;NS=3;AF=0.666667 GT:PL:DP:GQ 0|1:95,0,255:90:99 0|1:192,0,255:13:99 1|1:255,95,0:60:99 +20 326891 . A AC 999 PASS DP4=125718,95950,113812,80890;DP=461867;HWE=0.24036;ICF=0.01738;INDEL;IS=374,0.937343;MQ=49;PV4=9e-30,1,0,3.8e-13;QD=0.0172;AN=4;AC=2;NS=2;AF=0.5 GT:DP:GQ:PL 0|1:117:99:255,0,132 0|1:111:99:255,0,139 ./.:.:.:.,.,. +X 2928329 rs62584840 C T 999 PASS DP4=302,9137,32,1329;DP=11020;Dels=0;FS=13.38;HWE=0.284332;ICF=0.0253;MQ0=0;MQ=49;PV4=0.094,0,0,1;QD=18.61;AN=4;AC=1;NS=3;AF=0.25 GT:PL:DP:GQ 0:0,56:2:73 0:0,81:3:98 0/1:73,0,19:4:30 +X 2933066 rs61746890 G C 999 PASS DP4=69865,100561,461,783;DP=173729;Dels=0;FS=10.833;MQ0=0;MQ=50;PV4=0.005,3.6e-14,0,1;QD=15.33;AN=4;AC=1;NS=3;AF=0.25 GT:PL:DP:GQ 0:0,255:39:99 0:0,255:37:99 0/1:255,255,255:62:99 +X 2942109 rs5939407 T C 999 PASS DP4=23273,27816,40128,48208;DP=146673;Dels=0;FS=43.639;HWE=0.622715;ICF=-0.01176;MQ0=1;MQ=46;PV4=0.65,1,0,1;QD=14.81;AN=4;AC=3;NS=3;AF=0.75 GT:PL:DP:GQ 0:0,255:20:99 1:255,0:33:99 1/1:255,157,0:52:99 +X 3048719 . T C 999 PASS DP4=13263,27466,40128,48208;DP=146673;Dels=0;FS=43.639;HWE=0.622715;ICF=-0.01176;MQ0=1;MQ=46;PV4=0.65,1,0,1;QD=14.81;AN=4;AC=2;NS=3;AF=0.5 GT:PL:DP:GQ 0:0,255:20:99 1:255,0:33:99 0|1:255,0,157:52:99 +Y 8657215 . C A 999 PASS DP4=74915,114274,1948,2955;DP=195469;Dels=0;FS=3.181;MQ0=0;MQ=50;PV4=0.86,1,0,1;QD=33.77;AN=2;AC=1;NS=2;AF=0.5 GT:PL:DP:GQ 0:0,255:47:99 1:255,0:64:99 .:.:.:. +Y 10011673 rs78249411 G A 999 MinAB DP4=47351,30839,178796,279653;DP=550762;Dels=0;FS=41.028;MQ0=37362;MQ=26;PV4=0,0,0,1;QD=17.45;AN=2;AC=2;NS=2;AF=1 GT:PL:DP:GQ 1:126,101:146:37 1:95,0:130:99 .:.:.:. diff --git a/test/test.pl b/test/test.pl index 68226c7c2..7a54de292 100755 --- a/test/test.pl +++ b/test/test.pl @@ -176,17 +176,18 @@ test_vcf_annotate($opts,in=>'annotate4',vcf=>'annots4',out=>'annotate8.out',args=>'-c +INFO'); test_vcf_annotate($opts,in=>'annotate4',tab=>'annots4',out=>'annotate8.out',args=>'-c CHROM,POS,REF,ALT,+FA,+FR,+IA,+IR,+SA,+SR'); test_vcf_annotate($opts,in=>'annotate10',tab=>'annots10',out=>'annotate10.out',args=>'-c CHROM,POS,FMT/FINT,FMT/FFLT,FMT/FSTR'); -test_vcf_plugin($opts,in=>'plugin1',out=>'missing2ref.out',cmd=>'+missing2ref'); -test_vcf_plugin($opts,in=>'plugin1',out=>'missing2ref.out',cmd=>'+setGT',args=>'-- -t . -n 0'); +test_vcf_plugin($opts,in=>'plugin1',out=>'missing2ref.out',cmd=>'+missing2ref --no-version'); +test_vcf_plugin($opts,in=>'plugin1',out=>'missing2ref.out',cmd=>'+setGT --no-version',args=>'-- -t . -n 0'); test_vcf_annotate($opts,in=>'annotate9',tab=>'annots9',out=>'annotate9.out',args=>'-c CHROM,POS,REF,ALT,+ID'); -test_vcf_plugin($opts,in=>'plugin1',out=>'fill-AN-AC.out',cmd=>'+fill-AN-AC'); +test_vcf_plugin($opts,in=>'plugin1',out=>'fill-AN-AC.out',cmd=>'+fill-AN-AC --no-version'); test_vcf_plugin($opts,in=>'plugin1',out=>'dosage.out',cmd=>'+dosage'); -test_vcf_plugin($opts,in=>'fixploidy',out=>'fixploidy.out',cmd=>'+fixploidy',args=>'-- -s {PATH}/fixploidy.samples -p {PATH}/fixploidy.ploidy'); +test_vcf_plugin($opts,in=>'fixploidy',out=>'fixploidy.out',cmd=>'+fixploidy --no-version',args=>'-- -s {PATH}/fixploidy.samples -p {PATH}/fixploidy.ploidy'); test_vcf_plugin($opts,in=>'vcf2sex',out=>'vcf2sex.out',cmd=>'+vcf2sex',args=>'-- -n 5'); test_vcf_plugin($opts,in=>'vcf2sex',out=>'vcf2sex.out',cmd=>'+vcf2sex',args=>'-- -g GT'); test_vcf_plugin($opts,in=>'vcf2sex',out=>'vcf2sex.out',cmd=>'+vcf2sex',args=>'-- -g GT -n 5'); -test_vcf_plugin($opts,in=>'view.GL',out=>'view.PL.vcf',cmd=>'+tag2tag',args=>'-- -r --gl-to-pl'); -test_vcf_plugin($opts,in=>'merge.a',out=>'fill-tags.out',cmd=>'+fill-tags'); +test_vcf_plugin($opts,in=>'view.GL',out=>'view.PL.vcf',cmd=>'+tag2tag --no-version',args=>'-- -r --gl-to-pl'); +test_vcf_plugin($opts,in=>'merge.a',out=>'fill-tags.out',cmd=>'+fill-tags --no-version',args=>'-- -t AN,AC,AC_Hom,AC_Het,AC_Hemi'); +test_vcf_plugin($opts,in=>'view',out=>'fill-tags.2.out',cmd=>'+fill-tags --no-version',args=>'-- -t AC,AN,AF,NS'); test_vcf_concat($opts,in=>['concat.1.a','concat.1.b'],out=>'concat.1.vcf.out',do_bcf=>0,args=>''); test_vcf_concat($opts,in=>['concat.1.a','concat.1.b'],out=>'concat.1.bcf.out',do_bcf=>1,args=>''); test_vcf_concat($opts,in=>['concat.2.a','concat.2.b'],out=>'concat.2.vcf.out',do_bcf=>0,args=>'-a'); @@ -770,11 +771,11 @@ sub test_vcf_plugin if ( !exists($args{args}) ) { $args{args} = ''; } $args{args} =~ s/{PATH}/$$opts{path}/g; bgzip_tabix_vcf($opts,"$args{in}"); - test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools $args{cmd} --no-version $$opts{tmp}/$args{in}.vcf.gz $args{args}"); + test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools $args{cmd} $$opts{tmp}/$args{in}.vcf.gz $args{args}"); cmd("$$opts{bin}/bcftools view -Ob $$opts{tmp}/$args{in}.vcf.gz > $$opts{tmp}/$args{in}.bcf"); cmd("$$opts{bin}/bcftools index -f $$opts{tmp}/$args{in}.bcf"); - test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools $args{cmd} --no-version $$opts{tmp}/$args{in}.bcf $args{args} | grep -v ^##bcftools_"); + test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools $args{cmd} $$opts{tmp}/$args{in}.bcf $args{args} | grep -v ^##bcftools_"); } sub test_vcf_concat { From be92659d29e202b4d9edcb52406e9f12939470f4 Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Fri, 12 Feb 2016 14:57:01 +0000 Subject: [PATCH 145/211] test plugins via travis too * remove old LD_LIBRARY_PATH specification * test on osx too --- .travis.yml | 23 +++++++++++++---------- 1 file changed, 13 insertions(+), 10 deletions(-) diff --git a/.travis.yml b/.travis.yml index 333cc7356..608ce7af7 100644 --- a/.travis.yml +++ b/.travis.yml @@ -1,20 +1,23 @@ # Control file for continuous integration testing at http://travis-ci.org/ language: c -compiler: - - clang - - gcc - -env: - global: - - HTSDIR=./htslib - - LD_LIBRARY_PATH=$TRAVIS_BUILD_DIR/htslib:$LD_LIBRARY_PATH matrix: include: + - os: linux + compiler: clang + - os: linux + compiler: gcc # An unoptimised C99 build, for detecting non-static inline functions - - compiler: gcc + - os: linux + compiler: gcc env: CFLAGS="-std=gnu99 -O0" + - os: osx + compiler: clang + +env: + global: + - HTSDIR=./htslib before_script: # Clone samtools/htslib (or another repository, as specified by a Travis CI @@ -22,4 +25,4 @@ before_script: # same name, if any, or otherwise the default branch. - .travis/clone ${HTSREPO:-git://github.com/samtools/htslib.git} $HTSDIR $TRAVIS_BRANCH -script: make -e && make -e test +script: make plugindir=$TRAVIS_BUILD_DIR/plugins -e && make -e test-plugins From 681d80c20d078f953ff39140f7e519c94cb4fd1d Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Thu, 11 Feb 2016 14:44:32 +0000 Subject: [PATCH 146/211] peakfit build with GSLv2, resolves #378 --- peakfit.c | 6 ++++++ 1 file changed, 6 insertions(+) diff --git a/peakfit.c b/peakfit.c index 2bc849226..8094b5d52 100644 --- a/peakfit.c +++ b/peakfit.c @@ -26,6 +26,7 @@ #include "peakfit.h" #include +#include #include #include #include @@ -550,9 +551,14 @@ double peakfit_run(peakfit_t *pkf, int nvals, double *xvals, double *yvals) } if ( ret ) break; +#if GSL_MAJOR_VERSION >= 2 + int info; + test1 = gsl_multifit_fdfsolver_test(solver, 1e-8,1e-8, 0.0, &info); +#else gsl_multifit_gradient(solver->J, solver->f, grad); test1 = gsl_multifit_test_gradient(grad, 1e-8); test2 = gsl_multifit_test_delta(solver->dx, solver->x, 1e-8, 1e-8); +#endif } while ((test1==GSL_CONTINUE || test2==GSL_CONTINUE) && ++niterverbose >1 ) From a121590a44efabe8e66e23b087632eae282fbb77 Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Fri, 19 Feb 2016 15:19:53 +0000 Subject: [PATCH 147/211] plot-vcfstats: update expected headers [minor] should have been updated after 6fed5ac7a68a2cd0bc2121b99bcfbb3eacbec3e5 and c121e22a189d179462a2e510e4ec705e83bacb47 --- plot-vcfstats | 6 +++--- 1 file changed, 3 insertions(+), 3 deletions(-) diff --git a/plot-vcfstats b/plot-vcfstats index 5989062f4..74a42ca6e 100755 --- a/plot-vcfstats +++ b/plot-vcfstats @@ -174,12 +174,12 @@ sub parse_params { id=>'GCsS', header=>'GCsS, Genotype concordance by sample (SNPs)', - exp=>"# GCsS\t[2]id\t[3]sample\t[4]non-reference discordance rate\t[5]RR Hom matches\t[6]RA Het matches\t[7]AA Hom matches\t[8]RR Hom mismatches\t[9]RA Het mismatches\t[10]AA Hom mismatches" + exp=>"# GCsS\t[2]id\t[3]sample\t[4]non-reference discordance rate\t[5]RR Hom matches\t[6]RA Het matches\t[7]AA Hom matches\t[8]RR Hom mismatches\t[9]RA Het mismatches\t[10]AA Hom mismatches\t[11]dosage r-squared" }, { id=>'GCiS', header=>'GCiS, Genotype concordance by sample (indels)', - exp=>"# GCiS\t[2]id\t[3]sample\t[4]non-reference discordance rate\t[5]RR Hom matches\t[6]RA Het matches\t[7]AA Hom matches\t[8]RR Hom mismatches\t[9]RA Het mismatches\t[10]AA Hom mismatches" + exp=>"# GCiS\t[2]id\t[3]sample\t[4]non-reference discordance rate\t[5]RR Hom matches\t[6]RA Het matches\t[7]AA Hom matches\t[8]RR Hom mismatches\t[9]RA Het mismatches\t[10]AA Hom mismatches\t[11]dosage r-squared" }, { id=>'PSC', @@ -189,7 +189,7 @@ sub parse_params { id=>'PSI', header=>'PSI, Per-sample Indels', - exp=>"# PSI\t[2]id\t[3]sample\t[4]in-frame\t[5]out-frame\t[6]not applicable\t[7]out/(in+out) ratio" + exp=>"# PSI\t[2]id\t[3]sample\t[4]in-frame\t[5]out-frame\t[6]not applicable\t[7]out/(in+out) ratio\t[8]nHets\t[9]nAA" }, { id=>'DP', From ef4e8a9d9cf8b30c00f50050df060a3d34e79536 Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Fri, 19 Feb 2016 16:05:20 +0000 Subject: [PATCH 148/211] vcfannotate: fix typo [minor] --- vcfannotate.c | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/vcfannotate.c b/vcfannotate.c index 8e9ba3a42..d5164f333 100644 --- a/vcfannotate.c +++ b/vcfannotate.c @@ -1764,8 +1764,8 @@ static void usage(args_t *args) fprintf(stderr, " -c, --columns list of columns in the annotation file, e.g. CHROM,POS,REF,ALT,-,INFO/TAG. See man page for details\n"); fprintf(stderr, " -e, --exclude exclude sites for which the expression is true (see man page for details)\n"); fprintf(stderr, " -h, --header-lines lines which should be appended to the VCF header\n"); - fprintf(stderr, " -I, --set-id [+] set ID column, see man pagee for details\n"); - fprintf(stderr, " -i, --include select sites for which the expression is true (see man pagee for details)\n"); + fprintf(stderr, " -I, --set-id [+] set ID column, see man page for details\n"); + fprintf(stderr, " -i, --include select sites for which the expression is true (see man page for details)\n"); fprintf(stderr, " -m, --mark-sites [+-] add INFO/tag flag to sites which are (\"+\") or are not (\"-\") listed in the -a file\n"); fprintf(stderr, " --no-version do not append version and command line to the header\n"); fprintf(stderr, " -o, --output write output to a file [standard output]\n"); From 9f5ee2163fed0617cc4160abfe7046aa02212fd3 Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Fri, 19 Feb 2016 16:48:09 +0000 Subject: [PATCH 149/211] vcfcall: fix typo in error message [minor] --- vcfcall.c | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/vcfcall.c b/vcfcall.c index d4a19d99e..e5bbf1167 100644 --- a/vcfcall.c +++ b/vcfcall.c @@ -386,7 +386,7 @@ static void init_data(args_t *args) if ( args->regions ) { if ( bcf_sr_set_regions(args->aux.srs, args->regions, args->regions_is_file)<0 ) - error("Failed to read the targets: %s\n", args->regions); + error("Failed to read the regions: %s\n", args->regions); } if ( !bcf_sr_add_reader(args->aux.srs, args->bcf_fname) ) error("Failed to open %s: %s\n", args->bcf_fname,bcf_sr_strerror(args->aux.srs->errnum)); From 2f4a2b232103bffe673c7eb7f9e2e0304fb55af6 Mon Sep 17 00:00:00 2001 From: dlaehnemann Date: Fri, 4 Dec 2015 14:37:58 +0100 Subject: [PATCH 150/211] new plugin: GTisec to count genotype intersections across all possible sample subsets in a vcf file Commit messages, oldest first: Basic compiling version of vcfGTcmp that does not do any comparing, yet. Basic working version of GTcmp. Output is banker's sequence sorted per sample, i.e. with increasing cardinality of sample subsets of the current sample. No circos file printing included... Basic working Circos config file printing. Not tested with circos, yet, as karyotype and link files are still missing. Basic version of all circos file printing is tested to work correctly. Figure production using those files in circos is not yet tested. Circos plotting file output thoroughly tested with circos and adjusted to make sample sets easily distinguishable. Implement counting of missing genotypes, including a switch to turn this behaviour on (off by default). This includes cleaning up of cmp_GT(), i.e. all printing previously done within this function is now in this tools main function and cmp_GT only does counting. Ensure that karyotype band colors and subset ribbon colors can be searched-and-replaced separately in case of more than 9 samples and thus no automatic color assignment. Minor cleanup of code adaptations from Corin Lawson's banker's sequence code. (Hopefully) improve tool description line. Circos printing functionality was moved to a separate command line tool and this tool was renamed from GTcmp to gtisec for "genotype intersections" of all possible subsets of samples. Output is now more flexible, and all possible option combinations have been tested against test/view.vcf with manually checked results in test/view.gtisec.* files. Output options are: * a basic version is in global banker's sequence order that is easily parseable * -m: counts of missing values can be included optionally * -v: output can be made verbose, then including all the respective sample names before each count * -H: output can be put into a human-readable sample sort order (implies verbose output). Removed unnecessary functions carried over from original banker's sequence code. Improved the tools description at the top of the file comment, including reason for using banker's sequence. Added some comments explaining the GT comparisons. Checked for memory leaks using valgrind and removed one related to the quick lookup table of the n choose k function choose(). This lookup table is now part of the args_t struct, initialized in init_data and freed by destroy data. Added reference to tools using the output to the code file description and the comments section of the printed output. Tested that output is otherwise unchanged, using test/view.gtisec*.out files. Address error of automatic Travis CI build number 3. Change column order in verbose (-v) and human readable (-H) output, so that the count comes in the first column (consistent with regular output) and the samples list comes in the second column. Thanks to @pd3 for the suggestion. test/view.gtisec*.out files updated accordingly. Changed subtool vcfgtisec into plugin GTisec, including all necessary building and test file changes. Include test cases in test.pl and update test output to omit lines containing commit numbers. Making tests pass. [NEWS] GTisec: new plugin courtesy of @dlaehnemann to count genotype intersections across all possible sample subsets in a vcf file. --- plugins/GTisec.c | 470 +++++++++++++++++++++++++++++++++++++++ plugins/GTisec.mk | 2 + test/test.pl | 8 + test/view.GTisec.H.out | 20 ++ test/view.GTisec.Hm.out | 25 +++ test/view.GTisec.Hmv.out | 25 +++ test/view.GTisec.Hv.out | 20 ++ test/view.GTisec.m.out | 20 ++ test/view.GTisec.mv.out | 20 ++ test/view.GTisec.out | 15 ++ test/view.GTisec.v.out | 15 ++ 11 files changed, 640 insertions(+) create mode 100644 plugins/GTisec.c create mode 100644 plugins/GTisec.mk create mode 100644 test/view.GTisec.H.out create mode 100644 test/view.GTisec.Hm.out create mode 100644 test/view.GTisec.Hmv.out create mode 100644 test/view.GTisec.Hv.out create mode 100644 test/view.GTisec.m.out create mode 100644 test/view.GTisec.mv.out create mode 100644 test/view.GTisec.out create mode 100644 test/view.GTisec.v.out diff --git a/plugins/GTisec.c b/plugins/GTisec.c new file mode 100644 index 000000000..adfbdb972 --- /dev/null +++ b/plugins/GTisec.c @@ -0,0 +1,470 @@ +/* plugins/GTisec.c -- collect genotype intersection counts of all possible + subsets of the present samples and output in banker's + sequence order (in this sequence, the number of contained + samples increases monotonically, a property that is e.g. + useful for programatically creating plotting files for the + R package VennDiagram or the plotting tool circos from the + counts, as in the command line tools bankers2VennDiagram and + bankers2circos at htpps://github.com/dlaehnemann/bankers2) + + Copyright (C) 2016 Computational Biology of Infection Research, + Helmholtz Centre for Infection Research, Braunschweig, + Germany + + Author: David Laehnemann + +Permission is hereby granted, free of charge, to any person obtaining a copy +of this software and associated documentation files (the "Software"), to deal +in the Software without restriction, including without limitation the rights +to use, copy, modify, merge, publish, distribute, sublicense, and/or sell +copies of the Software, and to permit persons to whom the Software is +furnished to do so, subject to the following conditions: + +The above copyright notice and this permission notice shall be included in +all copies or substantial portions of the Software. + +THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS OR +IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF MERCHANTABILITY, +FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. IN NO EVENT SHALL +THE AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY CLAIM, DAMAGES OR OTHER +LIABILITY, WHETHER IN AN ACTION OF CONTRACT, TORT OR OTHERWISE, ARISING +FROM, OUT OF OR IN CONNECTION WITH THE SOFTWARE OR THE USE OR OTHER +DEALINGS IN THE SOFTWARE. */ + +#include +#include +#include +#include +#include +#include + +#include +#include +#include +KHASH_MAP_INIT_INT(gts2smps, uint32_t) + +#include "bcftools.h" + +/*! + * Flag definitions for args.flag + */ +#define MISSING (1<<0) +#define VERBOSE (1<<1) +#define SMPORDER (1<<2) + +typedef struct _args_t +{ + bcf_srs_t *file; /*! multi-sample VCF file */ + bcf_hdr_t *hdr; /*! VCF file header */ + FILE *out; /*! output file pointer */ + int nsmp; /*! number of samples, can be determined from header but is needed in multiple contexts */ + int nsmpp2; /*! 2^(nsmp) (is needed multiple times) */ + int *gt_arr; /*! temporary array, to store GTs of current line/record */ + int ngt_arr; /*! hold the number of current GT array entries */ + uint32_t *bankers; /*! array to store banker's sequence for all possible sample subsets for + programmatic indexing into smp_is for output printing, e.g. for three + samples A, B and C this would be the following order: + [ C, B, A, CB, CA, BA, CBA ] + [ 100, 010, 001, 110, 101, 011, 111 ] + */ + uint64_t *quick; /*! array to store n choose k lookup table of choose() function */ + uint8_t flag; /*! several flags, for positions see above*/ + uint64_t *missing_gts; /*! array to count missing genotypes of each sample */ + uint64_t *smp_is; /*! array to track all possible intersections between + samples, with each bit in the index integer belonging to one + sample. E.g. for three samples A, B and C, count would be in + the following order: + [ A, B, AB, C, AC, BC, ABC ] + [ 001, 010, 011, 100, 101, 110, 111 ] + */ +} +args_t; + +static args_t args; +uint32_t compute_bankers(unsigned long a); + +const char *about(void) +{ + return "Count genotype intersections across all possible sample subsets in a vcf file.\n"; +} + + +const char *usage(void) +{ + return + "\n" + "About: Count genotype intersections across all possible sample subsets in a vcf file.\n" + "Usage: bcftools +GTisec [General Options] -- [Plugin Options] \n" + "\n" + "Options:\n" + " run \"bcftools plugin\" for a list of common options\n" + "\n" + "Plugin options:\n" + " -m, --missing if set, include count of missing genotypes per sample in output\n" + " -v, --verbose if set, annotate count rows with corresponding sample subset lists\n" + " -H, --human-readable if set, create human readable output; i.e. sort output by sample and\n" + " print each subset's intersection count once for each sample contained\n" + " in the subset; implies verbose output (-v)\n" + "\n" + "Example:\n" + " bcftools +GTisec in.vcf -- -v # for verbose output\n" + " bcftools +GTisec in.vcf -- -H # for human readable output\n" + "\n"; +} + + +int init(int argc, char **argv, bcf_hdr_t *in, bcf_hdr_t *out) +{ + memset(&args,0,sizeof(args_t)); + args.flag = 0; + + static struct option loptions[] = + { + {"help", no_argument, 0,'h'}, + {"missing", no_argument, 0,'m'}, + {"verbose", no_argument, 0,'v'}, + {"human-readable", no_argument, 0,'H'}, + {0,0,0,0} + }; + + char c; + while ((c = getopt_long(argc, argv, "?mvHh",loptions,NULL)) >= 0) + { + switch (c) + { + case 'm': args.flag |= MISSING; break; + case 'v': args.flag |= VERBOSE; break; + case 'H': args.flag |= ( SMPORDER | VERBOSE ); break; + case 'h': usage(); break; + case '?': + default: error("%s", usage()); break; + } + } + if ( optind != argc ) usage(); // too many files given + + + args.hdr = in; + + if ( !bcf_hdr_nsamples(args.hdr) ) + { + error("No samples in input file.\n"); + } + + args.nsmp = bcf_hdr_nsamples(args.hdr); + if ( args.nsmp > 32 ) error("Too many samples. A maximum of 32 is supported.\n"); + args.nsmpp2 = pow( 2, args.nsmp); + args.bankers = (uint32_t*) calloc( args.nsmpp2, sizeof(uint32_t) ); + args.quick = (uint64_t*) calloc((args.nsmp * (args.nsmp + 1)) / 4, sizeof(unsigned long)); + if ( args.flag & MISSING ) args.missing_gts = (uint64_t*) calloc( args.nsmp, sizeof(uint64_t)); + args.smp_is = (uint64_t*) calloc( args.nsmpp2, sizeof(uint64_t)); + if ( bcf_hdr_id2int(args.hdr, BCF_DT_ID, "GT")<0 ) error("[E::%s] GT not present in the header\n", __func__); + + args.gt_arr = NULL; + args.ngt_arr = 0; + + args.out = stdout; + + /*! Header printing */ + FILE *fp = args.out; + fprintf(fp, "# This file was produced by bcftools +GTisec (%s+htslib-%s)\n", bcftools_version(), hts_version()); + fprintf(fp, "# The command line was:\tbcftools +GTisec %s ", argv[0]); + int i; + for (i=1; i < argc; i++) + { + fprintf(fp, " %s", argv[i]); + } + fprintf(fp,"\n"); + fprintf(fp,"# This file can be used as input to the subset plotting tools at:\n" + "# https://github.com/dlaehnemann/bankers2\n"); + fprintf(fp,"# Genotype intersections across samples:\n"); + fprintf(fp,"@SMPS"); + for (i = args.nsmp-1; i >= 0; i--) + { + fprintf(fp," %s", bcf_hdr_int2id(args.hdr, BCF_DT_SAMPLE, i)); + } + fprintf(fp,"\n"); + if ( args.flag & MISSING ) + { + if ( args.flag & SMPORDER ) + { + fprintf(fp, "# The first line of each sample contains its count of missing genotypes, with a '-' appended\n" + "# to the sample name.\n"); + } + else + { + fprintf(fp, "# The first %i lines contain the counts for missing values of each sample in the order provided\n" + "# in the SMPS-line above. Intersection counts only start afterwards.\n", args.nsmp); + } + } + if ( args.flag & SMPORDER ) + { + fprintf(fp, "# Human readable output (-H) was requested. Subset intersection counts are therefore sorted by\n" + "# sample and repeated for each contained sample. For each sample, counts are in banker's \n" + "# sequence order regarding all other samples.\n"); + } + else + { + fprintf(fp, "# Subset intersection counts are in global banker's sequence order.\n"); + if ( args.nsmp > 2 ) + { + fprintf(fp, "# After exclusive sample counts in order of the SMPS-line, banker's sequence continues with:\n" + "# %s,%s %s,%s ...\n", + bcf_hdr_int2id(in, BCF_DT_SAMPLE, args.nsmp-1 ), + bcf_hdr_int2id(in, BCF_DT_SAMPLE, args.nsmp-2 ), + bcf_hdr_int2id(in, BCF_DT_SAMPLE, args.nsmp-1 ), + bcf_hdr_int2id(in, BCF_DT_SAMPLE, args.nsmp-3 ) + ); + } + } + if (args.flag & VERBOSE ) + { + fprintf(fp,"# [1] Number of shared non-ref genotypes \t[2] Samples sharing non-ref genotype (GT)\n"); + } + else + { + fprintf(fp,"# [1] Number of shared non-ref genotypes\n"); + } + + /* Compute banker's sequence for following printing by sample and + * with increasing subset size. + */ + uint32_t j; + for ( j = 0; j < args.nsmpp2; j++ ) + { + args.bankers[j] = compute_bankers(j); + } + + return 1; +} + + +/* ADAPTED CODE FROM CORIN LAWSON (START) + * https://github.com/au-phiware/bankers/blob/master/c/bankers.c + * who implemented ideas of Eric Burnett: + * http://www.thelowlyprogrammer.com/2010/04/indexing-and-enumerating-subsets-of.html + */ + +/* + * Compute the binomial coefficient of `n choose k'. + * Use the fact that binom(n, k) = binom(n, n - k). + * Use a lookup table (triangle, actually) for speed. + * Otherwise it's dumb (heart) recursion. + * Added relative to Corin Lawson: + * * Passing in of sample number through pointer to args struct + * * Make quick lookup table external to keep it persistent with clean allocation + * and freeing + */ +uint64_t choose(unsigned int n, unsigned int k) { + if (n == 0) + return 0; + if (n == k || k == 0) + return 1; + if (k > n / 2) + k = n - k; + + unsigned int i = (n * (n - 1)) / 4 + k - 1; + if (args.quick[i] == 0) + args.quick[i] = choose(n - 1, k - 1) + choose(n - 1, k); + + return args.quick[i]; +} + +/* + * Returns the Banker's number at the specified position, a. + * Derived from the recursive bit flip method. + * Added relative to Corin Lawson: + * * Uses same lookup table solution as choose function, just + * maintained externally to persist across separate function calls. + * * Uses bitwise symmetry of banker's sequence to use bitwise inversion + * instead of recursive bit flip for second half of sequence. + */ +uint32_t compute_bankers(unsigned long a) +{ + if (a == 0) + return 0; + + if ( args.bankers[a] == 0 ) + { + if ( a >= (args.nsmpp2 / 2) ) + return args.bankers[a] = ( compute_bankers(args.nsmpp2 - (a+1)) ^ (args.nsmpp2 - 1) ); // use bitwise symmetry of bankers sequence + unsigned int c = 0; + uint32_t n = args.nsmp; + uint64_t e = a, binom; + binom = choose(n, c); + do { + e -= binom; + } while ((binom = choose(n, ++c)) <= e); + + do { + if (e == 0 || (binom = choose(n - 1, c - 1)) > e) + c--, args.bankers[a] |= 1; + else + e -= binom; + } while (--n && c && ((args.bankers[a] <<= 1) || 1)); + args.bankers[a] <<= n; + } + + return args.bankers[a]; +} + +// ADAPTED CODE FROM CORIN LAWSON END + + +/* + * GT field (genotype) comparison function. + */ +bcf1_t *process(bcf1_t *rec) +{ + uint64_t i; + bcf_unpack(rec, BCF_UN_FMT); // unpack the Format fields, including the GT field + int gte_smp = 0; // number GT array entries per sample (should be 2, one entry per allele) + if ( (gte_smp = bcf_get_genotypes(args.hdr, rec, &(args.gt_arr), &(args.ngt_arr) ) ) <= 0 ) + { + error("GT not present at %s: %d\n", args.hdr->id[BCF_DT_CTG][rec->rid].key, rec->pos+1); + } + + gte_smp /= args.nsmp; // divide total number of genotypes array entries (= args.ngt_arr) by number of samples + int ret; + + // stick all genotypes in a hash as keys and store up to 32 samples in a corresponding flag as its value + khiter_t bucket; + khash_t(gts2smps) *gts = kh_init(gts2smps); // create hash + for ( i = 0; i < args.nsmp; i++ ) + { + int *gt_ptr = args.gt_arr + gte_smp * i; + + if (bcf_gt_is_missing(gt_ptr[0]) || ( gte_smp == 2 && bcf_gt_is_missing(gt_ptr[1]) ) ) + { + if ( args.flag & MISSING ) args.missing_gts[i]++; // count missing genotypes, if requested + continue; // don't do anything else for missing genotypes, their "sharing" gives no info... + } + + int a = bcf_gt_allele(gt_ptr[0]); + int b; + if ( gte_smp == 2 ) // two entries available per sample, padded with missing values for haploid genotypes + { + b = bcf_gt_allele(gt_ptr[1]); + } + else if (gte_smp == 1 ) // use missing value for second entry in hash key generation below, if only one is available + { + b = bcf_gt_allele(bcf_int32_vector_end); + } + else + { + error("gtisec does not support ploidy higher than 2.\n"); + } + + int idx = bcf_alleles2gt(a,b); // generate genotype specific hash key + + bucket = kh_get(gts2smps, gts, idx); // get the genotype's hash bucket + + if ( bucket == kh_end(gts) ) { // means that key does not exist + bucket = kh_put(gts2smps, gts, idx, &ret); // create bucket with genotype index as key and return its iterator + kh_val(gts, bucket) = 0; // initialize the bucket with all sample bits unset + } + kh_value(gts, bucket) |= (1<= 0; s--) + { + if ( args.flag & MISSING ) // if missing genotype counts are requested, print them to standard output + { + fprintf(fp, "%"PRIu64"\t%s-\n", args.missing_gts[s], bcf_hdr_int2id(args.hdr, BCF_DT_SAMPLE, s)); + } + for ( i = 1; i < args.nsmpp2; i++ ) + { + if ( (args.bankers[i]>>s) & 1 ) + { + fprintf(fp, "%"PRIu64"\t", args.smp_is[ args.bankers[i] ]); // print out count of genotypes shared by samples in current banker's sequence position + int j; + /* Print sample list */ + fprintf(fp, "%s", bcf_hdr_int2id(args.hdr, BCF_DT_SAMPLE, s)); // print current sample first + for ( j = args.nsmp-1; j >= 0; j-- ) + { + if ( (args.bankers[i] ^ (1<= 0; s--) + { + fprintf(fp, "%"PRIu64"\t%s-\n", args.missing_gts[s], bcf_hdr_int2id(args.hdr, BCF_DT_SAMPLE, s)); + } + } + for ( i = 1; i < args.nsmpp2; i++ ) + { + fprintf(fp, "%"PRIu64"\t", args.smp_is[ args.bankers[i] ]); // print out count of genotypes shared by samples in current banker's sequence position + int j = 0; + for ( s = args.nsmp-1; s >= 0; s--) + { + if ( (args.bankers[i]>>s) & 1 ) + { + fprintf(fp, "%s%s", j ? "," : "", bcf_hdr_int2id(args.hdr, BCF_DT_SAMPLE, s) ); // samples in specified order + j = 1; + } + } + fprintf(fp, "\n" ); + } + } + else + { + if ( args.flag & MISSING ) // if missing genotype counts are requested, print them to standard output + { + for ( s = args.nsmp-1; s >= 0; s--) + { + fprintf(fp, "%"PRIu64"\n", args.missing_gts[s]); + } + } + for ( i = 1; i < args.nsmpp2; i++ ) + { + fprintf(fp, "%"PRIu64"\n", args.smp_is[ args.bankers[i] ]); // print out count of genotypes shared by samples in current banker's sequence position + } + } + fclose(fp); + + /* freeing up args */ + free(args.gt_arr); + free(args.bankers); + free(args.quick); + if (args.flag & MISSING) free(args.missing_gts); + free(args.smp_is); +} diff --git a/plugins/GTisec.mk b/plugins/GTisec.mk new file mode 100644 index 000000000..58d1cc739 --- /dev/null +++ b/plugins/GTisec.mk @@ -0,0 +1,2 @@ +plugins/GTisec.so: plugins/GTisec.c version.h version.c + $(CC) $(PLUGIN_FLAGS) $(CFLAGS) $(EXTRA_CPPFLAGS) $(CPPFLAGS) $(LDFLAGS) -o $@ version.c $< $(LIBS) diff --git a/test/test.pl b/test/test.pl index 7a54de292..2c353753a 100755 --- a/test/test.pl +++ b/test/test.pl @@ -188,6 +188,14 @@ test_vcf_plugin($opts,in=>'view.GL',out=>'view.PL.vcf',cmd=>'+tag2tag --no-version',args=>'-- -r --gl-to-pl'); test_vcf_plugin($opts,in=>'merge.a',out=>'fill-tags.out',cmd=>'+fill-tags --no-version',args=>'-- -t AN,AC,AC_Hom,AC_Het,AC_Hemi'); test_vcf_plugin($opts,in=>'view',out=>'fill-tags.2.out',cmd=>'+fill-tags --no-version',args=>'-- -t AC,AN,AF,NS'); +test_vcf_plugin($opts,in=>'view',out=>'view.GTisec.out',cmd=>'+GTisec',args=>' | grep -v bcftools'); +test_vcf_plugin($opts,in=>'view',out=>'view.GTisec.H.out',cmd=>'+GTisec',args=>'-- -H | grep -v bcftools'); +test_vcf_plugin($opts,in=>'view',out=>'view.GTisec.Hm.out',cmd=>'+GTisec',args=>'-- -Hm | grep -v bcftools'); +test_vcf_plugin($opts,in=>'view',out=>'view.GTisec.Hmv.out',cmd=>'+GTisec',args=>'-- -Hmv | grep -v bcftools'); +test_vcf_plugin($opts,in=>'view',out=>'view.GTisec.Hv.out',cmd=>'+GTisec',args=>'-- -Hv | grep -v bcftools'); +test_vcf_plugin($opts,in=>'view',out=>'view.GTisec.m.out',cmd=>'+GTisec',args=>'-- -m | grep -v bcftools'); +test_vcf_plugin($opts,in=>'view',out=>'view.GTisec.mv.out',cmd=>'+GTisec',args=>'-- -mv | grep -v bcftools'); +test_vcf_plugin($opts,in=>'view',out=>'view.GTisec.v.out',cmd=>'+GTisec',args=>'-- -v | grep -v bcftools'); test_vcf_concat($opts,in=>['concat.1.a','concat.1.b'],out=>'concat.1.vcf.out',do_bcf=>0,args=>''); test_vcf_concat($opts,in=>['concat.1.a','concat.1.b'],out=>'concat.1.bcf.out',do_bcf=>1,args=>''); test_vcf_concat($opts,in=>['concat.2.a','concat.2.b'],out=>'concat.2.vcf.out',do_bcf=>0,args=>'-a'); diff --git a/test/view.GTisec.H.out b/test/view.GTisec.H.out new file mode 100644 index 000000000..5cf831bb8 --- /dev/null +++ b/test/view.GTisec.H.out @@ -0,0 +1,20 @@ +# This file can be used as input to the subset plotting tools at: +# https://github.com/dlaehnemann/bankers2 +# Genotype intersections across samples: +@SMPS NA00003 NA00002 NA00001 +# Human readable output (-H) was requested. Subset intersection counts are therefore sorted by +# sample and repeated for each contained sample. For each sample, counts are in banker's +# sequence order regarding all other samples. +# [1] Number of shared non-ref genotypes [2] Samples sharing non-ref genotype (GT) +9 NA00003 +1 NA00003,NA00002 +0 NA00003,NA00001 +1 NA00003,NA00002,NA00001 +4 NA00002 +1 NA00002,NA00003 +8 NA00002,NA00001 +1 NA00002,NA00003,NA00001 +5 NA00001 +0 NA00001,NA00003 +8 NA00001,NA00002 +1 NA00001,NA00003,NA00002 diff --git a/test/view.GTisec.Hm.out b/test/view.GTisec.Hm.out new file mode 100644 index 000000000..e70f86b2a --- /dev/null +++ b/test/view.GTisec.Hm.out @@ -0,0 +1,25 @@ +# This file can be used as input to the subset plotting tools at: +# https://github.com/dlaehnemann/bankers2 +# Genotype intersections across samples: +@SMPS NA00003 NA00002 NA00001 +# The first line of each sample contains its count of missing genotypes, with a '-' appended +# to the sample name. +# Human readable output (-H) was requested. Subset intersection counts are therefore sorted by +# sample and repeated for each contained sample. For each sample, counts are in banker's +# sequence order regarding all other samples. +# [1] Number of shared non-ref genotypes [2] Samples sharing non-ref genotype (GT) +4 NA00003- +9 NA00003 +1 NA00003,NA00002 +0 NA00003,NA00001 +1 NA00003,NA00002,NA00001 +1 NA00002- +4 NA00002 +1 NA00002,NA00003 +8 NA00002,NA00001 +1 NA00002,NA00003,NA00001 +1 NA00001- +5 NA00001 +0 NA00001,NA00003 +8 NA00001,NA00002 +1 NA00001,NA00003,NA00002 diff --git a/test/view.GTisec.Hmv.out b/test/view.GTisec.Hmv.out new file mode 100644 index 000000000..e70f86b2a --- /dev/null +++ b/test/view.GTisec.Hmv.out @@ -0,0 +1,25 @@ +# This file can be used as input to the subset plotting tools at: +# https://github.com/dlaehnemann/bankers2 +# Genotype intersections across samples: +@SMPS NA00003 NA00002 NA00001 +# The first line of each sample contains its count of missing genotypes, with a '-' appended +# to the sample name. +# Human readable output (-H) was requested. Subset intersection counts are therefore sorted by +# sample and repeated for each contained sample. For each sample, counts are in banker's +# sequence order regarding all other samples. +# [1] Number of shared non-ref genotypes [2] Samples sharing non-ref genotype (GT) +4 NA00003- +9 NA00003 +1 NA00003,NA00002 +0 NA00003,NA00001 +1 NA00003,NA00002,NA00001 +1 NA00002- +4 NA00002 +1 NA00002,NA00003 +8 NA00002,NA00001 +1 NA00002,NA00003,NA00001 +1 NA00001- +5 NA00001 +0 NA00001,NA00003 +8 NA00001,NA00002 +1 NA00001,NA00003,NA00002 diff --git a/test/view.GTisec.Hv.out b/test/view.GTisec.Hv.out new file mode 100644 index 000000000..5cf831bb8 --- /dev/null +++ b/test/view.GTisec.Hv.out @@ -0,0 +1,20 @@ +# This file can be used as input to the subset plotting tools at: +# https://github.com/dlaehnemann/bankers2 +# Genotype intersections across samples: +@SMPS NA00003 NA00002 NA00001 +# Human readable output (-H) was requested. Subset intersection counts are therefore sorted by +# sample and repeated for each contained sample. For each sample, counts are in banker's +# sequence order regarding all other samples. +# [1] Number of shared non-ref genotypes [2] Samples sharing non-ref genotype (GT) +9 NA00003 +1 NA00003,NA00002 +0 NA00003,NA00001 +1 NA00003,NA00002,NA00001 +4 NA00002 +1 NA00002,NA00003 +8 NA00002,NA00001 +1 NA00002,NA00003,NA00001 +5 NA00001 +0 NA00001,NA00003 +8 NA00001,NA00002 +1 NA00001,NA00003,NA00002 diff --git a/test/view.GTisec.m.out b/test/view.GTisec.m.out new file mode 100644 index 000000000..8d217a5d2 --- /dev/null +++ b/test/view.GTisec.m.out @@ -0,0 +1,20 @@ +# This file can be used as input to the subset plotting tools at: +# https://github.com/dlaehnemann/bankers2 +# Genotype intersections across samples: +@SMPS NA00003 NA00002 NA00001 +# The first 3 lines contain the counts for missing values of each sample in the order provided +# in the SMPS-line above. Intersection counts only start afterwards. +# Subset intersection counts are in global banker's sequence order. +# After exclusive sample counts in order of the SMPS-line, banker's sequence continues with: +# NA00003,NA00002 NA00003,NA00001 ... +# [1] Number of shared non-ref genotypes +4 +1 +1 +9 +4 +5 +1 +0 +8 +1 diff --git a/test/view.GTisec.mv.out b/test/view.GTisec.mv.out new file mode 100644 index 000000000..1772a3b78 --- /dev/null +++ b/test/view.GTisec.mv.out @@ -0,0 +1,20 @@ +# This file can be used as input to the subset plotting tools at: +# https://github.com/dlaehnemann/bankers2 +# Genotype intersections across samples: +@SMPS NA00003 NA00002 NA00001 +# The first 3 lines contain the counts for missing values of each sample in the order provided +# in the SMPS-line above. Intersection counts only start afterwards. +# Subset intersection counts are in global banker's sequence order. +# After exclusive sample counts in order of the SMPS-line, banker's sequence continues with: +# NA00003,NA00002 NA00003,NA00001 ... +# [1] Number of shared non-ref genotypes [2] Samples sharing non-ref genotype (GT) +4 NA00003- +1 NA00002- +1 NA00001- +9 NA00003 +4 NA00002 +5 NA00001 +1 NA00003,NA00002 +0 NA00003,NA00001 +8 NA00002,NA00001 +1 NA00003,NA00002,NA00001 diff --git a/test/view.GTisec.out b/test/view.GTisec.out new file mode 100644 index 000000000..2b2b0f6d7 --- /dev/null +++ b/test/view.GTisec.out @@ -0,0 +1,15 @@ +# This file can be used as input to the subset plotting tools at: +# https://github.com/dlaehnemann/bankers2 +# Genotype intersections across samples: +@SMPS NA00003 NA00002 NA00001 +# Subset intersection counts are in global banker's sequence order. +# After exclusive sample counts in order of the SMPS-line, banker's sequence continues with: +# NA00003,NA00002 NA00003,NA00001 ... +# [1] Number of shared non-ref genotypes +9 +4 +5 +1 +0 +8 +1 diff --git a/test/view.GTisec.v.out b/test/view.GTisec.v.out new file mode 100644 index 000000000..8ec3aa315 --- /dev/null +++ b/test/view.GTisec.v.out @@ -0,0 +1,15 @@ +# This file can be used as input to the subset plotting tools at: +# https://github.com/dlaehnemann/bankers2 +# Genotype intersections across samples: +@SMPS NA00003 NA00002 NA00001 +# Subset intersection counts are in global banker's sequence order. +# After exclusive sample counts in order of the SMPS-line, banker's sequence continues with: +# NA00003,NA00002 NA00003,NA00001 ... +# [1] Number of shared non-ref genotypes [2] Samples sharing non-ref genotype (GT) +9 NA00003 +4 NA00002 +5 NA00001 +1 NA00003,NA00002 +0 NA00003,NA00001 +8 NA00002,NA00001 +1 NA00003,NA00002,NA00001 From 0bed387d08e558d278a3029b876c27f6ca870225 Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Fri, 4 Mar 2016 11:06:44 +0000 Subject: [PATCH 151/211] docs: add some clarification for view filters. fix some typos. closes #357 --- doc/bcftools.txt | 17 +++++++++++++---- 1 file changed, 13 insertions(+), 4 deletions(-) diff --git a/doc/bcftools.txt b/doc/bcftools.txt index 6b771dfe7..a37132efa 100644 --- a/doc/bcftools.txt +++ b/doc/bcftools.txt @@ -169,7 +169,7 @@ specific commands to see if they apply. *-O, --output-type* 'b'|'u'|'z'|'v':: Output compressed BCF ('b'), uncompressed BCF ('u'), compressed VCF ('z'), uncompressed VCF ('v'). Use the -Ou option when piping between bcftools subcommands to speed up - performance by removing unecessary compression/decompression and + performance by removing unnecessary compression/decompression and VCF<-->BCF conversion. *-r, --regions* 'chr'|'chr:pos'|'chr:from-to'|'chr:from-'[,...]:: @@ -607,7 +607,7 @@ demand. The original calling model can be invoked with the *-c* option. genotype calling maximizes likelihood of a particular combination of genotypes for father, mother and the child P(F=i,M=j,C=k) = P(unconstrained) * Pn + P(constrained) * (1-Pn). - By providing three values, the mutation rate Pn is set explictly for SNPs, + By providing three values, the mutation rate Pn is set explicitly for SNPs, deletions and insertions, respectively. If two values are given, the first is interpreted as the mutation rate of SNPs and the second is used to calculate the mutation rate of indels according to their length as @@ -1505,7 +1505,7 @@ file for help. see *<>* *-s, --sample* 'string':: - samply name + sample name *-t, --targets* 'LIST':: see *<>* @@ -1674,7 +1674,7 @@ Transition probabilities: *--AF-tag* 'TAG':: use the specified INFO tag 'TAG' as an allele frequency estimate - instead of the defaul AC and AN tags. Sites which do not have 'TAG' + instead of the default AC and AN tags. Sites which do not have 'TAG' will be skipped. *--AF-file* 'FILE':: @@ -1872,6 +1872,15 @@ Convert between VCF and BCF. Former *bcftools subset*. ==== Filter options: +Note that filter options below dealing with counting the number of alleles +will, for speed, first check for the values of AC and AN in the INFO column to +avoid parsing all the genotype (FORMAT/GT) fields in the VCF. This means +that a filter like '--min-af 0.1' will be based `AC/AN' where AC and AN come +from either INFO/AC and INFO/AN if available or FORMAT/GT if not. It will not +filter on another field like INFO/AF. The '--include' and '--exclude' filter +expressions should instead be used to explicitly filter based on fields in +the INFO column, e.g. '--exclude AF<0.1'. + *-c, --min-ac* 'INT'[':nref'|':alt1'|':minor'|':major'|:'nonmajor']:: minimum allele count (INFO/AC) of sites to be printed. Specifying the type of allele is optional and can be set to From e38a10aea6dd60355d725740008377ab004b8556 Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Fri, 4 Mar 2016 11:07:09 +0000 Subject: [PATCH 152/211] whitespace [minor] --- vcfconvert.c | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/vcfconvert.c b/vcfconvert.c index 94e90e88f..1e60d30a9 100644 --- a/vcfconvert.c +++ b/vcfconvert.c @@ -1309,7 +1309,7 @@ static void usage(void) fprintf(stderr, " --no-version do not append version and command line to the header\n"); fprintf(stderr, " -o, --output output file name [stdout]\n"); fprintf(stderr, " -O, --output-type b: compressed BCF, u: uncompressed BCF, z: compressed VCF, v: uncompressed VCF [v]\n"); - fprintf(stderr, " --threads number of extra output compression threads [0]\n"); + fprintf(stderr, " --threads number of extra output compression threads [0]\n"); fprintf(stderr, "\n"); fprintf(stderr, "GEN/SAMPLE conversion (input/output from IMPUTE2):\n"); fprintf(stderr, " -G, --gensample2vcf <...> |,\n"); From bf38eac19fbaede4fe9c1f2c17c061747c665ab9 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Fri, 4 Mar 2016 16:06:53 +0000 Subject: [PATCH 153/211] norm: should not crash on deletions in telomere N regions which cannot be extended to the left Fixes #385 --- test/norm.fa | 2 ++ test/norm.fa.fai | 1 + test/norm.telomere.out | 5 +++++ test/norm.telomere.vcf | 4 ++++ test/test.pl | 1 + vcfnorm.c | 6 ++++-- 6 files changed, 17 insertions(+), 2 deletions(-) create mode 100644 test/norm.telomere.out create mode 100644 test/norm.telomere.vcf diff --git a/test/norm.fa b/test/norm.fa index 53e6b163f..2eecd7f32 100644 --- a/test/norm.fa +++ b/test/norm.fa @@ -24,3 +24,5 @@ TCCCCTCTTGACCTCTCTCTATTTTTTTTTTTTTTTCTGAGATGGATTTTTGCTCTTGTT GTCTCAAAAAAAAAAAAAAAAAAAAGAAAAG >21 TTTATTATTATTATTATTAAATTGAATTTATTTAGTGTACATACATTCATGTGTATTGTG +>22 +NNNNNNNNNNNNNNNNNNNNNNNNNNNNNN diff --git a/test/norm.fa.fai b/test/norm.fa.fai index 40b06b7c4..da3fb859e 100644 --- a/test/norm.fa.fai +++ b/test/norm.fa.fai @@ -5,3 +5,4 @@ 4 60 985 60 61 5 31 1070 31 32 21 60 1106 60 61 +22 30 1171 30 31 diff --git a/test/norm.telomere.out b/test/norm.telomere.out new file mode 100644 index 000000000..59431fa90 --- /dev/null +++ b/test/norm.telomere.out @@ -0,0 +1,5 @@ +##fileformat=VCFv4.2 +##FILTER= +##contig= +#CHROM POS ID REF ALT QUAL FILTER INFO +22 1 . NN N . . . diff --git a/test/norm.telomere.vcf b/test/norm.telomere.vcf new file mode 100644 index 000000000..55ff94b3d --- /dev/null +++ b/test/norm.telomere.vcf @@ -0,0 +1,4 @@ +##fileformat=VCFv4.2 +##contig= +#CHROM POS ID REF ALT QUAL FILTER INFO +22 17 . NN N . . . diff --git a/test/test.pl b/test/test.pl index 2c353753a..a897afdb3 100755 --- a/test/test.pl +++ b/test/test.pl @@ -103,6 +103,7 @@ test_vcf_norm($opts,in=>'norm.merge.3',out=>'norm.merge.3.out',args=>'-m+'); test_vcf_norm($opts,in=>'norm.merge',out=>'norm.merge.strict.out',args=>'-m+ -s'); test_vcf_norm($opts,in=>'norm.setref',out=>'norm.setref.out',args=>'-Nc s',fai=>'norm'); +test_vcf_norm($opts,in=>'norm.telomere',out=>'norm.telomere.out',fai=>'norm'); test_vcf_view($opts,in=>'view',out=>'view.1.out',args=>'-aUc1 -C1 -s NA00002 -v snps',reg=>''); test_vcf_view($opts,in=>'view',out=>'view.2.out',args=>'-f PASS -Xks NA00003',reg=>'-r20,Y'); test_vcf_view($opts,in=>'view',out=>'view.3.out',args=>'-xs NA00003',reg=>''); diff --git a/vcfnorm.c b/vcfnorm.c index fdac00546..781833ceb 100644 --- a/vcfnorm.c +++ b/vcfnorm.c @@ -296,17 +296,19 @@ static int realign(args_t *args, bcf1_t *line) if ( i>0 && als[i].l==als[0].l && !strcasecmp(als[0].s,als[i].s) ) return ERR_DUP_ALLELE; } - // trim from right int ori_pos = line->pos; while (1) { // is the rightmost base identical in all alleles? + int min_len = als[0].l; for (i=1; in_allele; i++) { if ( als[0].s[ als[0].l-1 ]!=als[i].s[ als[i].l-1 ] ) break; + if ( als[i].l < min_len ) min_len = als[i].l; } if ( i!=line->n_allele ) break; // there are differences, cannot be trimmed + if ( min_len<=1 && line->pos==0 ) break; int pad_from_left = 0; for (i=0; in_allele; i++) // trim all alleles @@ -344,7 +346,7 @@ static int realign(args_t *args, bcf1_t *line) if ( als[0].s[ntrim_left]!=als[i].s[ntrim_left] ) break; if ( min_len > als[i].l - ntrim_left ) min_len = als[i].l - ntrim_left; } - if ( i!=line->n_allele || min_len==1 ) break; // there are differences, cannot be trimmed + if ( i!=line->n_allele || min_len<=1 ) break; // there are differences, cannot be trimmed ntrim_left++; } if ( ntrim_left ) From 2211509a59848f857182723b2fd82f61ee1c054a Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Mon, 14 Mar 2016 16:12:31 +0000 Subject: [PATCH 154/211] impute-info: do calculation with double; only convert to float on insert into VCF --- plugins/impute-info.c | 10 +++++----- 1 file changed, 5 insertions(+), 5 deletions(-) diff --git a/plugins/impute-info.c b/plugins/impute-info.c index c3c74ecea..ad5a0d155 100644 --- a/plugins/impute-info.c +++ b/plugins/impute-info.c @@ -1,6 +1,6 @@ /* plugins/impute-info.c -- adds info metrics to a VCF file. - Copyright (C) 2015 Genome Research Ltd. + Copyright (C) 2015-2016 Genome Research Ltd. Author: Shane McCarthy @@ -121,13 +121,13 @@ bcf1_t *process(bcf1_t *rec) return rec; // require biallelic diploid, return site unchanged } - float esum = 0, e2sum = 0, fsum = 0; + double esum = 0, e2sum = 0, fsum = 0; #define BRANCH(type_t,is_missing,is_vector_end) \ { \ type_t *ptr = (type_t*) buf; \ for (i=0; in_sample; i++) \ { \ - float vals[3] = {0,0,0}; \ + double vals[3] = {0,0,0}; \ for (j=0; j0 && theta<1) ? 1 - (fsum - e2sum) / (2 * (float)nval * theta * (1.0 - theta)) : 1; + double theta = esum / (2 * (double)nval); + float info = (theta>0 && theta<1) ? (float)(1 - (fsum - e2sum) / (2 * (double)nval * theta * (1.0 - theta))) : 1; bcf_update_info_float(out_hdr, rec, "INFO", &info, 1); nrec++; From afecb4e96c3abc188e7fc155e35720e01aa13a81 Mon Sep 17 00:00:00 2001 From: John Marshall Date: Tue, 15 Mar 2016 16:15:48 +0000 Subject: [PATCH 155/211] getopt_long() returns int, not char Much like fgetc() returning EOF, we need to store getopt_long()'s result in an int so that we can reliably check the -1 return value. Hat tip @daviesrob; fixes the usage errors part of #389. --- consensus.c | 2 +- plugins/GTisec.c | 2 +- plugins/color-chrs.c | 2 +- plugins/fill-tags.c | 2 +- plugins/mendelian.c | 2 +- plugins/tag2tag.c | 2 +- plugins/vcf2sex.c | 3 ++- polysomy.c | 3 ++- 8 files changed, 10 insertions(+), 8 deletions(-) diff --git a/consensus.c b/consensus.c index 7a615fef0..051f3536c 100644 --- a/consensus.c +++ b/consensus.c @@ -623,7 +623,7 @@ int main_consensus(int argc, char *argv[]) {"chain",1,0,'c'}, {0,0,0,0} }; - char c; + int c; while ((c = getopt_long(argc, argv, "h?s:1iH:f:o:m:c:",loptions,NULL)) >= 0) { switch (c) diff --git a/plugins/GTisec.c b/plugins/GTisec.c index adfbdb972..eaa0b1521 100644 --- a/plugins/GTisec.c +++ b/plugins/GTisec.c @@ -127,7 +127,7 @@ int init(int argc, char **argv, bcf_hdr_t *in, bcf_hdr_t *out) {0,0,0,0} }; - char c; + int c; while ((c = getopt_long(argc, argv, "?mvHh",loptions,NULL)) >= 0) { switch (c) diff --git a/plugins/color-chrs.c b/plugins/color-chrs.c index 6a9175e70..909065e5c 100644 --- a/plugins/color-chrs.c +++ b/plugins/color-chrs.c @@ -159,7 +159,7 @@ int init(int argc, char **argv, bcf_hdr_t *in, bcf_hdr_t *out) {"unrelated",1,0,'u'}, {0,0,0,0} }; - char c; + int c; while ((c = getopt_long(argc, argv, "?ht:u:p:",loptions,NULL)) >= 0) { switch (c) diff --git a/plugins/fill-tags.c b/plugins/fill-tags.c index 2fff25803..025ac32d5 100644 --- a/plugins/fill-tags.c +++ b/plugins/fill-tags.c @@ -117,7 +117,7 @@ int init(int argc, char **argv, bcf_hdr_t *in, bcf_hdr_t *out) {"tags",1,0,'t'}, {0,0,0,0} }; - char c; + int c; while ((c = getopt_long(argc, argv, "?ht:T:l:cd",loptions,NULL)) >= 0) { switch (c) diff --git a/plugins/mendelian.c b/plugins/mendelian.c index 186e3e512..304a27a7d 100644 --- a/plugins/mendelian.c +++ b/plugins/mendelian.c @@ -100,7 +100,7 @@ int init(int argc, char **argv, bcf_hdr_t *in, bcf_hdr_t *out) {"count",0,0,'c'}, {0,0,0,0} }; - char c; + int c; while ((c = getopt_long(argc, argv, "?ht:T:l:cd",loptions,NULL)) >= 0) { switch (c) diff --git a/plugins/tag2tag.c b/plugins/tag2tag.c index ec8956582..6145a6237 100644 --- a/plugins/tag2tag.c +++ b/plugins/tag2tag.c @@ -83,7 +83,7 @@ int init(int argc, char **argv, bcf_hdr_t *in, bcf_hdr_t *out) {"gl-to-pl",0,0,2}, {0,0,0,0} }; - char c; + int c; while ((c = getopt_long(argc, argv, "?hr",loptions,NULL)) >= 0) { switch (c) diff --git a/plugins/vcf2sex.c b/plugins/vcf2sex.c index ddba74c4d..9cb0ed5dc 100644 --- a/plugins/vcf2sex.c +++ b/plugins/vcf2sex.c @@ -389,7 +389,8 @@ int run(int argc, char **argv) {"background",1,0,'b'}, {0,0,0,0} }; - char c, *tmp, *ploidy_fname = NULL; + char *tmp, *ploidy_fname = NULL; + int c; while ((c = getopt_long(argc, argv, "p:n:g:m:vb:",loptions,NULL)) >= 0) { switch (c) { diff --git a/polysomy.c b/polysomy.c index c5a5394e1..93f41844c 100644 --- a/polysomy.c +++ b/polysomy.c @@ -675,7 +675,8 @@ int main_polysomy(int argc, char *argv[]) {"regions-file",1,0,'R'}, {0,0,0,0} }; - char c, *tmp; + char *tmp; + int c; while ((c = getopt_long(argc, argv, "h?o:vt:T:r:R:s:f:p:c:im:b:n:S:",loptions,NULL)) >= 0) { switch (c) From 3eb4e8ece828c00aa4ebb76dd24255aeab20708b Mon Sep 17 00:00:00 2001 From: John Marshall Date: Wed, 16 Mar 2016 11:08:00 +0000 Subject: [PATCH 156/211] Mark error() as HTS_NORETURN ...as it always calls exit(). Prevents a "'b' may be used uninitialised" warning in plugins/GTisec.c. --- Makefile | 2 +- bcftools.h | 3 ++- 2 files changed, 3 insertions(+), 2 deletions(-) diff --git a/Makefile b/Makefile index b84556523..b1c21440d 100644 --- a/Makefile +++ b/Makefile @@ -129,7 +129,7 @@ endif plugins: $(PLUGINS) -bcftools_h = bcftools.h $(htslib_vcf_h) +bcftools_h = bcftools.h $(htslib_hts_defs_h) $(htslib_vcf_h) call_h = call.h $(htslib_vcf_h) $(htslib_synced_bcf_reader_h) vcmp.h convert_h = convert.h $(htslib_vcf_h) tsv2vcf_h = tsv2vcf.h $(htslib_vcf_h) diff --git a/bcftools.h b/bcftools.h index 6f22272b9..d4e856da7 100644 --- a/bcftools.h +++ b/bcftools.h @@ -26,6 +26,7 @@ THE SOFTWARE. */ #define BCFTOOLS_H #include +#include #include #include @@ -37,7 +38,7 @@ THE SOFTWARE. */ #define FT_STDIN (1<<3) char *bcftools_version(void); -void error(const char *format, ...); +void error(const char *format, ...) HTS_NORETURN; void bcf_hdr_append_version(bcf_hdr_t *hdr, int argc, char **argv, const char *cmd); const char *hts_bcf_wmode(int file_type); From 4c933867d8d30f9d79186dfaca697653e77153a8 Mon Sep 17 00:00:00 2001 From: John Marshall Date: Wed, 16 Mar 2016 11:20:15 +0000 Subject: [PATCH 157/211] Check return codes from bgzf_read() / bgzf_write() calls --- reheader.c | 2 +- vcfconcat.c | 6 +++--- 2 files changed, 4 insertions(+), 4 deletions(-) diff --git a/reheader.c b/reheader.c index 7248cbb4b..0466c16ca 100644 --- a/reheader.c +++ b/reheader.c @@ -243,7 +243,7 @@ static void reheader_vcf_gz(args_t *args) // Output the modified header BGZF *bgzf_out = bgzf_open(args->output_fname ? args->output_fname : "-","w");; - bgzf_write(bgzf_out, hdr.s, hdr.l); + if ( bgzf_write(bgzf_out, hdr.s, hdr.l) < 0 ) error("Can't write BGZF header (code %d)\n", bgzf_out->errcode); free(hdr.s); // Output all remainig data read with the header block diff --git a/vcfconcat.c b/vcfconcat.c index 32421378c..bd6a00a25 100644 --- a/vcfconcat.c +++ b/vcfconcat.c @@ -578,12 +578,12 @@ static void naive_concat(args_t *args) error("Failed to read %s: %s\n", args->fnames[i], strerror(errno)); uint8_t magic[5]; - if ( bgzf_read(fp, magic, 5)<0 ) error("Failed to read the BCF header in %s\n", args->fnames[i]); + if ( bgzf_read(fp, magic, 5) != 5 ) error("Failed to read the BCF header in %s\n", args->fnames[i]); if (strncmp((char*)magic, "BCF\2\2", 5) != 0) error("Invalid BCF magic string in %s\n", args->fnames[i]); - bgzf_read(fp, &tmp.l, 4); + if ( bgzf_read(fp, &tmp.l, 4) != 4 ) error("Failed to read the BCF header in %s\n", args->fnames[i]); hts_expand(char,tmp.l,tmp.m,tmp.s); - bgzf_read(fp, tmp.s, tmp.l); + if ( bgzf_read(fp, tmp.s, tmp.l) != tmp.l ) error("Failed to read the BCF header in %s\n", args->fnames[i]); // write only the first header if ( i==0 ) From 21994b91b382c778d13f882080a36c145cd20f7c Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Thu, 17 Mar 2016 07:37:00 +0000 Subject: [PATCH 158/211] GLs are log10 scaled, not ln scaled. Fixes #394 --- plugins/tag2tag.c | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/plugins/tag2tag.c b/plugins/tag2tag.c index 6145a6237..8178326eb 100644 --- a/plugins/tag2tag.c +++ b/plugins/tag2tag.c @@ -118,7 +118,7 @@ bcf1_t *process(bcf1_t *rec) for (i=0; i Date: Thu, 31 Mar 2016 13:15:13 +0100 Subject: [PATCH 159/211] Fix docs grammar [minor] Obsoletes the rest of debian/1.3-3:debian/patches/spelling.patch --- doc/bcftools.txt | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/doc/bcftools.txt b/doc/bcftools.txt index a37132efa..379a0975a 100644 --- a/doc/bcftools.txt +++ b/doc/bcftools.txt @@ -266,7 +266,7 @@ specific commands to see if they apply. [[annotate]] === bcftools annotate '[OPTIONS]' 'FILE' -This command allows to add or remove annotations. +Add or remove annotations. *-a, --annotations* 'file':: Bgzip-compressed and tabix-indexed file with annotations. The file @@ -1472,7 +1472,7 @@ const char *about(void); // Longer description used by 'bcftools +name -h' const char *usage(void); -// Called once at startup, allows to initialize local variables. +// Called once at startup, allows initialization of local variables. // Return 1 to suppress normal VCF/BCF header output, -1 on critical // errors, 0 otherwise. int init(int argc, char **argv, bcf_hdr_t *in_hdr, bcf_hdr_t *out_hdr); From c45b93d11608504db3bea296ff7868cd9e18651f Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Mon, 18 Apr 2016 14:19:33 +0100 Subject: [PATCH 160/211] docs: clarify use of BED files in --regions-file and --targets-file options Closes #411 --- doc/bcftools.txt | 14 +++++++++----- 1 file changed, 9 insertions(+), 5 deletions(-) diff --git a/doc/bcftools.txt b/doc/bcftools.txt index 379a0975a..c91bb9c2b 100644 --- a/doc/bcftools.txt +++ b/doc/bcftools.txt @@ -179,11 +179,15 @@ specific commands to see if they apply. *-R, --regions-file* 'FILE':: Regions can be specified either on command line or in a VCF, BED, or tab-delimited file (the default). The columns of the tab-delimited file - are: CHROM, POS, and, optionally, POS_TO, where positions are 1-based - and inclusive. Uncompressed files are stored in memory, while - bgzip-compressed and tabix-indexed region files are streamed. Note that - sequence names must match exactly, "chr20" is not the same as "20". - Also note that chromosome ordering in 'FILE' will be respected, + are: CHROM, POS, and, optionally, POS_TO, where positions are 1-based + and inclusive. The columns of the tab-delimited BED file are also + CHROM, POS and POS_TO (trailing columns are ignored), but coordinates + are 0-based, half-open. To indicate that a file be treated as BED rather + than the 1-based tab-delimited file, the file must have the ".bed" or + ".bed.gz" suffix (case-insensitive). Uncompressed files are stored in + memory, while bgzip-compressed and tabix-indexed region files are streamed. + Note that sequence names must match exactly, "chr20" is not the same as + "20". Also note that chromosome ordering in 'FILE' will be respected, the VCF will be processed in the order in which chromosomes first appear in 'FILE'. However, within chromosomes, the VCF will always be processed in ascending genomic coordinate order no matter what order they From ee9905297767ba1f5ab1c8b223e5b39ed39bfdef Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Mon, 18 Apr 2016 14:23:49 +0100 Subject: [PATCH 161/211] docs: update man and html docs --- doc/bcftools.1 | 96 +++++++++++++++++++++++++++++++++++++------ doc/bcftools.html | 101 ++++++++++++++++++++++++++++++++++++++-------- 2 files changed, 168 insertions(+), 29 deletions(-) diff --git a/doc/bcftools.1 b/doc/bcftools.1 index d2783d499..a85c9a1b1 100644 --- a/doc/bcftools.1 +++ b/doc/bcftools.1 @@ -2,12 +2,12 @@ .\" Title: bcftools .\" Author: [see the "AUTHORS" section] .\" Generator: DocBook XSL Stylesheets v1.76.1 -.\" Date: 2015-12-15 14:02 GMT +.\" Date: 2016-04-18 14:18 BST .\" Manual: \ \& .\" Source: \ \& .\" Language: English .\" -.TH "BCFTOOLS" "1" "2015\-12\-15 14:02 GMT" "\ \&" "\ \&" +.TH "BCFTOOLS" "1" "2016\-04\-18 14:18 BST" "\ \&" "\ \&" .\" ----------------------------------------------------------------- .\" * Define some portability stuff .\" ----------------------------------------------------------------- @@ -41,7 +41,7 @@ Most commands accept VCF, bgzipped VCF and BCF with filetype detected automatica BCFtools is designed to work on a stream\&. It regards an input file "\-" as the standard input (stdin) and outputs to the standard output (stdout)\&. Several commands can thus be combined with Unix pipes\&. .SS "VERSION" .sp -This manual page was last updated \fB2015\-12\-15 14:02 GMT\fR and refers to bcftools git version \fB1\&.2\-191\-g6737c5c+\fR\&. +This manual page was last updated \fB2016\-04\-18 14:18 BST\fR and refers to bcftools git version \fB1\&.3\-36\-g47e811c+\fR\&. .SS "BCF1" .sp The BCF1 format output by versions of samtools <= 0\&.1\&.19 is \fBnot\fR compatible with this version of bcftools\&. To read BCF1 files one can use the view command from old versions of bcftools packaged with samtools versions <= 0\&.1\&.19 to convert to VCF, which can then be read by this version of bcftools\&. @@ -393,6 +393,11 @@ Skip sites where FILTER column does not contain any of the strings listed in \fI\&.,PASS\fR\&. .RE .PP +\fB\-\-no\-version\fR +.RS 4 +Do not append version and command line information to the output VCF header\&. +.RE +.PP \fB\-o, \-\-output\fR \fIFILE\fR .RS 4 When output consists of a single stream, write it to @@ -402,7 +407,7 @@ rather than to standard output, where it is written by default\&. .PP \fB\-O, \-\-output\-type\fR \fIb\fR|\fIu\fR|\fIz\fR|\fIv\fR .RS 4 -Output compressed BCF (\fIb\fR), uncompressed BCF (\fIu\fR), compressed VCF (\fIz\fR), uncompressed VCF (\fIv\fR)\&. Use the \-Ou option when piping between bcftools subcommands to speed up performance by removing unecessary compression/decompression and VCF←→BCF conversion\&. +Output compressed BCF (\fIb\fR), uncompressed BCF (\fIu\fR), compressed VCF (\fIz\fR), uncompressed VCF (\fIv\fR)\&. Use the \-Ou option when piping between bcftools subcommands to speed up performance by removing unnecessary compression/decompression and VCF←→BCF conversion\&. .RE .PP \fB\-r, \-\-regions\fR \fIchr\fR|\fIchr:pos\fR|\fIchr:from\-to\fR|\fIchr:from\-\fR[,\&...] @@ -416,7 +421,7 @@ cannot be used in combination with .PP \fB\-R, \-\-regions\-file\fR \fIFILE\fR .RS 4 -Regions can be specified either on command line or in a VCF, BED, or tab\-delimited file (the default)\&. The columns of the tab\-delimited file are: CHROM, POS, and, optionally, POS_TO, where positions are 1\-based and inclusive\&. Uncompressed files are stored in memory, while bgzip\-compressed and tabix\-indexed region files are streamed\&. Note that sequence names must match exactly, "chr20" is not the same as "20"\&. Also note that chromosome ordering in +Regions can be specified either on command line or in a VCF, BED, or tab\-delimited file (the default)\&. The columns of the tab\-delimited file are: CHROM, POS, and, optionally, POS_TO, where positions are 1\-based and inclusive\&. The columns of the tab\-delimited BED file are also CHROM, POS and POS_TO (trailing columns are ignored), but coordinates are 0\-based, half\-open\&. To indicate that a file be treated as BED rather than the 1\-based tab\-delimited file, the file must have the "\&.bed" or "\&.bed\&.gz" suffix (case\-insensitive)\&. Uncompressed files are stored in memory, while bgzip\-compressed and tabix\-indexed region files are streamed\&. Note that sequence names must match exactly, "chr20" is not the same as "20"\&. Also note that chromosome ordering in \fIFILE\fR will be respected, the VCF will be processed in the order in which chromosomes first appear in \fIFILE\fR\&. However, within chromosomes, the VCF will always be processed in ascending genomic coordinate order no matter what order they appear in @@ -546,7 +551,7 @@ or .RE .SS "bcftools annotate \fI[OPTIONS]\fR \fIFILE\fR" .sp -This command allows to add or remove annotations\&. +Add or remove annotations\&. .PP \fB\-a, \-\-annotations\fR \fIfile\fR .RS 4 @@ -637,6 +642,12 @@ annotate sites which are present ("+") or absent ("\-") in the file with a new INFO/TAG flag .RE .PP +\fB\-\-no\-version\fR +.RS 4 +see +\fBCommon Options\fR +.RE +.PP \fB\-o, \-\-output\fR \fIFILE\fR .RS 4 see @@ -861,6 +872,12 @@ This command replaces the former \fBbcftools view\fR caller\&. Some of the origi \fBFile format options:\fR .RS 4 .PP +\fB\-\-no\-version\fR +.RS 4 +see +\fBCommon Options\fR +.RE +.PP \fB\-o, \-\-output\fR \fIFILE\fR .RS 4 see @@ -1041,7 +1058,7 @@ calling model (conflicts with likelihood of novel mutation for constrained \fB\-C\fR \fItrio\fR -calling\&. The trio genotype calling maximizes likelihood of a particular combination of genotypes for father, mother and the child P(F=i,M=j,C=k) = P(unconstrained) * Pn + P(constrained) * (1\-Pn)\&. By providing three values, the mutation rate Pn is set explictly for SNPs, deletions and insertions, respectively\&. If two values are given, the first is interpreted as the mutation rate of SNPs and the second is used to calculate the mutation rate of indels according to their length as Pn=\fIfloat\fR*exp(\-a\-b*len), where a=22\&.8689, b=0\&.2994 for insertions and a=21\&.9313, b=0\&.2856 for deletions [pubmed:23975140]\&. If only one value is given, the same mutation rate Pn is used for SNPs and indels\&. +calling\&. The trio genotype calling maximizes likelihood of a particular combination of genotypes for father, mother and the child P(F=i,M=j,C=k) = P(unconstrained) * Pn + P(constrained) * (1\-Pn)\&. By providing three values, the mutation rate Pn is set explicitly for SNPs, deletions and insertions, respectively\&. If two values are given, the first is interpreted as the mutation rate of SNPs and the second is used to calculate the mutation rate of indels according to their length as Pn=\fIfloat\fR*exp(\-a\-b*len), where a=22\&.8689, b=0\&.2994 for insertions and a=21\&.9313, b=0\&.2856 for deletions [pubmed:23975140]\&. If only one value is given, the same mutation rate Pn is used for SNPs and indels\&. .RE .PP \fB\-p, \-\-pval\-threshold\fR \fIfloat\fR @@ -1076,7 +1093,7 @@ haploid output for males and skips females (requires PED file with .RE .SS "bcftools concat \fI[OPTIONS]\fR \fIFILE1\fR \fIFILE2\fR [\&...]" .sp -Concatenate or combine VCF/BCF files\&. All source files must have the same sample columns appearing in the same order\&. Can be used, for example, to concatenate chromosome VCFs into one VCF, or combine a SNP VCF and an indel VCF into one\&. The input files must be sorted by chr and position\&. The files must be given in the correct order to produce sorted VCF on output unless the \fB\-a, \-\-allow\-overlaps\fR option is specified\&. +Concatenate or combine VCF/BCF files\&. All source files must have the same sample columns appearing in the same order\&. Can be used, for example, to concatenate chromosome VCFs into one VCF, or combine a SNP VCF and an indel VCF into one\&. The input files must be sorted by chr and position\&. The files must be given in the correct order to produce sorted VCF on output unless the \fB\-a, \-\-allow\-overlaps\fR option is specified\&. With the \-\-naive option, the files are concatenated without being recompressed, which is very fast but dangerous if the BCF headers differ\&. .PP \fB\-a, \-\-allow\-overlaps\fR .RS 4 @@ -1110,6 +1127,17 @@ Read the list of files from a file\&. Ligate phased VCFs by matching phase at overlapping haplotypes .RE .PP +\fB\-\-no\-version\fR +.RS 4 +see +\fBCommon Options\fR +.RE +.PP +\fB\-n, \-\-naive\fR +.RS 4 +Concatenate BCF files without recompression\&. This is very fast but requires that all files have the same headers\&. This is because all tags and chromosome names in the BCF body rely on the implicit order of the contig and tag definitions in the header\&. Currently no sanity checks are in place and only works for compressed BCF files\&. Dangerous, use with caution\&. +.RE +.PP \fB\-o, \-\-output\fR \fIFILE\fR .RS 4 see @@ -1273,6 +1301,12 @@ see \fBVCF output options:\fR .RS 4 .PP +\fB\-\-no\-version\fR +.RS 4 +see +\fBCommon Options\fR +.RE +.PP \fB\-o, \-\-output\fR \fIFILE\fR .RS 4 see @@ -1593,6 +1627,12 @@ is true\&. For valid expressions see define behaviour at sites with existing FILTER annotations\&. The default mode replaces existing filters of failed sites with a new FILTER string while leaving sites which pass untouched when non\-empty and setting to "PASS" when the FILTER string is absent\&. The "+" mode appends new FILTER strings of failed sites instead of replacing them\&. The "x" mode resets filters of sites which pass to "PASS"\&. Modes "+" and "x" can both be set\&. .RE .PP +\fB\-\-no\-version\fR +.RS 4 +see +\fBCommon Options\fR +.RE +.PP \fB\-o, \-\-output\fR \fIFILE\fR .RS 4 see @@ -1641,6 +1681,12 @@ see see \fBCommon Options\fR .RE +.PP +\fB\-\-threads\fR \fIINT\fR +.RS 4 +see +\fBCommon Options\fR +.RE .SS "bcftools gtcheck [\fIOPTIONS\fR] [\-g \fIgenotypes\&.vcf\&.gz\fR] \fIquery\&.vcf\&.gz\fR" .sp Checks sample identity or, without \fB\-g\fR, multi\-sample cross\-check is performed\&. @@ -2066,6 +2112,12 @@ The option controls what types of multiallelic records can be created: .RE .\} .PP +\fB\-\-no\-version\fR +.RS 4 +see +\fBCommon Options\fR +.RE +.PP \fB\-o, \-\-output\fR \fIFILE\fR .RS 4 see @@ -2142,6 +2194,12 @@ split multiallelic sites into biallelic records (\fI\-\fR) or join biallelic sit \fIany\fR\&. .RE .PP +\fB\-\-no\-version\fR +.RS 4 +see +\fBCommon Options\fR +.RE +.PP \fB\-N, \-\-do\-not\-normalize\fR .RS 4 the @@ -2264,6 +2322,12 @@ see \fBVCF output options:\fR .RS 4 .PP +\fB\-\-no\-version\fR +.RS 4 +see +\fBCommon Options\fR +.RE +.PP \fB\-o, \-\-output\fR \fIFILE\fR .RS 4 see @@ -2512,7 +2576,7 @@ const char *about(void); // Longer description used by \*(Aqbcftools +name \-h\*(Aq const char *usage(void); -// Called once at startup, allows to initialize local variables\&. +// Called once at startup, allows initialization of local variables\&. // Return 1 to suppress normal VCF/BCF header output, \-1 on critical // errors, 0 otherwise\&. int init(int argc, char **argv, bcf_hdr_t *in_hdr, bcf_hdr_t *out_hdr); @@ -2558,7 +2622,7 @@ see .PP \fB\-s, \-\-sample\fR \fIstring\fR .RS 4 -samply name +sample name .RE .PP \fB\-t, \-\-targets\fR \fILIST\fR @@ -2781,7 +2845,7 @@ see .PP \fB\-s, \-\-samples\fR \fIFILE\fR .RS 4 -new sample names, one name per line, in the same order as they appear in the VCF file\&. Alternatively, only samples which need to be renamed can be listed as "old_name new_name\en" pairs separated by whitespaces, each on separate line\&. +new sample names, one name per line, in the same order as they appear in the VCF file\&. Alternatively, only samples which need to be renamed can be listed as "old_name new_name\en" pairs separated by whitespaces, each on a separate line\&. If a sample name contains spaces, the spaces can be escaped using the backslash character, for example "Not\e a\e good\e sample\e name"\&. .RE .SS "bcftools roh [\fIOPTIONS\fR] \fIfile\&.vcf\&.gz\fR" .sp @@ -2841,7 +2905,7 @@ in case allele frequency is not known, use the .RS 4 use the specified INFO tag \fITAG\fR -as an allele frequency estimate instead of the defaul AC and AN tags\&. Sites which do not have +as an allele frequency estimate instead of the default AC and AN tags\&. Sites which do not have \fITAG\fR will be skipped\&. .RE @@ -3098,6 +3162,12 @@ suppress the header in VCF output compression level\&. 0 stands for uncompressed, 1 for best speed and 9 for best compression\&. .RE .PP +\fB\-\-no\-version\fR +.RS 4 +see +\fBCommon Options\fR +.RE +.PP \fB\-O, \-\-output\-type\fR \fIb\fR|\fIu\fR|\fIz\fR|\fIv\fR .RS 4 see @@ -3180,6 +3250,8 @@ see .ps +1 \fBFilter options:\fR .RS 4 +.sp +Note that filter options below dealing with counting the number of alleles will, for speed, first check for the values of AC and AN in the INFO column to avoid parsing all the genotype (FORMAT/GT) fields in the VCF\&. This means that a filter like \fI\-\-min\-af 0\&.1\fR will be based \(oqAC/AN\(cq where AC and AN come from either INFO/AC and INFO/AN if available or FORMAT/GT if not\&. It will not filter on another field like INFO/AF\&. The \fI\-\-include\fR and \fI\-\-exclude\fR filter expressions should instead be used to explicitly filter based on fields in the INFO column, e\&.g\&. \fI\-\-exclude AF<0\&.1\fR\&. .PP \fB\-c, \-\-min\-ac\fR \fIINT\fR[\fI:nref\fR|\fI:alt1\fR|\fI:minor\fR|\fI:major\fR|:\*(Aqnonmajor\*(Aq] .RS 4 diff --git a/doc/bcftools.html b/doc/bcftools.html index 012d67017..d089aec16 100644 --- a/doc/bcftools.html +++ b/doc/bcftools.html @@ -1,6 +1,6 @@ -bcftools

    Name

    bcftools — utilities for variant calling and manipulating VCFs and BCFs.

    Synopsis

    bcftools [--version|--version-only] [--help] [COMMAND] [OPTIONS]

    DESCRIPTION

    BCFtools is a set of utilities that manipulate variant calls in the Variant +bcftools

    Name

    bcftools — utilities for variant calling and manipulating VCFs and BCFs.

    Synopsis

    bcftools [--version|--version-only] [--help] [COMMAND] [OPTIONS]

    DESCRIPTION

    BCFtools is a set of utilities that manipulate variant calls in the Variant Call Format (VCF) and its binary counterpart BCF. All commands work transparently with both VCFs and BCFs, both uncompressed and BGZF-compressed.

    Most commands accept VCF, bgzipped VCF and BCF with filetype detected automatically even when streaming from a pipe. Indexed VCF and BCF @@ -8,7 +8,7 @@ work in most, but not all situations. In general, whenever multiple VCFs are read simultaneously, they must be indexed and therefore also compressed.

    BCFtools is designed to work on a stream. It regards an input file "-" as the standard input (stdin) and outputs to the standard output (stdout). Several -commands can thus be combined with Unix pipes.

    VERSION

    This manual page was last updated 2015-12-15 14:02 GMT and refers to bcftools git version 1.2-191-g6737c5c+.

    BCF1

    The BCF1 format output by versions of samtools <= 0.1.19 is not +commands can thus be combined with Unix pipes.

    VERSION

    This manual page was last updated 2016-04-18 14:18 BST and refers to bcftools git version 1.3-36-g47e811c+.

    BCF1

    The BCF1 format output by versions of samtools <= 0.1.19 is not compatible with this version of bcftools. To read BCF1 files one can use the view command from old versions of bcftools packaged with samtools versions <= 0.1.19 to convert to VCF, which can then be read by @@ -117,6 +117,10 @@ in LIST. For example, to include only sites which have no filters set, use -f .,PASS.

    +--no-version +
    + Do not append version and command line information to the output VCF header. +
    -o, --output FILE
    When output consists of a single stream, write it to FILE rather than @@ -126,7 +130,7 @@
    Output compressed BCF (b), uncompressed BCF (u), compressed VCF (z), uncompressed VCF (v). Use the -Ou option when piping between bcftools subcommands to speed up - performance by removing unecessary compression/decompression and + performance by removing unnecessary compression/decompression and VCF←→BCF conversion.
    -r, --regions chr|chr:pos|chr:from-to|chr:from-[,…] @@ -138,11 +142,15 @@
    Regions can be specified either on command line or in a VCF, BED, or tab-delimited file (the default). The columns of the tab-delimited file - are: CHROM, POS, and, optionally, POS_TO, where positions are 1-based - and inclusive. Uncompressed files are stored in memory, while - bgzip-compressed and tabix-indexed region files are streamed. Note that - sequence names must match exactly, "chr20" is not the same as "20". - Also note that chromosome ordering in FILE will be respected, + are: CHROM, POS, and, optionally, POS_TO, where positions are 1-based + and inclusive. The columns of the tab-delimited BED file are also + CHROM, POS and POS_TO (trailing columns are ignored), but coordinates + are 0-based, half-open. To indicate that a file be treated as BED rather + than the 1-based tab-delimited file, the file must have the ".bed" or + ".bed.gz" suffix (case-insensitive). Uncompressed files are stored in + memory, while bgzip-compressed and tabix-indexed region files are streamed. + Note that sequence names must match exactly, "chr20" is not the same as + "20". Also note that chromosome ordering in FILE will be respected, the VCF will be processed in the order in which chromosomes first appear in FILE. However, within chromosomes, the VCF will always be processed in ascending genomic coordinate order no matter what order they @@ -217,7 +225,7 @@
    Number of output compression threads to use in addition to main thread. Only used when --output-type is b or z. Default: 0. -

    bcftools annotate [OPTIONS] FILE

    This command allows to add or remove annotations.

    +

    bcftools annotate [OPTIONS] FILE

    Add or remove annotations.

    -a, --annotations file
    Bgzip-compressed and tabix-indexed file with annotations. The file @@ -288,6 +296,10 @@
    annotate sites which are present ("+") or absent ("-") in the -a file with a new INFO/TAG flag
    +--no-version +
    + see Common Options +
    -o, --output FILE
    see Common Options @@ -450,6 +462,10 @@ functionality has been temporarily lost in the process of transition under htslib, but will be added back on popular demand. The original calling model can be invoked with the -c option.

    File format options:

    +--no-version +
    + see Common Options +
    -o, --output FILE
    see Common Options @@ -566,7 +582,7 @@ genotype calling maximizes likelihood of a particular combination of genotypes for father, mother and the child P(F=i,M=j,C=k) = P(unconstrained) * Pn + P(constrained) * (1-Pn). - By providing three values, the mutation rate Pn is set explictly for SNPs, + By providing three values, the mutation rate Pn is set explicitly for SNPs, deletions and insertions, respectively. If two values are given, the first is interpreted as the mutation rate of SNPs and the second is used to calculate the mutation rate of indels according to their length as @@ -598,7 +614,9 @@ concatenate chromosome VCFs into one VCF, or combine a SNP VCF and an indel VCF into one. The input files must be sorted by chr and position. The files must be given in the correct order to produce sorted VCF on output unless -the -a, --allow-overlaps option is specified.

    +the -a, --allow-overlaps option is specified. With the --naive option, the files +are concatenated without being recompressed, which is very fast but dangerous +if the BCF headers differ.

    -a, --allow-overlaps
    First coordinate of the next file can precede last record of the current file. @@ -624,6 +642,18 @@
    Ligate phased VCFs by matching phase at overlapping haplotypes
    +--no-version +
    + see Common Options +
    +-n, --naive +
    + Concatenate BCF files without recompression. This is very fast but requires + that all files have the same headers. This is because all tags and + chromosome names in the BCF body rely on the implicit order of the contig + and tag definitions in the header. Currently no sanity checks + are in place and only works for compressed BCF files. Dangerous, use with caution. +
    -o, --output FILE
    see Common Options @@ -714,6 +744,10 @@
    see Common Options

    VCF output options:

    +--no-version +
    + see Common Options +
    -o, --output FILE
    see Common Options @@ -907,6 +941,10 @@ strings of failed sites instead of replacing them. The "x" mode resets filters of sites which pass to "PASS". Modes "+" and "x" can both be set.
    +--no-version +
    + see Common Options +
    -o, --output FILE
    see Common Options @@ -937,6 +975,10 @@ see Common Options
    -T, --targets-file file +
    + see Common Options +
    +--threads INT
    see Common Options

    bcftools gtcheck [OPTIONS] [-g genotypes.vcf.gz] query.vcf.gz

    Checks sample identity or, without -g, multi-sample cross-check is performed.

    @@ -1165,6 +1207,10 @@ -m both .. both SNP and indel records can be multiallelic -m all .. SNP records can be merged with indel records -m id .. merge by ID
    +--no-version +
    + see Common Options +
    -o, --output FILE
    see Common Options @@ -1223,6 +1269,10 @@ both; if SNPs and indels should be merged into a single record, specify any.
    +--no-version +
    + see Common Options +
    -N, --do-not-normalize
    the -c s option can be used to fix or set the REF allele from the @@ -1292,6 +1342,10 @@
    see Common Options

    VCF output options:

    +--no-version +
    + see Common Options +
    -o, --output FILE
    see Common Options @@ -1400,7 +1454,7 @@ // Longer description used by 'bcftools +name -h' const char *usage(void); -// Called once at startup, allows to initialize local variables. +// Called once at startup, allows initialization of local variables. // Return 1 to suppress normal VCF/BCF header output, -1 on critical // errors, 0 otherwise. int init(int argc, char **argv, bcf_hdr_t *in_hdr, bcf_hdr_t *out_hdr); @@ -1427,7 +1481,7 @@
    -s, --sample string
    - samply name + sample name
    -t, --targets LIST
    @@ -1561,8 +1615,10 @@
    new sample names, one name per line, in the same order as they appear in the VCF file. Alternatively, only samples which need to be renamed - can be listed as "old_name new_name\n" pairs separated by - whitespaces, each on separate line. + can be listed as "old_name new_name\n" pairs separated by whitespaces, + each on a separate line. If a sample name contains spaces, the + spaces can be escaped using the backslash character, for example + "Not\ a\ good\ sample\ name".

    bcftools roh [OPTIONS] file.vcf.gz

    A program for detecting runs of homo/autozygosity. Only bi-allelic sites are considered.

    The HMM model:

    Notation:
       D  = Data, AZ = autozygosity, HW = Hardy-Weinberg (non-autozygosity),
    @@ -1590,7 +1646,7 @@
     --AF-tag TAG
     
    use the specified INFO tag TAG as an allele frequency estimate - instead of the defaul AC and AN tags. Sites which do not have TAG + instead of the default AC and AN tags. Sites which do not have TAG will be skipped.
    --AF-file FILE @@ -1759,6 +1815,10 @@ compression level. 0 stands for uncompressed, 1 for best speed and 9 for best compression.
    +--no-version +
    + see Common Options +
    -O, --output-type b|u|z|v
    see Common Options @@ -1803,7 +1863,14 @@ -S, --samples-file FILE
    see Common Options -

    Filter options:

    +

    Filter options:

    Note that filter options below dealing with counting the number of alleles +will, for speed, first check for the values of AC and AN in the INFO column to +avoid parsing all the genotype (FORMAT/GT) fields in the VCF. This means +that a filter like --min-af 0.1 will be based ‘AC/AN’ where AC and AN come +from either INFO/AC and INFO/AN if available or FORMAT/GT if not. It will not +filter on another field like INFO/AF. The --include and --exclude filter +expressions should instead be used to explicitly filter based on fields in +the INFO column, e.g. --exclude AF<0.1.

    -c, --min-ac INT[:nref|:alt1|:minor|:major|:'nonmajor']
    minimum allele count (INFO/AC) of sites to be printed. From 77e76e5c378f9b299a23f22fe66be345e1790341 Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Fri, 29 Apr 2016 09:00:15 +0100 Subject: [PATCH 162/211] filter: fix bug with uninitialised key Fixes #406 --- filter.c | 2 +- test/query.24.out | 3 +++ test/test.pl | 1 + 3 files changed, 5 insertions(+), 1 deletion(-) create mode 100644 test/query.24.out diff --git a/filter.c b/filter.c index c56ae6d12..4ffaec34a 100644 --- a/filter.c +++ b/filter.c @@ -1511,7 +1511,7 @@ filter_t *filter_init(bcf_hdr_t *hdr, const char *str) // Look for j="." and k numeric type int j = i-1, k = i-2; if ( !out[j].is_str ) { k = i-1, j = i-2; } - if ( out[k].hdr_id>0 && out[j].is_str && !strcmp(".",out[j].key) ) + if ( out[k].hdr_id>0 && out[j].is_str && out[j].key && !strcmp(".",out[j].key) ) { int type = bcf_hdr_id2type(filter->hdr,out[k].type,out[k].hdr_id); if ( type==BCF_HT_INT ) { out[j].is_str = 0; out[j].is_missing = 1; bcf_float_set_missing(out[j].values[0]); } diff --git a/test/query.24.out b/test/query.24.out new file mode 100644 index 000000000..0fb1c83a4 --- /dev/null +++ b/test/query.24.out @@ -0,0 +1,3 @@ +3000003 . +3000004 xxx +3000005 .. diff --git a/test/test.pl b/test/test.pl index a897afdb3..e7d7416c3 100755 --- a/test/test.pl +++ b/test/test.pl @@ -94,6 +94,7 @@ test_vcf_query($opts,in=>'missing',out=>'query.23.out',args=>q[-i'ISTR!="."' -f'%POS %ISTR\\n']); test_vcf_query($opts,in=>'missing',out=>'query.23.out',args=>q[-e'ISTR="."' -f'%POS %ISTR\\n']); test_vcf_query($opts,in=>'missing',out=>'query.22.out',args=>q[-e'ISTR!="."' -f'%POS %ISTR\\n']); +test_vcf_query($opts,in=>'missing',out=>'query.24.out',args=>q[-i'FILTER="q11"' -f'%POS %ISTR\\n']); test_vcf_norm($opts,in=>'norm',out=>'norm.out',fai=>'norm'); test_vcf_norm($opts,in=>'norm.split',out=>'norm.split.out',args=>'-m-'); test_vcf_norm($opts,in=>'norm.split.2',out=>'norm.split.2.out',args=>'-m-'); From 679c6e68802481bc4865e0969eef3e773a52002a Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Wed, 23 Mar 2016 07:43:10 +0000 Subject: [PATCH 163/211] norm: informative error messages on fields with wrong Number=R,A values Resolves #364 --- vcfnorm.c | 27 ++++++++++++++++++++------- 1 file changed, 20 insertions(+), 7 deletions(-) diff --git a/vcfnorm.c b/vcfnorm.c index 781833ceb..d3b9fee42 100644 --- a/vcfnorm.c +++ b/vcfnorm.c @@ -390,18 +390,24 @@ static void split_info_numeric(args_t *args, bcf1_t *src, bcf_info_t *info, int int len = bcf_hdr_id2length(args->hdr,BCF_HL_INFO,info->key); \ if ( len==BCF_VL_A ) \ { \ - assert( ret==src->n_allele-1); \ + if ( ret!=src->n_allele-1 ) \ + error("Error: wrong number of fields in INFO/%s at %s:%d, expected %d, found %d\n", \ + tag,bcf_seqname(args->hdr,src),src->pos+1,src->n_allele-1,ret); \ bcf_update_info_##type(args->hdr,dst,tag,vals+ialt,1); \ } \ else if ( len==BCF_VL_R ) \ { \ - assert( ret==src->n_allele); \ + if ( ret!=src->n_allele ) \ + error("Error: wrong number of fields in INFO/%s at %s:%d, expected %d, found %d\n", \ + tag,bcf_seqname(args->hdr,src),src->pos+1,src->n_allele,ret); \ if ( ialt!=0 ) vals[1] = vals[ialt+1]; \ bcf_update_info_##type(args->hdr,dst,tag,vals,2); \ } \ else if ( len==BCF_VL_G ) \ { \ - assert( ret==src->n_allele*(src->n_allele+1)/2 ); \ + if ( ret!=src->n_allele*(src->n_allele+1)/2 ) \ + error("Error: wrong number of fields in INFO/%s at %s:%d, expected %d, found %d\n", \ + tag,bcf_seqname(args->hdr,src),src->pos+1,src->n_allele*(src->n_allele+1)/2,ret); \ if ( ialt!=0 ) \ { \ vals[1] = vals[bcf_alleles2gt(0,ialt+1)]; \ @@ -545,7 +551,9 @@ static void split_format_numeric(args_t *args, bcf1_t *src, bcf_fmt_t *fmt, int } \ if ( len==BCF_VL_A ) \ { \ - assert( nvals==(src->n_allele-1)*nsmpl); \ + if ( nvals!=(src->n_allele-1)*nsmpl ) \ + error("Error: wrong number of fields in FMT/%s at %s:%d, expected %d, found %d\n", \ + tag,bcf_seqname(args->hdr,src),src->pos+1,(src->n_allele-1)*nsmpl,nvals); \ nvals /= nsmpl; \ type_t *src_vals = vals, *dst_vals = vals; \ for (i=0; in_allele*nsmpl); \ + if ( nvals!=src->n_allele*nsmpl ) \ + error("Error: wrong number of fields in FMT/%s at %s:%d, expected %d, found %d\n", \ + tag,bcf_seqname(args->hdr,src),src->pos+1,src->n_allele*nsmpl,nvals); \ nvals /= nsmpl; \ type_t *src_vals = vals, *dst_vals = vals; \ for (i=0; in_allele*(src->n_allele+1)/2 || nfields==src->n_allele ); + if ( nfields!=src->n_allele*(src->n_allele+1)/2 && nfields!=src->n_allele ) + error("Error: wrong number of fields in FMT/%s at %s:%d, expected %d or %d, found %d\n", + tag,bcf_seqname(args->hdr,src),src->pos+1,src->n_allele*(src->n_allele+1)/2,src->n_allele,nfields); + int len = 0; if ( nfields==src->n_allele ) // haploid { @@ -994,7 +1007,7 @@ static void merge_format_genotype(args_t *args, bcf1_t **lines, int nlines, bcf_ else { int ial = bcf_gt_allele(gt2[k]); - assert( ialmaps[i].nals ); + if ( ial>=args->maps[i].nals ) error("Error at %s:%d: incorrect allele index %d\n",bcf_seqname(args->hdr,lines[i]),lines[i]->pos+1,ial); gt[k] = bcf_gt_unphased( args->maps[i].map[ial] ) | bcf_gt_is_phased(gt[k]); } } From 8eb3804ac9c133b0dbe5abea960fa6cd4eb0dda0 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Fri, 25 Mar 2016 13:02:52 +0000 Subject: [PATCH 164/211] concat: `--naive` option now works for both bcf and vcf.gz --- test/test.pl | 71 +++++++++++++++++++++++++++++++++++++++---- vcfconcat.c | 86 +++++++++++++++++++++++++++++++++++++++++++--------- 2 files changed, 136 insertions(+), 21 deletions(-) diff --git a/test/test.pl b/test/test.pl index e7d7416c3..dc1fcfa84 100755 --- a/test/test.pl +++ b/test/test.pl @@ -206,6 +206,7 @@ test_vcf_concat($opts,in=>['concat.2.a','concat.2.b'],out=>'concat.4.bcf.out',do_bcf=>1,args=>'-aD'); test_vcf_concat($opts,in=>['concat.3.a','concat.3.b','concat.3.0','concat.3.c','concat.3.d','concat.3.e','concat.3.f'],out=>'concat.3.vcf.out',do_bcf=>0,args=>'-l'); test_vcf_concat($opts,in=>['concat.3.a','concat.3.b','concat.3.0','concat.3.c','concat.3.d','concat.3.e','concat.3.f'],out=>'concat.3.bcf.out',do_bcf=>1,args=>'-l'); +test_naive_concat($opts,name=>'naive_concat',max_hdr_lines=>10000,max_body_lines=>10000,nfiles=>10); test_vcf_reheader($opts,in=>'reheader',out=>'reheader.1.out',header=>'reheader.hdr'); test_vcf_reheader($opts,in=>'reheader',out=>'reheader.2.out',samples=>'reheader.samples'); test_vcf_reheader($opts,in=>'reheader',out=>'reheader.2.out',samples=>'reheader.samples2'); @@ -319,7 +320,7 @@ sub cmd sub test_cmd { my ($opts,%args) = @_; - if ( !exists($args{out}) ) + if ( !exists($args{out}) && !exists($args{exp}) ) { if ( !exists($args{in}) ) { error("FIXME: expected out or in key\n"); } $args{out} = "$args{in}.out"; @@ -348,13 +349,17 @@ sub test_cmd } } my $exp = ''; - if ( open(my $fh,'<',"$$opts{path}/$args{out}") ) + if ( exists($args{exp}) ) { $exp = $args{exp}; } + else { - my @exp = <$fh>; - $exp = join('',@exp); - close($fh); + if ( open(my $fh,'<',"$$opts{path}/$args{out}") ) + { + my @exp = <$fh>; + $exp = join('',@exp); + close($fh); + } + elsif ( !$$opts{redo_outputs} ) { failed($opts,$test,"$$opts{path}/$args{out}: $!"); return; } } - elsif ( !$$opts{redo_outputs} ) { failed($opts,$test,"$$opts{path}/$args{out}: $!"); return; } if ( $exp ne $out ) { @@ -855,3 +860,57 @@ sub test_vcf_consensus_chain test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools consensus $$opts{tmp}/$args{in}.vcf.gz -f $$opts{path}/$args{fa} $args{args} $mask $chain > /dev/null 2>/dev/null; cat $$opts{tmp}/$args{chain}.new"); } +sub test_naive_concat +{ + my ($opts,%args) = @_; + + my $seed = srand(); + print STDERR "Random seed for test_naive_concat: $seed\n"; + + my @files = (); + my $exp = ''; + for (my $n=0; $n<$args{nfiles}; $n++) + { + my $nhdr = 1 + int(rand($args{max_hdr_lines})); + my $nbdy = int(rand($args{max_body_lines})); + my $file = "$$opts{tmp}/$args{name}.$n"; + push @files,$file; + + open(my $fh,'>',"$file.vcf") or error("$file.vcf: $!"); + print $fh "##fileformat=VCFv4.0\n"; + print $fh "##INFO=\n"; + print $fh "##contig=\n"; + for (my $i=0; $i<$nhdr; $i++) + { + my $x = rand; + print $fh "##INFO=\n"; + } + print $fh join("\t",'#CHROM','POS','ID','REF','ALT','QUAL','FILTER','INFO')."\n"; + + # let one of the files have no body + if ( $n!=3 ) + { + for (my $i=1; $i<=$nbdy; $i++) + { + my $x = int(rand(1000)); + my $line = join("\t",'1',$i,'.','A','C','.','.',"DP=$x")."\n"; + print $fh $line; + $exp .= $line; + } + } + close($fh) or error("close failed: $file.vcf"); + } + + for my $file (@files) + { + cmd("$$opts{bin}/bcftools view -Ob -o $file.bcf $file.vcf"); + cmd("$$opts{bin}/bcftools view -Oz -o $file.vcf.gz $file.vcf"); + } + + my $bcfs = join('.bcf ',@files).'.bcf'; + test_cmd($opts,exp=>$exp,cmd=>"$$opts{bin}/bcftools concat --naive $bcfs | $$opts{bin}/bcftools view -H"); + + my $vcfs = join('.vcf.gz ',@files).'.vcf.gz'; + test_cmd($opts,exp=>$exp,cmd=>"$$opts{bin}/bcftools concat --naive $vcfs | $$opts{bin}/bcftools view -H"); +} + diff --git a/vcfconcat.c b/vcfconcat.c index bd6a00a25..e5b1699ed 100644 --- a/vcfconcat.c +++ b/vcfconcat.c @@ -555,6 +555,50 @@ static void concat(args_t *args) } } +int print_vcf_gz_header(BGZF *fp, BGZF *bgzf_out, int print_header, kstring_t *tmp) +{ + char *buffer = (char*) fp->uncompressed_block; + + // Read the header and find the position of the data block + if ( buffer[0]!='#' ) error("Could not parse the header, expected '#', found '%c'\n", buffer[0]); + + int nskip = 1; // end of the header in the current uncompressed block + while (1) + { + if ( buffer[nskip]=='\n' ) + { + nskip++; + if ( nskip>=fp->block_length ) + { + kputsn(buffer,nskip,tmp); + if ( bgzf_read_block(fp) != 0 ) return -1; + if ( !fp->block_length ) break; + nskip = 0; + } + // The header has finished + if ( buffer[nskip]!='#' ) + { + kputsn(buffer,nskip,tmp); + break; + } + } + nskip++; + if ( nskip>=fp->block_length ) + { + kputsn(buffer,fp->block_length,tmp); + if ( bgzf_read_block(fp) != 0 ) return -1; + if ( !fp->block_length ) break; + nskip = 0; + } + } + if ( print_header ) + { + if ( bgzf_write(bgzf_out,tmp->s,tmp->l) != tmp->l ) error("Failed to write %d bytes\n", tmp->l); + tmp->l = 0; + } + return nskip; +} + static void naive_concat(args_t *args) { // only compressed BCF atm @@ -563,38 +607,50 @@ static void naive_concat(args_t *args) const size_t page_size = 32768; char *buf = (char*) malloc(page_size); kstring_t tmp = {0,0,0}; - int i; + int i, file_types = 0; for (i=0; infnames; i++) { htsFile *hts_fp = hts_open(args->fnames[i],"r"); if ( !hts_fp ) error("Failed to open: %s\n", args->fnames[i]); htsFormat type = *hts_get_format(hts_fp); - if ( type.format==vcf ) error("The --naive option currently works only for compressed BCFs, sorry :-/\n"); - if ( type.compression!=bgzf ) error("The --naive option currently works only for compressed BCFs, sorry :-/\n"); + if ( type.compression!=bgzf ) + error("The --naive option works only for compressed BCFs or VCFs, sorry :-/\n"); + file_types |= type.format==vcf ? 1 : 2; + if ( file_types==3 ) + error("The --naive option works only for compressed files of the same type, all BCFs or all VCFs :-/\n"); BGZF *fp = hts_get_bgzfp(hts_fp); if ( !fp || bgzf_read_block(fp) != 0 || !fp->block_length ) error("Failed to read %s: %s\n", args->fnames[i], strerror(errno)); - uint8_t magic[5]; - if ( bgzf_read(fp, magic, 5) != 5 ) error("Failed to read the BCF header in %s\n", args->fnames[i]); - if (strncmp((char*)magic, "BCF\2\2", 5) != 0) error("Invalid BCF magic string in %s\n", args->fnames[i]); + int nskip; + if ( type.format==bcf ) + { + uint8_t magic[5]; + if ( bgzf_read(fp, magic, 5) != 5 ) error("Failed to read the BCF header in %s\n", args->fnames[i]); + if (strncmp((char*)magic, "BCF\2\2", 5) != 0) error("Invalid BCF magic string in %s\n", args->fnames[i]); - if ( bgzf_read(fp, &tmp.l, 4) != 4 ) error("Failed to read the BCF header in %s\n", args->fnames[i]); - hts_expand(char,tmp.l,tmp.m,tmp.s); - if ( bgzf_read(fp, tmp.s, tmp.l) != tmp.l ) error("Failed to read the BCF header in %s\n", args->fnames[i]); + if ( bgzf_read(fp, &tmp.l, 4) != 4 ) error("Failed to read the BCF header in %s\n", args->fnames[i]); + hts_expand(char,tmp.l,tmp.m,tmp.s); + if ( bgzf_read(fp, tmp.s, tmp.l) != tmp.l ) error("Failed to read the BCF header in %s\n", args->fnames[i]); - // write only the first header - if ( i==0 ) + // write only the first header + if ( i==0 ) + { + if ( bgzf_write(bgzf_out, "BCF\2\2", 5) !=5 ) error("Failed to write %d bytes to %s\n", 5,args->output_fname); + if ( bgzf_write(bgzf_out, &tmp.l, 4) !=4 ) error("Failed to write %d bytes to %s\n", 4,args->output_fname); + if ( bgzf_write(bgzf_out, tmp.s, tmp.l) != tmp.l) error("Failed to write %d bytes to %s\n", tmp.l,args->output_fname); + } + nskip = fp->block_offset; + } + else { - if ( bgzf_write(bgzf_out, "BCF\2\2", 5) !=5 ) error("Failed to write %d bytes to %s\n", 5,args->output_fname); - if ( bgzf_write(bgzf_out, &tmp.l, 4) !=4 ) error("Failed to write %d bytes to %s\n", 4,args->output_fname); - if ( bgzf_write(bgzf_out, tmp.s, tmp.l) != tmp.l) error("Failed to write %d bytes to %s\n", tmp.l,args->output_fname); + nskip = print_vcf_gz_header(fp, bgzf_out, i==0?1:0, &tmp); + if ( nskip==-1 ) error("Error reading %s\n", args->fnames[i]); } // Output all non-header data that were read together with the header block - int nskip = fp->block_offset; if ( fp->block_length - nskip > 0 ) { if ( bgzf_write(bgzf_out, fp->uncompressed_block+nskip, fp->block_length-nskip)<0 ) error("Error: %d\n",fp->errcode); From e3ef8dabc4450cd7adbaaafb86840ebbf109ab98 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Wed, 13 Apr 2016 13:12:12 +0100 Subject: [PATCH 165/211] reheader: allow multispace delimiters in `reheader -s` files --- reheader.c | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/reheader.c b/reheader.c index 0466c16ca..69018cd5a 100644 --- a/reheader.c +++ b/reheader.c @@ -89,7 +89,7 @@ static int set_sample_pairs(char **samples, int nsamples, kstring_t *hdr, int id ptr++; } if ( !*ptr ) break; - ptr++; + while ( *ptr && isspace(*ptr) ) ptr++; while ( *ptr ) { if ( *ptr=='\\' && !escaped ) { escaped = 1; ptr++; continue; } From 0c88e1ad361730f235bcb639a05dcb0f1170836d Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Tue, 2 Feb 2016 14:51:59 +0000 Subject: [PATCH 166/211] mcall: trim all `Number=R` tags * remove QS before (unnecessary) trimming so that `mcall_trim_numberR()` works with `call-c` --- mcall.c | 95 ++++++++++++++++++++++++++++----------------------------- 1 file changed, 47 insertions(+), 48 deletions(-) diff --git a/mcall.c b/mcall.c index 495f849a8..9ace3ed5b 100644 --- a/mcall.c +++ b/mcall.c @@ -1,6 +1,6 @@ /* mcall.c -- multiallelic and rare variant calling. - Copyright (C) 2012-2014 Genome Research Ltd. + Copyright (C) 2012-2016 Genome Research Ltd. Author: Petr Danecek @@ -1184,75 +1184,73 @@ static void mcall_trim_PLs(call_t *call, bcf1_t *rec, int nals, int nout_als, in void mcall_trim_numberR(call_t *call, bcf1_t *rec, int nals, int nout_als, int out_als) { - int i, ret; + if ( nals==nout_als ) return; - // at the moment we have DPR,AD,ADF,ADR all Number=R,Type=Integer, - // so only dealing with these cases at the moment + int i,j, nret, size = sizeof(float); + + void *tmp_ori = call->itmp, *tmp_new = call->PLs; // reusing PLs storage which is not used at this point + int ntmp_ori = call->n_itmp, ntmp_new = call->mPLs; + + // INFO fields for (i=0; in_info; i++) { bcf_info_t *info = &rec->d.info[i]; int vlen = bcf_hdr_id2length(call->hdr,BCF_HL_INFO,info->key); - if ( vlen!=BCF_VL_R ) continue; - int type = bcf_hdr_id2type(call->hdr,BCF_HL_INFO,info->key); - if ( type!=BCF_HT_INT ) continue; + if ( vlen!=BCF_VL_R ) continue; // not a Number=R tag + + int type = bcf_hdr_id2type(call->hdr,BCF_HL_INFO,info->key); + const char *key = bcf_hdr_int2id(call->hdr,BCF_DT_ID,info->key); + nret = bcf_get_info_values(call->hdr, rec, key, &tmp_ori, &ntmp_ori, type); + if ( nret<=0 ) continue; - ret = bcf_get_info_int32(call->hdr, rec, bcf_hdr_int2id(call->hdr,BCF_DT_ID,info->key), &call->itmp, &call->n_itmp); - if ( ret>0 ) + if ( nout_als==1 ) + bcf_update_info_int32(call->hdr, rec, key, tmp_ori, 1); // has to be the REF, the order could not change + else { - assert( ret==nals ); - if ( out_als==1 ) - bcf_update_info_int32(call->hdr, rec, bcf_hdr_int2id(call->hdr,BCF_DT_ID,info->key), call->itmp, 1); - else + for (j=0; jals_map[j]==-1 ) continue; // to be dropped - call->PLs[ call->als_map[j] ] = call->itmp[j]; // reusing PLs storage which is not used at this point - } - bcf_update_info_int32(call->hdr, rec, bcf_hdr_int2id(call->hdr,BCF_DT_ID,info->key), call->PLs, nout_als); + int k = call->als_map[j]; + if ( k==-1 ) continue; // to be dropped + memcpy(tmp_new+size*k, tmp_ori+size*j, size); } + bcf_update_info_int32(call->hdr, rec, key, tmp_new, nout_als); } } + // FORMAT fields for (i=0; in_fmt; i++) { bcf_fmt_t *fmt = &rec->d.fmt[i]; int vlen = bcf_hdr_id2length(call->hdr,BCF_HL_FMT,fmt->id); - if ( vlen!=BCF_VL_R ) continue; + if ( vlen!=BCF_VL_R ) continue; // not a Number=R tag + int type = bcf_hdr_id2type(call->hdr,BCF_HL_FMT,fmt->id); - if ( type!=BCF_HT_INT ) continue; + const char *key = bcf_hdr_int2id(call->hdr,BCF_DT_ID,fmt->id); + nret = bcf_get_format_values(call->hdr, rec, key, &tmp_ori, &ntmp_ori, type); + if (nret<=0) continue; + int nsmpl = bcf_hdr_nsamples(call->hdr); - ret = bcf_get_format_int32(call->hdr, rec, bcf_hdr_int2id(call->hdr,BCF_DT_ID,fmt->id), &call->itmp, &call->n_itmp); - if ( ret>0 ) - { - int j, nsmpl = bcf_hdr_nsamples(call->hdr); - int ndp = ret / nsmpl; - assert( ndp==nals ); - if ( out_als==1 ) - { - for (j=0; jPLs[j] = call->itmp[j*ndp]; + assert( nret==nals*nsmpl ); - bcf_update_format_int32(call->hdr, rec, bcf_hdr_int2id(call->hdr,BCF_DT_ID,fmt->id), call->PLs, nsmpl); - } - else + for (j=0; jPLs + j*nout_als; - int32_t *dp_src = call->itmp + j*ndp; - for (k=0; kals_map[k]==-1 ) continue; // to be dropped - dp_dst[ call->als_map[k] ] = dp_src[k]; // reusing PLs storage which is not used at this point - } - } - bcf_update_format_int32(call->hdr, rec, bcf_hdr_int2id(call->hdr,BCF_DT_ID,fmt->id), call->PLs, nsmpl*nout_als); + int l = call->als_map[k]; + if ( l==-1 ) continue; // to be dropped + memcpy(ptr_dst+size*l, ptr_src+size*k, size); } } + bcf_update_format_int32(call->hdr, rec, key, tmp_new, nout_als*nsmpl); } + + call->PLs = (int32_t*) tmp_new; + call->mPLs = ntmp_new; + call->itmp = (int32_t*) tmp_ori; + call->n_itmp = ntmp_ori; } @@ -1423,6 +1421,8 @@ int mcall(call_t *call, bcf1_t *rec) if ( qsum_tot ) for (i=0; iqsum[i] /= qsum_tot; #endif + bcf_update_info_int32(call->hdr, rec, "QS", NULL, 0); // remove QS tag + // Find the best combination of alleles int out_als, nout; if ( nals > 8*sizeof(out_als) ) @@ -1530,7 +1530,6 @@ int mcall(call_t *call, bcf1_t *rec) } bcf_update_info_int32(call->hdr, rec, "I16", NULL, 0); // remove I16 tag - bcf_update_info_int32(call->hdr, rec, "QS", NULL, 0); // remove QS tag return nout; } From 0a5e8f8b6936f5ff93b042eaff269e0e45b20311 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Mon, 25 Apr 2016 08:45:37 +0100 Subject: [PATCH 167/211] call: new `-F, --prior-freqs` option --- call.h | 1 + doc/bcftools.txt | 20 ++++++++++++++++++++ mcall.c | 33 ++++++++++++++++++++++++++++++++- vcfcall.c | 11 ++++++++++- 4 files changed, 63 insertions(+), 2 deletions(-) diff --git a/call.h b/call.h index bbf0a52b4..9254bf67b 100644 --- a/call.h +++ b/call.h @@ -72,6 +72,7 @@ typedef struct double trio_Pm_SNPs, trio_Pm_del, trio_Pm_ins; // P(mendelian) for trio calling, see mcall_call_trio_genotypes() int32_t *ugts, *cgts; // unconstraind and constrained GTs uint32_t output_tags; + char *prior_AN, *prior_AC; // reference panel AF tags (AF=AC/AN) // ccall only double indel_frac, min_perm_p, min_lrt; diff --git a/doc/bcftools.txt b/doc/bcftools.txt index c91bb9c2b..4d1b522a4 100644 --- a/doc/bcftools.txt +++ b/doc/bcftools.txt @@ -571,6 +571,26 @@ demand. The original calling model can be invoked with the *-c* option. GQ and GP fields are supported. For convenience, the fields can be given as lower case letters. +*-F, --prior-freqs* 'AN','AC':: + take advantage of prior knowledge of population allele frequencies. The + workflow looks like this: +---- + # Extract AN,AC values from an existing VCF, such 1000Genomes + bcftools query -f'%CHROM\t%POS\t%REF\t%ALT\t%AN\t%AC\n' 1000Genomes.bcf | bgzip -c > AFs.tab.gz + + # If the tags AN,AC are not already present, use the +fill-AN-AC plugin + bcftools +fill-AN-AC 1000Genomes.bcf | bcftools query -f'%CHROM\t%POS\t%REF\t%ALT\t%AN\t%AC\n' | bgzip -c > AFs.tab.gz + tabix -s1 -b2 -e2 AFs.tab.gz + + # Create a VCF header description, here we name the tags REF_AN,REF_AC + cat AFs.hdr + ##INFO= + ##INFO= + + # Now before calling, stream the raw mpileup output through `bcftools annotate` to add the frequencies + bcftools mpileup [...] -Ou | bcftools annotate -a AFs.tab.gz -h AFs.hdr -c CHROM,POS,REF,ALT,REF_AN,REF_AC -Ou | bcftools call -mv -F REF_AN,REF_AC [...] +---- + *-g, --gvcf* 'INT':: output also gVCF blocks of homozygous REF calls. The parameter 'INT' is the minimum per-sample depth required to include a site in the non-variant diff --git a/mcall.c b/mcall.c index 9ace3ed5b..a9ffe1e8e 100644 --- a/mcall.c +++ b/mcall.c @@ -107,6 +107,16 @@ int calc_Pkij(int fals, int mals, int kals, int fpl, int mpl, int kpl) // static void mcall_init_trios(call_t *call) { + if ( call->prior_AN ) + { + int id = bcf_hdr_id2int(call->hdr,BCF_DT_ID,call->prior_AN); + if ( id==-1 ) error("No such tag \"%s\"\n", call->prior_AN); + if ( !bcf_hdr_idinfo_exists(call->hdr,BCF_HL_FMT,id) ) error("No such FORMAT tag \"%s\"\n", call->prior_AN); + id = bcf_hdr_id2int(call->hdr,BCF_DT_ID,call->prior_AC); + if ( id==-1 ) error("No such tag \"%s\"\n", call->prior_AC); + if ( !bcf_hdr_idinfo_exists(call->hdr,BCF_HL_FMT,id) ) error("No such FORMAT tag \"%s\"\n", call->prior_AC); + } + // 23, 138, 478 possible diploid trio genotypes with 2, 3, 4 alleles call->ntrio[FTYPE_222][2] = 15; call->ntrio[FTYPE_222][3] = 78; call->ntrio[FTYPE_222][4] = 250; call->ntrio[FTYPE_121][2] = 8; call->ntrio[FTYPE_121][3] = 27; call->ntrio[FTYPE_121][4] = 64; @@ -1393,7 +1403,7 @@ int mcall(call_t *call, bcf1_t *rec) #if QS_FROM_PDG estimate_qsum(call, rec); #else - // Get sum of qualities + // Get sum of qualities, serves as an AF estimate, f_x = QS/N in Eq. 1 in call-m math notes. int nqs = bcf_get_info_float(call->hdr, rec, "QS", &call->qsum, &call->nqsum); if ( nqs<=0 ) error("The QS annotation not present at %s:%d\n", bcf_seqname(call->hdr,rec),rec->pos+1); if ( nqs < nals ) @@ -1404,6 +1414,27 @@ int mcall(call_t *call, bcf1_t *rec) hts_expand(float,nals,call->nqsum,call->qsum); for (i=nqs; iqsum[i] = 0; } + + // If available, take into account reference panel AFs + if ( call->prior_AN && bcf_get_info_int32(call->hdr, rec, call->prior_AN ,&call->ac, &call->nac)==1 ) + { + int an = call->ac[0]; + if ( bcf_get_info_int32(call->hdr, rec, call->prior_AC ,&call->ac, &call->nac)==nals-1 ) + { + int ac0 = an; // number of alleles in the reference population + for (i=0; iac[i]==bcf_int32_vector_end ) break; + if ( call->ac[i]==bcf_int32_missing ) continue; + ac0 -= call->ac[i]; + call->qsum[i+1] += call->ac[i]*0.5; + } + if ( ac0<0 ) error("Incorrect %s,%s values at %s:%d\n", call->prior_AN,call->prior_AC,bcf_seqname(call->hdr,rec),rec->pos+1); + call->qsum[0] += ac0*0.5; + for (i=0; iqsum[i] /= nsmpl + 0.5*an; + } + } + float qsum_tot = 0; for (i=0; iqsum[i]; if ( !call->qsum[0] ) diff --git a/vcfcall.c b/vcfcall.c index e5bbf1167..767099216 100644 --- a/vcfcall.c +++ b/vcfcall.c @@ -618,6 +618,7 @@ static void usage(args_t *args) fprintf(stderr, "Input/output options:\n"); fprintf(stderr, " -A, --keep-alts keep all possible alternate alleles at variant sites\n"); fprintf(stderr, " -f, --format-fields output format fields: GQ,GP (lowercase allowed) []\n"); + fprintf(stderr, " -F, --prior-freqs use prior allele frequencies\n"); fprintf(stderr, " -g, --gvcf ,[...] group non-variant sites into gVCF blocks by minimum per-sample DP\n"); fprintf(stderr, " -i, --insert-missed output also sites missed by mpileup but present in -T\n"); fprintf(stderr, " -M, --keep-masked-ref keep sites with masked reference allele (REF=N)\n"); @@ -667,6 +668,7 @@ int main_vcfcall(int argc, char *argv[]) { {"help",no_argument,NULL,'h'}, {"format-fields",required_argument,NULL,'f'}, + {"prior-freqs",required_argument,NULL,'F'}, {"gvcf",required_argument,NULL,'g'}, {"output",required_argument,NULL,'o'}, {"output-type",required_argument,NULL,'O'}, @@ -698,7 +700,7 @@ int main_vcfcall(int argc, char *argv[]) }; char *tmp = NULL; - while ((c = getopt_long(argc, argv, "h?o:O:r:R:s:S:t:T:ANMV:vcmp:C:n:P:f:ig:XY", loptions, NULL)) >= 0) + while ((c = getopt_long(argc, argv, "h?o:O:r:R:s:S:t:T:ANMV:vcmp:C:n:P:f:ig:XYF:", loptions, NULL)) >= 0) { switch (c) { @@ -713,6 +715,13 @@ int main_vcfcall(int argc, char *argv[]) case 'c': args.flag |= CF_CCALL; break; // the original EM based calling method case 'i': args.flag |= CF_INS_MISSED; break; case 'v': args.aux.flag |= CALL_VARONLY; break; + case 'F': + args.aux.prior_AN = optarg; + args.aux.prior_AC = index(optarg,','); + if ( !args.aux.prior_AC ) error("Expected two tags with -F (e.g. AN,AC), got \"%s\"\n",optarg); + *args.aux.prior_AC = 0; + args.aux.prior_AC++; + break; case 'g': args.gvcf = gvcf_init(optarg); if ( !args.gvcf ) error("Could not parse: --gvcf %s\n", optarg); From 4b16ea3888807a33b0b459ed240aca22975e0fad Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Tue, 3 May 2016 09:58:37 +0100 Subject: [PATCH 168/211] docs: fix up alphabetic order of commands in docs cnv>call --- doc/bcftools.txt | 169 ++++++++++++++++++++++++----------------------- 1 file changed, 85 insertions(+), 84 deletions(-) diff --git a/doc/bcftools.txt b/doc/bcftools.txt index 4d1b522a4..a54d6ff8b 100644 --- a/doc/bcftools.txt +++ b/doc/bcftools.txt @@ -412,90 +412,6 @@ Add or remove annotations. bcftools annotate -a annots.bed.gz -h annots.hdr -c CHROM,FROM,TO,TAG input.vcf ---- -[[cnv]] -=== bcftools cnv '[OPTIONS]' 'FILE' - -Copy number variation caller, requires a VCF annotated with the Illumina's -B-allele frequency (BAF) and Log R Ratio intensity (LRR) values. The HMM -considers the following copy number states: CN 2 (normal), 1 (single-copy -loss), 0 (complete loss), 3 (single-copy gain). - - -==== General Options: - -*-c, --control-sample* 'string':: - optional control sample name. If given, pairwise calling is performed - and the *-P* option can be used - -*-f, --AF-file* 'file':: - read allele frequencies from a tab-delimited file with the columns CHR,POS,REF,ALT,AF - -*-o, --output-dir 'path':: - output directory - -*-p, --plot-threshold 'float':: - call *matplotlib* to produce plots for chromosomes with quality at least 'float', - useful for visual inspection of the calls. With *-p 0*, plots for all chromosomes will be - generated. If not given, a *matplotlib* script will be created but not called. - -*-r, --regions* 'chr'|'chr:pos'|'chr:from-to'|'chr:from-'[,...]:: - see *<>* - -*-R, --regions-file* 'file':: - see *<>* - -*-s, --query-sample* 'string':: - query samply name - -*-t, --targets* 'LIST':: - see *<>* - -*-T, --targets-file* 'FILE':: - see *<>* - -==== HMM Options: - -*-a, --aberrant* 'float'[,'float']:: - fraction of aberrant cells in query and control. The hallmark of - duplications and contaminations is the BAF value of heterozygous markers - which is dependent on the fraction of aberrant cells. Sensitivity to - smaller fractions of cells can be increased by setting *-a* to a lower value. Note - however, that this comes at the cost of increased false discovery rate. - -*-b, --BAF-weight* 'float':: - relative contribution from BAF - -*d, --BAF-dev* 'float'[,'float']:: - expected BAF deviation in query and control, i.e. the noise observed - in the data. - -*-e, --err-prob* 'float':: - uniform error probability - -*-l, --LRR-weight* 'float':: - relative contribution from LRR. With noisy data, this option can have big effect - on the number of calls produced. In truly random noise (such as in simulated data), - the value should be set high (1.0), but in the presence of systematic noise - when LRR are not informative, lower values result in cleaner calls (0.2). - -*-L, --LRR-smooth-win* 'int':: - reduce LRR noise by applying moving average given this window size - -*-O, --optimize* 'float':: - iteratively estimate the fraction of aberrant cells, down to the given fraction. - Lowering this value from the default 1.0 to say, 0.3, can help discover more - events but also increases noise - -*-P, --same-prob* 'float':: - the prior probability of the query and the control sample being the same. - Setting to 0 calls both independently, setting to 1 forces the same copy - number state in both. - -*-x, --xy-prob* 'float':: - the HMM probability of transition to another copy number state. Increasing this - values leads to smaller and more frequent calls. - - [[call]] @@ -655,6 +571,91 @@ demand. The original calling model can be invoked with the *-c* option. haploid output for males and skips females (requires PED file with *-s*) +[[cnv]] +=== bcftools cnv '[OPTIONS]' 'FILE' + +Copy number variation caller, requires a VCF annotated with the Illumina's +B-allele frequency (BAF) and Log R Ratio intensity (LRR) values. The HMM +considers the following copy number states: CN 2 (normal), 1 (single-copy +loss), 0 (complete loss), 3 (single-copy gain). + + +==== General Options: + +*-c, --control-sample* 'string':: + optional control sample name. If given, pairwise calling is performed + and the *-P* option can be used + +*-f, --AF-file* 'file':: + read allele frequencies from a tab-delimited file with the columns CHR,POS,REF,ALT,AF + +*-o, --output-dir 'path':: + output directory + +*-p, --plot-threshold 'float':: + call *matplotlib* to produce plots for chromosomes with quality at least 'float', + useful for visual inspection of the calls. With *-p 0*, plots for all chromosomes will be + generated. If not given, a *matplotlib* script will be created but not called. + +*-r, --regions* 'chr'|'chr:pos'|'chr:from-to'|'chr:from-'[,...]:: + see *<>* + +*-R, --regions-file* 'file':: + see *<>* + +*-s, --query-sample* 'string':: + query samply name + +*-t, --targets* 'LIST':: + see *<>* + +*-T, --targets-file* 'FILE':: + see *<>* + +==== HMM Options: + +*-a, --aberrant* 'float'[,'float']:: + fraction of aberrant cells in query and control. The hallmark of + duplications and contaminations is the BAF value of heterozygous markers + which is dependent on the fraction of aberrant cells. Sensitivity to + smaller fractions of cells can be increased by setting *-a* to a lower value. Note + however, that this comes at the cost of increased false discovery rate. + +*-b, --BAF-weight* 'float':: + relative contribution from BAF + +*d, --BAF-dev* 'float'[,'float']:: + expected BAF deviation in query and control, i.e. the noise observed + in the data. + +*-e, --err-prob* 'float':: + uniform error probability + +*-l, --LRR-weight* 'float':: + relative contribution from LRR. With noisy data, this option can have big effect + on the number of calls produced. In truly random noise (such as in simulated data), + the value should be set high (1.0), but in the presence of systematic noise + when LRR are not informative, lower values result in cleaner calls (0.2). + +*-L, --LRR-smooth-win* 'int':: + reduce LRR noise by applying moving average given this window size + +*-O, --optimize* 'float':: + iteratively estimate the fraction of aberrant cells, down to the given fraction. + Lowering this value from the default 1.0 to say, 0.3, can help discover more + events but also increases noise + +*-P, --same-prob* 'float':: + the prior probability of the query and the control sample being the same. + Setting to 0 calls both independently, setting to 1 forces the same copy + number state in both. + +*-x, --xy-prob* 'float':: + the HMM probability of transition to another copy number state. Increasing this + values leads to smaller and more frequent calls. + + + [[concat]] === bcftools concat '[OPTIONS]' 'FILE1' 'FILE2' [...] From e8b7c5bd91aeae0f59bf18fa5458d668f9ad14d4 Mon Sep 17 00:00:00 2001 From: John Marshall Date: Wed, 11 May 2016 11:09:17 +0100 Subject: [PATCH 169/211] Use bcf_hdr_format() rather than deprecated bcf_hdr_fmt_text() Uses new HTSlib function added in samtools/htslib@f581de8b6714cf69416ce6f9d4d4f050996699b8. --- reheader.c | 4 +--- 1 file changed, 1 insertion(+), 3 deletions(-) diff --git a/reheader.c b/reheader.c index 69018cd5a..429bf7efd 100644 --- a/reheader.c +++ b/reheader.c @@ -371,9 +371,7 @@ static void reheader_bcf(args_t *args, int is_compressed) htsFile *fp = args->fp; bcf_hdr_t *hdr = bcf_hdr_read(fp); if ( !hdr ) error("Failed to read the header: %s\n", args->fname); kstring_t htxt = {0,0,0}; - int hlen; - htxt.s = bcf_hdr_fmt_text(hdr, 1, &hlen); - htxt.l = hlen; + bcf_hdr_format(hdr, 1, &htxt); int i, nsamples = 0; char **samples = NULL; From f7f36d9f086a7c7fb7d66bd84221c22e60917d2b Mon Sep 17 00:00:00 2001 From: John Marshall Date: Thu, 12 May 2016 11:03:35 +0100 Subject: [PATCH 170/211] Avoid angle brackets around option arguments Use emphasis or bold instead. Avoids accidentally turning -m <-|+> into left-arrow|plus. --- doc/bcftools.txt | 8 ++++---- 1 file changed, 4 insertions(+), 4 deletions(-) diff --git a/doc/bcftools.txt b/doc/bcftools.txt index c91bb9c2b..d72685e06 100644 --- a/doc/bcftools.txt +++ b/doc/bcftools.txt @@ -1070,7 +1070,7 @@ Checks sample identity or, without *-g*, multi-sample cross-check is performed. [[index]] -=== bcftools index ['OPTIONS'] '|' +=== bcftools index ['OPTIONS'] 'in.bcf'|'in.vcf.gz' Creates index for bgzip compressed VCF/BCF files for random access. CSI (coordinate-sorted index) is created by default. The CSI format supports indexing of chromosomes up to length 2^31. TBI (tabix index) @@ -1289,9 +1289,9 @@ the *<>* option is supplied. and normalization, however, see also the *<>* option below. -*-m, --multiallelics* <-|+>['snps'|'indels'|'both'|'any']:: - split multiallelic sites into biallelic records ('-') or join - biallelic sites into multiallelic records ('+'). An optional type string +*-m, --multiallelics* *-*|*+*['snps'|'indels'|'both'|'any']:: + split multiallelic sites into biallelic records (*-*) or join + biallelic sites into multiallelic records (*+*). An optional type string can follow which controls variant types which should be split or merged together: If only SNP records should be split or merged, specify 'snps'; if both SNPs and indels should be merged separately into two records, specify From b9e0105eb21432ea098b53e09e53a4eec9dd9244 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Mon, 15 Feb 2016 22:15:44 +0000 Subject: [PATCH 171/211] annotate: add `-m` support for VCF, not just tab-delimited annot files --- vcfannotate.c | 19 +++++++++++++------ 1 file changed, 13 insertions(+), 6 deletions(-) diff --git a/vcfannotate.c b/vcfannotate.c index d5164f333..6426f2789 100644 --- a/vcfannotate.c +++ b/vcfannotate.c @@ -1552,7 +1552,6 @@ static void init_data(args_t *args) if ( args->mark_sites ) { if ( !args->targets_fname ) error("The -a option not given\n"); - if ( args->tgts_is_vcf ) error("Apologies, this has not been implemented yet: -a is a VCF\n"); // very easy to add.. bcf_hdr_printf(args->hdr_out,"##INFO=", args->mark_sites,args->mark_sites_logic==MARK_LISTED?"":"not ",args->mark_sites); } @@ -1731,12 +1730,20 @@ static void annotate(args_t *args, bcf1_t *line) bcf_update_info_flag(args->hdr_out,line,args->mark_sites,NULL,inalines?0:1); } } - else if ( args->files->nreaders == 2 && bcf_sr_has_line(args->files,1) ) + else if ( args->files->nreaders == 2 ) { - bcf1_t *aline = bcf_sr_get_line(args->files,1); - for (j=0; jncols; j++) - if ( args->cols[j].setter(args,line,&args->cols[j],aline) ) - error("fixme: Could not set %s at %s:%d\n", args->cols[j].hdr_key,bcf_seqname(args->hdr,line),line->pos+1); + if ( bcf_sr_has_line(args->files,1) ) + { + bcf1_t *aline = bcf_sr_get_line(args->files,1); + for (j=0; jncols; j++) + if ( args->cols[j].setter(args,line,&args->cols[j],aline) ) + error("fixme: Could not set %s at %s:%d\n", args->cols[j].hdr_key,bcf_seqname(args->hdr,line),line->pos+1); + + if ( args->mark_sites ) + bcf_update_info_flag(args->hdr_out,line,args->mark_sites,NULL,args->mark_sites_logic==MARK_LISTED ? 1 : 0); + } + else if ( args->mark_sites ) + bcf_update_info_flag(args->hdr_out,line,args->mark_sites,NULL, args->mark_sites_logic==MARK_UNLISTED ? 1 : 0); } if ( args->set_ids ) { From ee8148d31f97c39c77fd7d5b4a4e1d5ca8408031 Mon Sep 17 00:00:00 2001 From: John Marshall Date: Tue, 17 May 2016 13:08:06 +0100 Subject: [PATCH 172/211] Refactorings and warning preventions [minor] Avoid "may be used uninitialised" warning by telling the compiler that C_UNRL and C_TRIO are the only possibilities. Fix "break" typo. Use strchr() to clarify string parsing. Clarify that printf("\n") statements terminate their printf loops. --- plugins/color-chrs.c | 1 + plugins/mendelian.c | 11 +++++++---- plugins/vcf2sex.c | 3 ++- test/test-rbuf.c | 6 ++++-- vcfmerge.c | 8 +++++--- 5 files changed, 19 insertions(+), 10 deletions(-) diff --git a/plugins/color-chrs.c b/plugins/color-chrs.c index 909065e5c..993ff4b6a 100644 --- a/plugins/color-chrs.c +++ b/plugins/color-chrs.c @@ -456,6 +456,7 @@ void flush_viterbi(args_t *args) s3 = bcf_hdr_int2id(args->hdr,BCF_DT_SAMPLE,args->ifather); s2 = bcf_hdr_int2id(args->hdr,BCF_DT_SAMPLE,args->ichild); } + else abort(); if ( !args->fp ) { diff --git a/plugins/mendelian.c b/plugins/mendelian.c index 304a27a7d..b3c8bb884 100644 --- a/plugins/mendelian.c +++ b/plugins/mendelian.c @@ -26,6 +26,7 @@ #include #include +#include #include #include #include @@ -145,18 +146,20 @@ int init(int argc, char **argv, bcf_hdr_t *in, bcf_hdr_t *out) args.trios = (trio_t*) calloc(n,sizeof(trio_t)); for (i=0; insites = strtol(optarg,&tmp,10); - if (*tmp) error("Unexpected argument to --nsites: %s\n", optarg); break; + if (*tmp) error("Unexpected argument to --nsites: %s\n", optarg); + break; case 'h': case '?': default: error("%s", usage()); break; diff --git a/test/test-rbuf.c b/test/test-rbuf.c index bc8ebe92b..5c0480fde 100644 --- a/test/test-rbuf.c +++ b/test/test-rbuf.c @@ -29,8 +29,10 @@ DEALINGS IN THE SOFTWARE. */ void debug_print(rbuf_t *rbuf, int *dat) { int i; - for (i=-1; rbuf_next(rbuf, &i); ) printf(" %2d", i); printf("\n"); - for (i=-1; rbuf_next(rbuf, &i); ) printf(" %2d", dat[i]); printf("\n"); + for (i=-1; rbuf_next(rbuf, &i); ) printf(" %2d", i); + printf("\n"); + for (i=-1; rbuf_next(rbuf, &i); ) printf(" %2d", dat[i]); + printf("\n"); } int main(int argc, char **argv) diff --git a/vcfmerge.c b/vcfmerge.c index 02fac6bcc..3f5db9ece 100644 --- a/vcfmerge.c +++ b/vcfmerge.c @@ -274,7 +274,7 @@ static void info_rules_init(args_t *args) rule->type = bcf_hdr_id2type(args->out_hdr,BCF_HL_INFO,id); if ( rule->type!=BCF_HT_INT && rule->type!=BCF_HT_REAL && rule->type!=BCF_HT_STR ) error("The type is not supported: \"%s\"\n", rule->hdr_tag); - while ( *ss ) ss++; ss++; + ss = strchr(ss, '\0'); ss++; if ( !*ss ) error("Could not parse INFO rules, missing logic of \"%s\"\n", rule->hdr_tag); int is_join = 0; @@ -300,7 +300,8 @@ static void info_rules_init(args_t *args) error("Only fixed-length vectors are supported with -i %s:%s\n", ss, rule->hdr_tag); } - while ( *ss ) ss++; ss++; n++; + ss = strchr(ss, '\0'); ss++; + n++; } free(str.s); free(tmp); @@ -1658,7 +1659,8 @@ void debug_maux(args_t *args, int pos, int var_type) fprintf(stderr,"\n"); } fprintf(stderr," counts: "); - for (j=0; jnals; j++) fprintf(stderr,"%s %dx %s", j==0?"":",",maux->cnt[j], maux->als[j]); fprintf(stderr,"\n"); + for (j=0; jnals; j++) fprintf(stderr,"%s %dx %s", j==0?"":",",maux->cnt[j], maux->als[j]); + fprintf(stderr,"\n"); for (j=0; jnreaders; j++) { bcf_sr_t *reader = &files->readers[j]; From 170198d1e6d9072c639c7fb30f95995563e856d8 Mon Sep 17 00:00:00 2001 From: John Marshall Date: Tue, 24 May 2016 14:23:57 +0100 Subject: [PATCH 173/211] Fix test_cmd(exp=>"expected") when test fails If you use test_cmd(...,exp=>,...) then you must also use out=> with a suitable output filename. Normally the output file does not exist; but if the test fails, both {out} and {out}.new will be created. --- test/test.pl | 27 +++++++++++++++------------ 1 file changed, 15 insertions(+), 12 deletions(-) diff --git a/test/test.pl b/test/test.pl index dc1fcfa84..da493fd86 100755 --- a/test/test.pl +++ b/test/test.pl @@ -320,7 +320,7 @@ sub cmd sub test_cmd { my ($opts,%args) = @_; - if ( !exists($args{out}) && !exists($args{exp}) ) + if ( !exists($args{out}) ) { if ( !exists($args{in}) ) { error("FIXME: expected out or in key\n"); } $args{out} = "$args{in}.out"; @@ -350,23 +350,20 @@ sub test_cmd } my $exp = ''; if ( exists($args{exp}) ) { $exp = $args{exp}; } - else + elsif ( open(my $fh,'<',"$$opts{path}/$args{out}") ) { - if ( open(my $fh,'<',"$$opts{path}/$args{out}") ) - { - my @exp = <$fh>; - $exp = join('',@exp); - close($fh); - } - elsif ( !$$opts{redo_outputs} ) { failed($opts,$test,"$$opts{path}/$args{out}: $!"); return; } + my @exp = <$fh>; + $exp = join('',@exp); + close($fh); } + elsif ( !$$opts{redo_outputs} ) { failed($opts,$test,"$$opts{path}/$args{out}: $!"); return; } if ( $exp ne $out ) { open(my $fh,'>',"$$opts{path}/$args{out}.new") or error("$$opts{path}/$args{out}.new"); print $fh $out; close($fh); - if ( !-e "$$opts{path}/$args{out}" ) + if ( !-e "$$opts{path}/$args{out}" && !exists($args{exp}) ) { rename("$$opts{path}/$args{out}.new","$$opts{path}/$args{out}") or error("rename $$opts{path}/$args{out}.new $$opts{path}/$args{out}: $!"); print "\tthe file with expected output does not exist, creating new one:\n"; @@ -374,6 +371,12 @@ sub test_cmd } else { + if ( exists($args{exp}) ) + { + open(my $fh,'>',"$$opts{path}/$args{out}") or error("$$opts{path}/$args{out}"); + print $fh $exp; + close($fh); + } failed($opts,$test,"The outputs differ:\n\t\t$$opts{path}/$args{out}\n\t\t$$opts{path}/$args{out}.new"); } return; @@ -908,9 +911,9 @@ sub test_naive_concat } my $bcfs = join('.bcf ',@files).'.bcf'; - test_cmd($opts,exp=>$exp,cmd=>"$$opts{bin}/bcftools concat --naive $bcfs | $$opts{bin}/bcftools view -H"); + test_cmd($opts,exp=>$exp,out=>"concat.naive.bcf.out",cmd=>"$$opts{bin}/bcftools concat --naive $bcfs | $$opts{bin}/bcftools view -H"); my $vcfs = join('.vcf.gz ',@files).'.vcf.gz'; - test_cmd($opts,exp=>$exp,cmd=>"$$opts{bin}/bcftools concat --naive $vcfs | $$opts{bin}/bcftools view -H"); + test_cmd($opts,exp=>$exp,out=>"concat.naive.vcf.out",cmd=>"$$opts{bin}/bcftools concat --naive $vcfs | $$opts{bin}/bcftools view -H"); } From 16414e6f772f65285c425e3cbd2fdb908550f727 Mon Sep 17 00:00:00 2001 From: John Marshall Date: Fri, 27 May 2016 14:26:49 +0100 Subject: [PATCH 174/211] Avoid segfault when QUAL < 0 QUAL is Phred-scaled so by definition is >= 0.0. If we get invalid input with a negative QUAL, clip it into the bin with 0, similarly to the clipping beyond m_qual. Hat tip Peter Johansson on samtools-help. --- vcfstats.c | 10 ++++++++-- 1 file changed, 8 insertions(+), 2 deletions(-) diff --git a/vcfstats.c b/vcfstats.c index 1032bf87b..45b28b7ae 100644 --- a/vcfstats.c +++ b/vcfstats.c @@ -187,6 +187,12 @@ static inline int idist_i2bin(idist_t *d, int i) return i-1+d->min; } +static inline int clip_nonnegative(float x, int limit) +{ + if (x >= limit || isnan(x)) return limit - 1; + else if (x <= 0.0) return 0; + else return (int) x; +} #define IC_DBG 0 #if IC_DBG @@ -621,7 +627,7 @@ static void do_indel_stats(args_t *args, stats_t *stats, bcf_sr_t *reader) bcf1_t *line = reader->buffer[0]; #if QUAL_STATS - int iqual = line->qual >= args->m_qual || isnan(line->qual) ? args->m_qual - 1 : line->qual; + int iqual = clip_nonnegative(line->qual, args->m_qual); stats->qual_indels[iqual]++; #endif @@ -756,7 +762,7 @@ static void do_snp_stats(args_t *args, stats_t *stats, bcf_sr_t *reader) if ( ref<0 ) return; #if QUAL_STATS - int iqual = line->qual >= args->m_qual || isnan(line->qual) ? args->m_qual - 1 : line->qual; + int iqual = clip_nonnegative(line->qual, args->m_qual); stats->qual_snps[iqual]++; #endif From df3ca41b95a454462598919f5123ebbbfcb7ed6b Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Fri, 6 May 2016 20:15:05 +0100 Subject: [PATCH 175/211] consensus: handle variants which overlap region boundaries Fixes #400 --- consensus.c | 33 +++++++++++++++++++++++++++++---- 1 file changed, 29 insertions(+), 4 deletions(-) diff --git a/consensus.c b/consensus.c index 051f3536c..79b4a5f91 100644 --- a/consensus.c +++ b/consensus.c @@ -409,12 +409,27 @@ static void apply_variant(args_t *args, bcf1_t *rec) rec->d.allele[1][0] = gt2iupac(ial,jal); } + int len_diff = 0, alen = 0; int idx = rec->pos - args->fa_ori_pos + args->fa_mod_off; - if ( idx<0 || idx>=args->fa_buf.l ) + if ( idx<0 ) + { + fprintf(stderr,"Warning: ignoring overlapping variant starting at %s:%d\n", bcf_seqname(args->hdr,rec),rec->pos+1); + return; + } + if ( rec->rlen > args->fa_buf.l - idx ) + { + rec->rlen = args->fa_buf.l - idx; + alen = strlen(rec->d.allele[ialt]); + if ( alen > rec->rlen ) + { + rec->d.allele[ialt][rec->rlen] = 0; + fprintf(stderr,"Warning: trimming variant starting at %s:%d\n", bcf_seqname(args->hdr,rec),rec->pos+1); + } + } + if ( idx>=args->fa_buf.l ) error("FIXME: %s:%d .. idx=%d, ori_pos=%d, len=%d, off=%d\n",bcf_seqname(args->hdr,rec),rec->pos+1,idx,args->fa_ori_pos,args->fa_buf.l,args->fa_mod_off); // sanity check the reference base - int len_diff = 0, alen = 0; if ( rec->d.allele[ialt][0]=='<' ) { if ( strcasecmp(rec->d.allele[ialt], "") ) @@ -519,7 +534,7 @@ static void consensus(args_t *args) { if ( str.s[0]=='>' ) { - // new sequence encountered, apply all chached variants + // new sequence encountered, apply all cached variants while ( args->vcf_rbuf.n ) { if (args->chain) { @@ -576,7 +591,17 @@ static void consensus(args_t *args) } if ( !rec_ptr ) flush_fa_buffer(args, 60); } - if (args->chain) { + bcf1_t **rec_ptr = NULL; + while ( args->rid>=0 && (rec_ptr = next_vcf_line(args)) ) + { + bcf1_t *rec = *rec_ptr; + if ( rec->rid!=args->rid ) break; + if ( args->fa_end_pos && rec->pos > args->fa_end_pos ) break; + if ( args->fa_ori_pos + args->fa_buf.l - args->fa_mod_off <= rec->pos ) break; + apply_variant(args, rec); + } + if (args->chain) + { print_chain(args); destroy_chain(args); } From 25d042b833987d32e5de1fc3a109d357c4d0f738 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Mon, 20 Jun 2016 07:44:39 +0100 Subject: [PATCH 176/211] norm: strict checking of non-ACGTN bases in `norm -cwx` Fixes #439 --- vcfnorm.c | 35 +++++++++++++++++++++++++++++------ 1 file changed, 29 insertions(+), 6 deletions(-) diff --git a/vcfnorm.c b/vcfnorm.c index d3b9fee42..daac7532e 100644 --- a/vcfnorm.c +++ b/vcfnorm.c @@ -87,10 +87,21 @@ static inline int replace_iupac_codes(char *seq, int nseq) for (i=0; id.allele[0]); char *ref = faidx_fetch_seq(args->fai, (char*)args->hdr->id[BCF_DT_CTG][line->rid].key, line->pos, line->pos+reflen-1, &nref); if ( !ref ) error("faidx_fetch_seq failed at %s:%d\n", args->hdr->id[BCF_DT_CTG][line->rid].key, line->pos+1); - replace_iupac_codes(ref,nref); + replace_iupac_codes(ref,nref); // any non-ACGT character in fasta ref is replaced with N - // does REF contain non-standard bases? - if ( replace_iupac_codes(line->d.allele[0],reflen) ) + // does VCF REF contain non-standard bases? + if ( has_non_acgtn(line->d.allele[0],reflen) ) { - args->nchanged++; - bcf_update_alleles(args->hdr,line,(const char**)line->d.allele,line->n_allele); + if ( args->check_ref==CHECK_REF_EXIT ) + error("Non-ACGTN reference allele at %s:%d .. REF_SEQ:'%s' vs VCF:'%s'\n", bcf_seqname(args->hdr,line),line->pos+1,ref,line->d.allele[0]); + if ( args->check_ref & CHECK_REF_WARN ) + fprintf(stderr,"NON_ACGTN_REF\t%s\t%d\t%s\n", bcf_seqname(args->hdr,line),line->pos+1,line->d.allele[0]); + free(ref); + return ERR_REF_MISMATCH; } if ( strcasecmp(ref,line->d.allele[0]) ) { @@ -289,6 +304,14 @@ static int realign(args_t *args, bcf1_t *line) for (i=0; in_allele; i++) { if ( line->d.allele[i][0]=='<' ) return ERR_SYMBOLIC; // symbolic allele + if ( has_non_acgtn(line->d.allele[i],0) ) + { + if ( args->check_ref==CHECK_REF_EXIT ) + error("Non-ACGTN alternate allele at %s:%d .. REF_SEQ:'%s' vs VCF:'%s'\n", bcf_seqname(args->hdr,line),line->pos+1,ref,line->d.allele[i]); + if ( args->check_ref & CHECK_REF_WARN ) + fprintf(stderr,"NON_ACGTN_ALT\t%s\t%d\t%s\n", bcf_seqname(args->hdr,line),line->pos+1,line->d.allele[i]); + return ERR_REF_MISMATCH; + } als[i].l = 0; kputs(line->d.allele[i], &als[i]); From d083c5b39bd4effaa38fb23575fa762dd1f7561f Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Fri, 20 May 2016 19:34:36 +0100 Subject: [PATCH 177/211] roh: fix nonfunctional --AF-dflt option also clarify a comment line in the code --- vcfroh.c | 47 +++++++++++++++++++++++------------------------ 1 file changed, 23 insertions(+), 24 deletions(-) diff --git a/vcfroh.c b/vcfroh.c index 95605592f..ead7adc14 100644 --- a/vcfroh.c +++ b/vcfroh.c @@ -502,7 +502,7 @@ int parse_line(args_t *args, bcf1_t *line, double *alt_freq, double *pdg) args->nitmp = 0; // Set allele frequency - int ret; + int ret = 0; if ( args->af_tag ) { // Use an INFO tag provided by the user @@ -517,36 +517,35 @@ int parse_line(args_t *args, bcf1_t *line, double *alt_freq, double *pdg) // Read AF from a file ret = read_AF(args->files->targets, line, alt_freq); } + else if ( args->dflt_AF > 0 ) + { + *alt_freq = args->dflt_AF; + } + else if ( args->estimate_AF ) + { + // Estimate AF from GTs of all samples or samples listed in a file + ret = estimate_AF(args, line, alt_freq); // reads GTs into args->itmp + } else { - // Use GTs or AC/AN: GTs when AC/AN not present or when GTs explicitly requested by --estimate-AF - ret = -1; - if ( !args->estimate_AF ) + // Use AC/AN + int AC = -1, AN = 0; + ret = bcf_get_info_int32(args->hdr, line, "AN", &args->itmp, &args->mitmp); + if ( ret==1 ) { - int AC = -1, AN = 0; - ret = bcf_get_info_int32(args->hdr, line, "AN", &args->itmp, &args->mitmp); - if ( ret==1 ) - { - AN = args->itmp[0]; - ret = bcf_get_info_int32(args->hdr, line, "AC", &args->itmp, &args->mitmp); - if ( ret>0 ) - AC = args->itmp[0]; - } - if ( AN<=0 || AC<0 ) - ret = -1; - else - *alt_freq = (double) AC/AN; + AN = args->itmp[0]; + ret = bcf_get_info_int32(args->hdr, line, "AC", &args->itmp, &args->mitmp); + if ( ret>0 ) + AC = args->itmp[0]; } - if ( ret==-1 ) - ret = estimate_AF(args, line, alt_freq); // reads GTs into args->itmp + if ( AN<=0 || AC<0 ) + ret = -1; + else + *alt_freq = (double) AC/AN; } if ( ret<0 ) return ret; - if ( *alt_freq==0.0 ) - { - if ( args->dflt_AF==0 ) return -1; // we skip sites with AF=0 - *alt_freq = args->dflt_AF; - } + if ( *alt_freq==0.0 ) return -1; // Set P(D|G) if ( args->fake_PLs ) From 2035ddd696b83455210be5cae2d2c775c4aca2aa Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Mon, 13 Jun 2016 13:34:22 +0100 Subject: [PATCH 178/211] call: re-enable numeric ploidy definitions via `--samples-file` Fixes #436 --- test/mpileup.2.samples | 3 +++ test/mpileup.X.2.out | 40 +++++++++++++++++++++++++++++++++++++++ test/mpileup.c.X.2.out | 43 ++++++++++++++++++++++++++++++++++++++++++ test/test.pl | 2 ++ vcfcall.c | 6 +++--- 5 files changed, 91 insertions(+), 3 deletions(-) create mode 100644 test/mpileup.2.samples create mode 100644 test/mpileup.X.2.out create mode 100644 test/mpileup.c.X.2.out diff --git a/test/mpileup.2.samples b/test/mpileup.2.samples new file mode 100644 index 000000000..07b1eae64 --- /dev/null +++ b/test/mpileup.2.samples @@ -0,0 +1,3 @@ +HG00100 2 +HG00101 1 +HG00102 2 diff --git a/test/mpileup.X.2.out b/test/mpileup.X.2.out new file mode 100644 index 000000000..1c63822dc --- /dev/null +++ b/test/mpileup.X.2.out @@ -0,0 +1,40 @@ +##fileformat=VCFv4.2 +##FILTER= +##samtoolsVersion=1.1-19-g6b249e2+htslib-1.1-74-g845c515 +##samtoolsCommand=samtools mpileup -uvDV -b xxx//mpileup.bam.list -f xxx//mpileup.ref.fa.gz +##reference=file://xxx//mpileup.ref.fa.gz +##contig= +##ALT= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +#CHROM POS ID REF ALT QUAL FILTER INFO FORMAT HG00100 HG00101 HG00102 +X 302 . T TA 481 . INDEL;IDV=7;IMF=1;DP=25;VDB=0.27613;SGB=-4.22417;MQSB=0.0443614;MQ0F=0;ICB=0.235294;HOB=0.18;AC=4;AN=5;DP4=2,4,8,11;MQ=49 GT:PL:DP:DV 0/1:167,0,96:11:6 1:157,9:7:6 1/1:201,21,0:7:7 +X 828 . T C 321 . DP=25;VDB=0.842082;SGB=-4.20907;RPB=0.950652;MQB=1;MQSB=1;BQB=0.929717;MQ0F=0;ICB=0.235294;HOB=0.18;AC=4;AN=5;DP4=2,4,8,11;MQ=60 GT:PL:DP:DV 0/1:211,0,35:12:10 1:116,91:9:5 1/1:120,12,0:4:4 +X 834 . G A 308 . DP=25;VDB=0.788006;SGB=-4.01214;RPB=0.999233;MQB=1;MQSB=1;BQB=0.821668;MQ0F=0;ICB=0.235294;HOB=0.18;AC=4;AN=5;DP4=2,3,7,10;MQ=60 GT:PL:DP:DV 0/1:185,0,46:11:9 1:128,59:8:5 1/1:89,9,0:3:3 +X 1665 . T C 3.10525 . DP=20;VDB=0.1;SGB=0.346553;RPB=0.222222;MQB=0.611111;MQSB=0.988166;BQB=0.944444;MQ0F=0;ICB=0.235294;HOB=0.18;AC=1;AN=5;DP4=7,11,1,1;MQ=55 GT:PL:DP:DV 0/0:0,21,185:7:0 0:0,222:9:0 0/1:35,0,51:4:2 +X 1869 . A T 119 . DP=24;VDB=0.928022;SGB=-11.9537;RPB=0.984127;MQB=0.96464;MQSB=0.931547;BQB=0.359155;MQ0F=0;ICB=0.461538;HOB=0.02;AC=3;AN=5;DP4=6,9,5,4;MQ=58 GT:PL:DP:DV 0/1:115,0,224:18:7 0:16,104:5:1 1/1:42,3,0:1:1 +X 2041 . G A 424 . DP=31;VDB=0.816435;SGB=-4.18892;RPB=0.88473;MQB=0.972375;MQSB=0.968257;BQB=0.311275;MQ0F=0;ICB=0.235294;HOB=0.18;AC=4;AN=5;DP4=6,5,12,7;MQ=58 GT:PL:DP:DV 0/1:229,0,212:21:11 1:32,24:2:1 1/1:223,21,0:7:7 +X 2220 . G A 257 . DP=21;VDB=0.532753;SGB=-3.51597;RPB=0.964198;MQB=0.898397;MQSB=0.875769;BQB=0.0354359;MQ0F=0;ICB=0.235294;HOB=0.18;AC=4;AN=5;DP4=6,2,1,11;MQ=58 GT:PL:DP:DV 0/1:139,0,130:12:6 1:69,46:4:2 1/1:131,12,0:4:4 +X 2564 . A G 178 . DP=15;VDB=0.690812;SGB=-3.20711;RPB=0.197899;MQB=1;MQSB=1;BQB=0.965069;MQ0F=0;ICB=0.235294;HOB=0.18;AC=4;AN=5;DP4=1,4,4,5;MQ=60 GT:PL:DP:DV 0/1:88,0,78:6:3 1:57,56:4:2 1/1:124,12,0:4:4 +X 3104 . C T 24.1975 . DP=25;VDB=0.8;SGB=0.346553;RPB=0.717391;MQB=0.956522;MQSB=0.962269;BQB=0.978261;MQ0F=0;ICB=0.235294;HOB=0.18;AC=1;AN=5;DP4=8,15,2,0;MQ=58 GT:PL:DP:DV 0/0:0,48,255:16:0 0:0,144:4:0 0/1:59,0,93:5:2 +X 3587 . G A 332 . DP=29;VDB=0.902044;SGB=-3.91326;RPB=0.800999;MQB=1;MQSB=1;BQB=0.156944;MQ0F=0;ICB=0.461538;HOB=0.02;AC=3;AN=5;DP4=4,7,10,6;MQ=60 GT:PL:DP:DV 0/1:161,0,184:14:7 0:22,118:5:1 1/1:212,24,0:8:8 +X 3936 . A G 412 . DP=37;VDB=0.0574114;SGB=-4.60123;RPB=0.741697;MQB=0.812605;MQSB=0.143788;BQB=0.883831;MQ0F=0;ICB=0.235294;HOB=0.18;AC=4;AN=5;DP4=5,6,6,17;MQ=56 GT:PL:DP:DV 0/1:233,0,206:20:11 1:77,58:6:4 1/1:196,24,0:8:8 diff --git a/test/mpileup.c.X.2.out b/test/mpileup.c.X.2.out new file mode 100644 index 000000000..25022d9bc --- /dev/null +++ b/test/mpileup.c.X.2.out @@ -0,0 +1,43 @@ +##fileformat=VCFv4.2 +##FILTER= +##samtoolsVersion=1.1-19-g6b249e2+htslib-1.1-74-g845c515 +##samtoolsCommand=samtools mpileup -uvDV -b xxx//mpileup.bam.list -f xxx//mpileup.ref.fa.gz +##reference=file://xxx//mpileup.ref.fa.gz +##contig= +##ALT= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +#CHROM POS ID REF ALT QUAL FILTER INFO FORMAT HG00100 HG00101 HG00102 +X 302 . T TA 999 . INDEL;IDV=7;IMF=1;DP=25;VDB=0.27613;SGB=-4.22417;MQSB=0.0443614;MQ0F=0;AF1=0.685575;AC1=4;DP4=2,4,8,11;MQ=51;FQ=61.4911;PV4=1,1,1,1 GT:PL:DP:DV 0/1:167,0,96:11:6 0:157,0,9:7:6 1/1:201,21,0:7:7 +X 828 . T C 999 . DP=25;VDB=0.842082;SGB=-4.20907;RPB=0.950652;MQB=1;MQSB=1;BQB=0.929717;MQ0F=0;AF1=0.656389;AC1=4;DP4=2,4,8,11;MQ=60;FQ=89.3748;PV4=1,1,1,0.32233 GT:PL:DP:DV 0/1:211,0,35:12:10 0:116,91:9:5 1/1:120,12,0:4:4 +X 834 . G A 999 . DP=25;VDB=0.788006;SGB=-4.01214;RPB=0.999233;MQB=1;MQSB=1;BQB=0.821668;MQ0F=0;AF1=0.646503;AC1=4;DP4=2,3,7,10;MQ=60;FQ=68.6952;PV4=1,1,1,0.228905 GT:PL:DP:DV 0/1:185,0,46:11:9 0:128,59:8:5 1/1:89,9,0:3:3 +X 1665 . T C 3.14059 . DP=20;VDB=0.1;SGB=0.346553;RPB=0.222222;MQB=0.611111;MQSB=0.988166;BQB=0.944444;MQ0F=0;AF1=0.167199;AC1=1;DP4=7,11,1,1;MQ=56;FQ=3.56819;PV4=1,0.239991,0.0798553,0.27333 GT:PL:DP:DV 0/0:0,21,185:7:0 0:0,222:9:0 0/1:35,0,51:4:2 +X 1869 . A T 134.348 . DP=24;VDB=0.928022;SGB=-11.9537;RPB=0.984127;MQB=0.96464;MQSB=0.931547;BQB=0.359155;MQ0F=0;AF1=0.598209;AC1=4;DP4=6,9,5,4;MQ=59;FQ=138.299;PV4=0.675175,0.0234896,1,0.324361 GT:PL:DP:DV 0/1:115,0,224:18:7 0:16,104:5:1 1/1:42,3,0:1:1 +X 2041 . G A 999 . DP=31;VDB=0.816435;SGB=-4.18892;RPB=0.88473;MQB=0.972375;MQSB=0.968257;BQB=0.311275;MQ0F=0;AF1=0.665982;AC1=4;DP4=6,5,12,7;MQ=59;FQ=999;PV4=0.71163,1,0.228209,0.143795 GT:PL:DP:DV 0/1:229,0,212:21:11 0:32,24:2:1 1/1:223,21,0:7:7 +X 2220 . G A 999 . DP=21;VDB=0.532753;SGB=-3.51597;RPB=0.964198;MQB=0.898397;MQSB=0.875769;BQB=0.0354359;MQ0F=0;AF1=0.656341;AC1=4;DP4=6,2,1,11;MQ=59;FQ=139.373;PV4=0.00443756,1,1,1 GT:PL:DP:DV 0/1:139,0,130:12:6 0:69,46:4:2 1/1:131,12,0:4:4 +X 2564 . A G 227.769 . DP=15;VDB=0.690812;SGB=-3.20711;RPB=0.197899;MQB=1;MQSB=1;BQB=0.965069;MQ0F=0;AF1=0.656337;AC1=4;DP4=1,4,4,5;MQ=60;FQ=97.3723;PV4=0.58042,1,1,1 GT:PL:DP:DV 0/1:88,0,78:6:3 0:57,56:4:2 1/1:124,12,0:4:4 +X 3104 . C T 24.364 . DP=25;VDB=0.8;SGB=0.346553;RPB=0.717391;MQB=0.956522;MQSB=0.962269;BQB=0.978261;MQ0F=0;AF1=0.170892;AC1=1;DP4=8,15,2,0;MQ=59;FQ=25.179;PV4=0.15,1,1,1 GT:PL:DP:DV 0/0:0,48,255:16:0 0:0,144:4:0 0/1:59,0,93:5:2 +X 3587 . G A 353.302 . DP=29;VDB=0.902044;SGB=-3.91326;RPB=0.800999;MQB=1;MQSB=1;BQB=0.156944;MQ0F=0;AF1=0.665739;AC1=4;DP4=4,7,10,6;MQ=60;FQ=358.057;PV4=0.25186,0.0986321,1,1 GT:PL:DP:DV 0/1:161,0,184:14:7 0:22,118:5:1 1/1:212,24,0:8:8 +X 3936 . A G 999 . DP=37;VDB=0.0574114;SGB=-4.60123;RPB=0.741697;MQB=0.812605;MQSB=0.143788;BQB=0.883831;MQ0F=0;AF1=0.666004;AC1=4;DP4=5,6,6,17;MQ=57;FQ=999;PV4=0.434446,0.125787,1,1 GT:PL:DP:DV 0/1:233,0,206:20:11 0:77,58:6:4 1/1:196,24,0:8:8 diff --git a/test/test.pl b/test/test.pl index c1bcdfd67..bb4323cd8 100755 --- a/test/test.pl +++ b/test/test.pl @@ -145,11 +145,13 @@ test_vcf_call($opts,in=>'mpileup',out=>'mpileup.2.out',args=>'-mg0'); test_vcf_call($opts,in=>'mpileup.X',out=>'mpileup.X.out',args=>'-mv --ploidy-file {PATH}/mpileup.ploidy -S {PATH}/mpileup.samples'); test_vcf_call($opts,in=>'mpileup.X',out=>'mpileup.X.out',args=>'-mv --ploidy-file {PATH}/mpileup.ploidy -S {PATH}/mpileup.ped'); +test_vcf_call($opts,in=>'mpileup.X',out=>'mpileup.X.2.out',args=>'-mv --ploidy-file {PATH}/mpileup.ploidy -S {PATH}/mpileup.2.samples'); test_vcf_call_cAls($opts,in=>'mpileup',out=>'mpileup.cAls.out',tab=>'mpileup'); test_vcf_call($opts,in=>'mpileup.c',out=>'mpileup.c.1.out',args=>'-cv'); # test_vcf_call($opts,in=>'mpileup.c',out=>'mpileup.c.2.out',args=>'-cg0'); test_vcf_call($opts,in=>'mpileup.c.X',out=>'mpileup.c.X.out',args=>'-cv --ploidy-file {PATH}/mpileup.ploidy -S {PATH}/mpileup.samples'); test_vcf_call($opts,in=>'mpileup.c.X',out=>'mpileup.c.X.out',args=>'-cv --ploidy-file {PATH}/mpileup.ploidy -S {PATH}/mpileup.ped'); +test_vcf_call($opts,in=>'mpileup.c.X',out=>'mpileup.c.X.2.out',args=>'-cv --ploidy-file {PATH}/mpileup.ploidy -S {PATH}/mpileup.2.samples'); test_vcf_filter($opts,in=>'filter.1',out=>'filter.1.out',args=>'-mx -g2 -G2'); test_vcf_filter($opts,in=>'filter.2',out=>'filter.2.out',args=>q[-e'QUAL==59.2 || (INDEL=0 & (FMT/GQ=25 | FMT/DP=10))' -sModified -S.]); test_vcf_filter($opts,in=>'filter.3',out=>'filter.3.out',args=>q[-e'DP=19'],fmt=>'%POS\\t%FILTER\\t%DP[\\t%GT]\\n'); diff --git a/vcfcall.c b/vcfcall.c index cc4aff29d..f29002098 100644 --- a/vcfcall.c +++ b/vcfcall.c @@ -411,7 +411,7 @@ static void init_data(args_t *args) { args->nsamples = bcf_hdr_nsamples(args->aux.hdr); args->sample2sex = (int*) malloc(sizeof(int)*args->nsamples); - for (i=0; insamples; i++) args->sample2sex[i] = 0; + for (i=0; insamples; i++) args->sample2sex[i] = 2; } } if ( args->nsamples ) @@ -779,8 +779,8 @@ int main_vcfcall(int argc, char *argv[]) if ( !ploidy_fname && !ploidy ) { - fprintf(stderr,"Note: Neither --ploidy nor --ploidy-file given, assuming all sites are diploid\n"); - args.ploidy = ploidy_init_string("",2); + if ( !args.samples_is_file ) fprintf(stderr,"Note: none of --samples-file, --ploidy or --ploidy-file given, assuming all sites are diploid\n"); + args.ploidy = ploidy_init_string("* * * 0 0\n* * * 1 1\n* * * 2 2\n",2); } if ( !args.ploidy ) error("Could not initialize ploidy\n"); From be8b378d2a187d3942e9148190a58ba919c44b83 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Mon, 2 May 2016 12:29:06 +0100 Subject: [PATCH 179/211] cnv: add params estimated by -O to the summary cnv output --- vcfcnv.c | 46 ++++++++++++++++++++++++++++++++++++---------- 1 file changed, 36 insertions(+), 10 deletions(-) diff --git a/vcfcnv.c b/vcfcnv.c index e4b9372c9..ffe71c42c 100644 --- a/vcfcnv.c +++ b/vcfcnv.c @@ -266,17 +266,15 @@ static void init_data(args_t *args) hmm_init_states(args->hmm, args->iprobs); args->summary_fh = stdout; - if ( args->output_dir ) + init_sample_files(&args->query_sample, args->output_dir); + if ( args->control_sample.name ) { - init_sample_files(&args->query_sample, args->output_dir); - if ( args->control_sample.name ) - { - init_sample_files(&args->control_sample, args->output_dir); - args->summary_fh = open_file(&args->summary_fname,"w","%s/summary.tab",args->output_dir); - } - else - args->summary_fh = NULL; // one sample only, no two-file summary + init_sample_files(&args->control_sample, args->output_dir); + args->summary_fh = open_file(&args->summary_fname,"w","%s/summary.tab",args->output_dir); } + else + args->summary_fh = NULL; // one sample only, no two-file summary + int i; FILE *fh = args->summary_fh ? args->summary_fh : args->query_sample.summary_fh; @@ -295,6 +293,19 @@ static void init_data(args_t *args) "# RG, Regions\t[2]Chromosome\t[3]Start\t[4]End\t[5]Copy number:%s\t[6]Quality\t[7]nSites\t[8]nHETs\n", args->query_sample.name ); + if ( args->optimize_frac ) + { + fprintf(args->query_sample.summary_fh, "# CF, cell fraction estimate\t[2]Chromosome\t[3]Start\t[4]End\t[5]Cell fraction\t[6]BAF deviation\n"); + if ( args->control_sample.name ) + { + fprintf(args->control_sample.summary_fh, "# CF, cell fraction estimate\t[2]Chromosome\t[3]Start\t[4]End\t[5]Cell fraction\t[6]BAF deviation\n"); + fprintf(args->summary_fh, "# CF, cell fraction estimate\t[2]Chromosome\t[3]Start\t[4]End\t" + "[5]Cell fraction:%s\t[6]Cell fraction:%s\t[7]BAF deviation:%s\t[8]BAF deviation:%s\n", + args->query_sample.name,args->control_sample.name, + args->query_sample.name,args->control_sample.name + ); + } + } } char *msprintf(const char *fmt, ...); @@ -556,6 +567,7 @@ static void destroy_data(args_t *args) free(args->sites); free(args->eprob); free(args->tprob); + free(args->iprobs); free(args->summary_fname); free(args->nonref_afs); free(args->query_sample.baf); @@ -960,6 +972,20 @@ static void cnv_flush_viterbi(args_t *args) if ( args->control_sample.name ) fprintf(stderr,"\t.. %f %f", args->control_sample.cell_frac,args->control_sample.baf_dev2); fprintf(stderr,"\n"); + + fprintf(args->query_sample.summary_fh,"CF\t%s\t%d\t%d\t%.2f\t%f\n", + bcf_hdr_id2name(args->hdr,args->prev_rid),args->sites[0]+1,args->sites[args->nsites-1]+1, + args->query_sample.cell_frac,sqrt(args->query_sample.baf_dev2)); + if ( args->control_sample.name ) + { + fprintf(args->control_sample.summary_fh,"CF\t%s\t%d\t%d\t%.2f\t%f\n", + bcf_hdr_id2name(args->hdr,args->prev_rid),args->sites[0]+1,args->sites[args->nsites-1]+1, + args->control_sample.cell_frac,sqrt(args->control_sample.baf_dev2)); + fprintf(args->summary_fh,"CF\t%s\t%d\t%d\t%.2f\t%.2f\t%f\t%f\n", + bcf_hdr_id2name(args->hdr,args->prev_rid),args->sites[0]+1,args->sites[args->nsites-1]+1, + args->query_sample.cell_frac, args->control_sample.cell_frac, + sqrt(args->query_sample.baf_dev2), sqrt(args->control_sample.baf_dev2)); + } } set_emission_probs(args); @@ -1351,7 +1377,7 @@ int main_vcfcnv(int argc, char *argv[]) else fname = argv[optind]; if ( !fname ) usage(args); - if ( args->plot_th<=100 && !args->output_dir ) error("Expected -o option with -p\n"); + if ( !args->output_dir ) error("Expected -o option\n"); if ( args->regions_list ) { if ( bcf_sr_set_regions(args->files, args->regions_list, regions_is_file)<0 ) From 101061cd738c816ed203c0f56d622d4f78e046a5 Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Tue, 21 Jun 2016 11:06:14 +0100 Subject: [PATCH 180/211] call: add some extra info to the ploidy help message [minor] --- vcfcall.c | 7 +++++-- 1 file changed, 5 insertions(+), 2 deletions(-) diff --git a/vcfcall.c b/vcfcall.c index f29002098..b6f3b4d67 100644 --- a/vcfcall.c +++ b/vcfcall.c @@ -146,7 +146,7 @@ static ploidy_predef_t ploidy_predefs[] = "* * * F 2\n" }, { .alias = "GRCh38", - .about = "Human Genome reference assembly GRCh38 / hg38, plain chromosome naming (1,2,3,..)", + .about = "Human Genome reference assembly GRCh38 / hg38", .ploidy = "X 1 9999 M 1\n" "X 2781480 155701381 M 1\n" @@ -569,7 +569,10 @@ ploidy_t *init_ploidy(char *alias) if ( !pld->alias ) { - fprintf(stderr,"Predefined ploidies:\n"); + fprintf(stderr,"\nPRE-DEFINED PLOIDY FILES\n\n"); + fprintf(stderr," * Columns are: CHROM,FROM,TO,SEX,PLOIDY\n"); + fprintf(stderr," * Coordinates are 1-based inclusive.\n"); + fprintf(stderr," * A '*' means any value not otherwise defined.\n\n"); pld = ploidy_predefs; while ( pld->alias ) { From e29f2f538daec0cccc2ca9c3924da8d4876f4cf1 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Fri, 3 Jun 2016 10:22:06 +0100 Subject: [PATCH 181/211] plugin: decrease verbosity of plugin -l, old output via -lv and -lvv --- vcfplugin.c | 33 +++++++++++++++++++-------------- 1 file changed, 19 insertions(+), 14 deletions(-) diff --git a/vcfplugin.c b/vcfplugin.c index 87a773f50..5afdb69cd 100644 --- a/vcfplugin.c +++ b/vcfplugin.c @@ -1,6 +1,6 @@ /* vcfplugin.c -- plugin modules for operating on VCF/BCF files. - Copyright (C) 2013-2015 Genome Research Ltd. + Copyright (C) 2013-2016 Genome Research Ltd. Author: Petr Danecek @@ -47,7 +47,7 @@ typedef struct _plugin_t plugin_t; * Plugin API: * ---------- * const char *about(void) - * - short description used by 'bcftools plugin -l' + * - short description used by 'bcftools plugin -lv' * * const char *usage(void) * - longer description used by 'bcftools +name -h' @@ -170,11 +170,11 @@ static void add_plugin_paths(args_t *args, const char *path) args->plugin_paths = (char**) realloc(args->plugin_paths,sizeof(char*)*(args->nplugin_paths+1)); args->plugin_paths[args->nplugin_paths] = dir; args->nplugin_paths++; - if ( args->verbose ) fprintf(stderr, "plugin directory %s .. ok\n", dir); + if ( args->verbose > 1 ) fprintf(stderr, "plugin directory %s .. ok\n", dir); } else { - if ( args->verbose ) fprintf(stderr, "plugin directory %s .. %s\n", dir, strerror(errno)); + if ( args->verbose > 1 ) fprintf(stderr, "plugin directory %s .. %s\n", dir, strerror(errno)); free(dir); } @@ -210,7 +210,7 @@ static void *dlopen_plugin(args_t *args, const char *fname) { tmp = msprintf("%s/%s.so", args->plugin_paths[i],fname); handle = dlopen(tmp, RTLD_NOW); // valgrind complains about unfreed memory, not our problem though - if ( args->verbose ) + if ( args->verbose > 1 ) { if ( !handle ) fprintf(stderr,"%s:\n\tdlopen .. %s\n", tmp,dlerror()); else fprintf(stderr,"%s:\n\tdlopen .. ok\n", tmp); @@ -221,7 +221,7 @@ static void *dlopen_plugin(args_t *args, const char *fname) } handle = dlopen(fname, RTLD_NOW); - if ( args->verbose ) + if ( args->verbose > 1 ) { if ( !handle ) fprintf(stderr,"%s:\n\tdlopen .. %s\n", fname,dlerror()); else fprintf(stderr,"%s:\n\tdlopen .. ok\n", fname); @@ -266,19 +266,19 @@ static int load_plugin(args_t *args, const char *fname, int exit_on_error, plugi if ( ret ) plugin->init = NULL; else - if ( args->verbose ) fprintf(stderr,"\tinit .. ok\n"); + if ( args->verbose > 1 ) fprintf(stderr,"\tinit .. ok\n"); plugin->run = (dl_run_f) dlsym(plugin->handle, "run"); ret = dlerror(); if ( ret ) plugin->run = NULL; else - if ( args->verbose ) fprintf(stderr,"\trun .. ok\n"); + if ( args->verbose > 1 ) fprintf(stderr,"\trun .. ok\n"); if ( !plugin->init && !plugin->run ) { if ( exit_on_error ) error("Could not initialize %s, neither run or init found \n", plugin->name); - else if ( args->verbose ) fprintf(stderr,"\tinit/run .. not found\n"); + else if ( args->verbose > 1 ) fprintf(stderr,"\tinit/run .. not found\n"); return -1; } @@ -287,7 +287,7 @@ static int load_plugin(args_t *args, const char *fname, int exit_on_error, plugi if ( ret ) { if ( exit_on_error ) error("Could not initialize %s, version string not found\n", plugin->name); - else if ( args->verbose ) fprintf(stderr,"\tversion .. not found\n"); + else if ( args->verbose > 1 ) fprintf(stderr,"\tversion .. not found\n"); return -1; } @@ -392,8 +392,13 @@ static int list_plugins(args_t *args) qsort(plugins, nplugins, sizeof(plugins[0]), cmp_plugin_name); for (i=0; iverbose ) + printf("\n-- %s --\n%s", plugins[i].name, plugins[i].about()); + else + printf("%s\n", plugins[i].name); + } + if ( args->verbose ) printf("\n"); } else print_plugin_usage_hint(); @@ -460,7 +465,7 @@ static void usage(args_t *args) fprintf(stderr, "Plugin options:\n"); fprintf(stderr, " -h, --help list plugin's options\n"); fprintf(stderr, " -l, --list-plugins list available plugins. See BCFTOOLS_PLUGINS environment variable and man page for details\n"); - fprintf(stderr, " -v, --verbose print debugging information on plugin failure\n"); + fprintf(stderr, " -v, --verbose print verbose information, -vv increases verbosity\n"); fprintf(stderr, " -V, --version print version string and exit\n"); fprintf(stderr, "\n"); exit(1); @@ -518,7 +523,7 @@ int main_plugin(int argc, char *argv[]) { switch (c) { case 'V': version_only = 1; break; - case 'v': args->verbose = 1; break; + case 'v': args->verbose++; break; case 'o': args->output_fname = optarg; break; case 'O': switch (optarg[0]) { From 4bf6c480e12fbc5f00ebcce6ee88deace07e6075 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Thu, 31 Mar 2016 09:08:25 +0100 Subject: [PATCH 182/211] tag2tag: new `--gp-to-gt` option --- plugins/tag2tag.c | 68 ++++++++++++++++++++++++++++++++++++++++++----- 1 file changed, 62 insertions(+), 6 deletions(-) diff --git a/plugins/tag2tag.c b/plugins/tag2tag.c index 8178326eb..f56e00eb1 100644 --- a/plugins/tag2tag.c +++ b/plugins/tag2tag.c @@ -1,6 +1,6 @@ -/* plugins/tag2tag.c -- Convert between similar tags, such as GL and GP. +/* plugins/tag2tag.c -- convert between similar tags - Copyright (C) 2014 Genome Research Ltd. + Copyright (C) 2014-2016 Genome Research Ltd. Author: Petr Danecek @@ -33,12 +33,13 @@ DEALINGS IN THE SOFTWARE. */ #define GP_TO_GL 1 #define GL_TO_PL 2 +#define GP_TO_GT 3 static int mode = 0, drop_source_tag = 0; static bcf_hdr_t *in_hdr, *out_hdr; static float *farr = NULL; static int32_t *iarr = NULL; -static int mfarr = 0; +static int mfarr = 0, miarr = 0; const char *about(void) { @@ -55,8 +56,8 @@ const char *usage(void) " run \"bcftools plugin\" for a list of common options\n" "\n" "Plugin options:\n" -//todo " --gl-to-gp convert FORMAT/GL to FORMAT/GP\n" " --gp-to-gl convert FORMAT/GP to FORMAT/GL\n" + " --gp-to-gt convert FORMAT/GP to FORMAT/GT by taking argmax of GP\n" " --gl-to-pl convert FORMAT/GL to FORMAT/PL\n" " -r, --replace drop the source tag\n" "\n" @@ -81,6 +82,7 @@ int init(int argc, char **argv, bcf_hdr_t *in, bcf_hdr_t *out) {"replace",0,0,'r'}, {"gp-to-gl",0,0,1}, {"gl-to-pl",0,0,2}, + {"gp-to-gt",0,0,3}, {0,0,0,0} }; int c; @@ -90,6 +92,7 @@ int init(int argc, char **argv, bcf_hdr_t *in, bcf_hdr_t *out) { case 1 : mode = GP_TO_GL; break; case 2 : mode = GL_TO_PL; break; + case 3 : mode = GP_TO_GT; break; case 'r': drop_source_tag = 1; break; case 'h': case '?': @@ -105,6 +108,8 @@ int init(int argc, char **argv, bcf_hdr_t *in, bcf_hdr_t *out) init_header(out_hdr,drop_source_tag?"GP":NULL,BCF_HL_FMT,"##FORMAT="); else if ( mode==GL_TO_PL ) init_header(out_hdr,drop_source_tag?"GL":NULL,BCF_HL_FMT,"##FORMAT="); + else if ( mode==GP_TO_GT ) + init_header(out_hdr,drop_source_tag?"GP":NULL,BCF_HL_FMT,"##FORMAT="); return 0; } @@ -131,8 +136,7 @@ bcf1_t *process(bcf1_t *rec) fprintf(stderr, "Could not read tag: GL\n"); exit(1); } - - + // create extra space to store converted data iarr = (int32_t*) malloc(n * sizeof(int32_t)); if(!iarr) n = -4; @@ -150,6 +154,58 @@ bcf1_t *process(bcf1_t *rec) if ( drop_source_tag ) bcf_update_format_float(out_hdr,rec,"GL",NULL,0); } + else if ( mode==GP_TO_GT ) + { + int nals = rec->n_allele; + int nsmpl = bcf_hdr_nsamples(in_hdr); + hts_expand(int32_t,nsmpl*2,miarr,iarr); + + n = bcf_get_format_float(in_hdr,rec,"GP",&farr,&mfarr); + n /= nsmpl; + for (i=0; i ptr[jmax] ) jmax = j; + } + + // haploid genotype + if ( j==nals ) + { + iarr[2*i] = bcf_gt_unphased(jmax); + iarr[2*i+1] = bcf_int32_vector_end; + continue; + } + + if ( j!=nals*(nals+1)/2 ) + error("Wrong number of GP values for diploid genotype at %s:%d, expected %d, found %d\n", + bcf_seqname(in_hdr,rec),rec->pos+1, nals*(nals+1)/2,j); + + // most common case: RR + if ( jmax==0 ) + { + iarr[2*i] = iarr[2*i+1] = bcf_gt_unphased(0); + continue; + } + + int a,b; + bcf_gt2alleles(jmax,&a,&b); + iarr[2*i] = bcf_gt_unphased(a); + iarr[2*i+1] = bcf_gt_unphased(b); + } + bcf_update_genotypes(out_hdr,rec,iarr,nsmpl*2); + if ( drop_source_tag ) + bcf_update_format_float(out_hdr,rec,"GP",NULL,0); + } return rec; } From 206c4ee33f6a16e730b51c85c1ce53b63a36bd63 Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Tue, 28 Jun 2016 10:20:30 +0100 Subject: [PATCH 183/211] tag2tag: add hard-call `--threshold` option; add `--gp-to-gt` test --- plugins/tag2tag.c | 41 ++++++++++++++++++++++++++--------------- test/test.pl | 1 + test/view.GP.vcf | 42 ++++++++++++++++++++++++++++++++++++++++++ test/view.GT.vcf | 42 ++++++++++++++++++++++++++++++++++++++++++ 4 files changed, 111 insertions(+), 15 deletions(-) create mode 100644 test/view.GP.vcf create mode 100644 test/view.GT.vcf diff --git a/plugins/tag2tag.c b/plugins/tag2tag.c index f56e00eb1..0dc877a16 100644 --- a/plugins/tag2tag.c +++ b/plugins/tag2tag.c @@ -37,29 +37,30 @@ DEALINGS IN THE SOFTWARE. */ static int mode = 0, drop_source_tag = 0; static bcf_hdr_t *in_hdr, *out_hdr; -static float *farr = NULL; +static float *farr = NULL, thresh = 0.1; static int32_t *iarr = NULL; static int mfarr = 0, miarr = 0; const char *about(void) { - return "Convert between similar tags, such as GL and GP.\n"; + return "Convert between similar tags, such as GL, PL and GP.\n"; } const char *usage(void) { return "\n" - "About: Convert between similar tags, such as GL and GP.\n" + "About: Convert between similar tags, such as GL, PL and GP.\n" "Usage: bcftools +tag2tag [General Options] -- [Plugin Options]\n" "Options:\n" " run \"bcftools plugin\" for a list of common options\n" "\n" "Plugin options:\n" - " --gp-to-gl convert FORMAT/GP to FORMAT/GL\n" - " --gp-to-gt convert FORMAT/GP to FORMAT/GT by taking argmax of GP\n" - " --gl-to-pl convert FORMAT/GL to FORMAT/PL\n" - " -r, --replace drop the source tag\n" + " --gp-to-gl convert FORMAT/GP to FORMAT/GL\n" + " --gp-to-gt convert FORMAT/GP to FORMAT/GT by taking argmax of GP\n" + " --gl-to-pl convert FORMAT/GL to FORMAT/PL\n" + " -r, --replace drop the source tag\n" + " -t, --threshold threshold for GP to GT hard-call [0.1]\n" "\n" "Example:\n" " bcftools +tag2tag in.vcf -- -r --gp-to-gl\n" @@ -79,14 +80,15 @@ int init(int argc, char **argv, bcf_hdr_t *in, bcf_hdr_t *out) { static struct option loptions[] = { - {"replace",0,0,'r'}, - {"gp-to-gl",0,0,1}, - {"gl-to-pl",0,0,2}, - {"gp-to-gt",0,0,3}, - {0,0,0,0} + {"replace",no_argument,NULL,'r'}, + {"gp-to-gl",no_argument,NULL,1}, + {"gl-to-pl",no_argument,NULL,2}, + {"gp-to-gt",no_argument,NULL,3}, + {"threshold",required_argument,NULL,'t'}, + {NULL,0,NULL,0} }; int c; - while ((c = getopt_long(argc, argv, "?hr",loptions,NULL)) >= 0) + while ((c = getopt_long(argc, argv, "?hrt:",loptions,NULL)) >= 0) { switch (c) { @@ -94,6 +96,7 @@ int init(int argc, char **argv, bcf_hdr_t *in, bcf_hdr_t *out) case 2 : mode = GL_TO_PL; break; case 3 : mode = GP_TO_GT; break; case 'r': drop_source_tag = 1; break; + case 't': thresh = atof(optarg); break; case 'h': case '?': default: error("%s", usage()); break; @@ -108,8 +111,10 @@ int init(int argc, char **argv, bcf_hdr_t *in, bcf_hdr_t *out) init_header(out_hdr,drop_source_tag?"GP":NULL,BCF_HL_FMT,"##FORMAT="); else if ( mode==GL_TO_PL ) init_header(out_hdr,drop_source_tag?"GL":NULL,BCF_HL_FMT,"##FORMAT="); - else if ( mode==GP_TO_GT ) + else if ( mode==GP_TO_GT ) { + if (thresh<0||thresh>1) error("--threshold must be in the range [0,1]: %f\n", thresh); init_header(out_hdr,drop_source_tag?"GP":NULL,BCF_HL_FMT,"##FORMAT="); + } return 0; } @@ -181,7 +186,7 @@ bcf1_t *process(bcf1_t *rec) // haploid genotype if ( j==nals ) { - iarr[2*i] = bcf_gt_unphased(jmax); + iarr[2*i] = ptr[jmax] < 1-thresh ? bcf_gt_missing : bcf_gt_unphased(jmax); iarr[2*i+1] = bcf_int32_vector_end; continue; } @@ -190,6 +195,12 @@ bcf1_t *process(bcf1_t *rec) error("Wrong number of GP values for diploid genotype at %s:%d, expected %d, found %d\n", bcf_seqname(in_hdr,rec),rec->pos+1, nals*(nals+1)/2,j); + if (ptr[jmax] < 1-thresh) + { + iarr[2*i] = iarr[2*i+1] = bcf_gt_missing; + continue; + } + // most common case: RR if ( jmax==0 ) { diff --git a/test/test.pl b/test/test.pl index bb4323cd8..c1bf1211f 100755 --- a/test/test.pl +++ b/test/test.pl @@ -190,6 +190,7 @@ test_vcf_plugin($opts,in=>'vcf2sex',out=>'vcf2sex.out',cmd=>'+vcf2sex',args=>'-- -g GT'); test_vcf_plugin($opts,in=>'vcf2sex',out=>'vcf2sex.out',cmd=>'+vcf2sex',args=>'-- -g GT -n 5'); test_vcf_plugin($opts,in=>'view.GL',out=>'view.PL.vcf',cmd=>'+tag2tag --no-version',args=>'-- -r --gl-to-pl'); +test_vcf_plugin($opts,in=>'view.GP',out=>'view.GT.vcf',cmd=>'+tag2tag --no-version',args=>'-- -r --gp-to-gt -t 0.2'); test_vcf_plugin($opts,in=>'merge.a',out=>'fill-tags.out',cmd=>'+fill-tags --no-version',args=>'-- -t AN,AC,AC_Hom,AC_Het,AC_Hemi'); test_vcf_plugin($opts,in=>'view',out=>'fill-tags.2.out',cmd=>'+fill-tags --no-version',args=>'-- -t AC,AN,AF,NS'); test_vcf_plugin($opts,in=>'view',out=>'view.GTisec.out',cmd=>'+GTisec',args=>' | grep -v bcftools'); diff --git a/test/view.GP.vcf b/test/view.GP.vcf new file mode 100644 index 000000000..cf5beed2d --- /dev/null +++ b/test/view.GP.vcf @@ -0,0 +1,42 @@ +##fileformat=VCFv4.2 +##FILTER= +##contig= +##contig= +##FORMAT= +#CHROM POS ID REF ALT QUAL FILTER INFO FORMAT NA12890 NA12891 NA12892 +22 16050159 . C T 68 . . GP 0.962,0.038,0 0,1,0 1,0,0 +22 16050252 . A T 85 . . GP 0.934,0.059,0.007 0,1,0 1,0,0 +22 16051249 . T C 32.1761 . . GP 0,1,0 1,0,0 1,0,0 +22 16051347 . G C 283 . . GP 0,0.443,0.557 0,1,0 1,0,0 +22 16051453 . A C 3.42882 . . GP 0.001,0.999,0 1,0,0 1,0,0 +22 16051497 . A G 362 . . GP 0,0.008,0.992 0,1,0 1,0,0 +22 16051968 . C A 136 . . GP 0.972,0.024,0.003 0,1,0 1,0,0 +22 16052167 . AAAACAAACAAACAAACAAACAAACAAACAAAC AAAACAAACAAACAAACAAACAAACAAACAAACAAACAAAC 217 . . GP 0.333,0.333,0.333 0,0,1 1,0,0 +22 16052169 . AACAAACA AACAAACAGACAAACA 241 . . GP 0.003,0.995,0.002 0,1,0 1,0,0 +22 16052180 . AAAC AAACCAACTAAC 221 . . GP 0.909,0.091,0 0,1,0 1,0,0 +22 16052239 . A G 172 . . GP 0.984,0.016,0 0,1,0 1,0,0 +22 16052513 . G C 153 . . GP 1,0,0 0,1,0 1,0,0 +22 16052618 . G A 124 . . GP 0.997,0.003,0 0,1,0 1,0,0 +22 16053659 . A C 352 . . GP 0,0.002,0.998 0,0,1 1,0,0 +22 16053791 . C A 287 . . GP 0,1,0 0,1,0 1,0,0 +22 16054454 . C T 14.2772 . . GP 0,0.76,0.24 1,0,0 1,0,0 +22 16054667 . C G 179 . . GP 0.998,0.002,0 0,1,0 1,0,0 +22 16054740 . A G 126 . . GP 0.994,0.006,0 0,1,0 1,0,0 +22 16055942 . C T 385 . . GP 0,0.008,0.992 0,0,1 1,0,0 +22 16056126 . G A 263 . . GP 0,0.969,0.031 0,1,0 1,0,0 +22 16056854 . G GA 17.3105 . . GP 0.996,0.004,0 0,1,0 1,0,0 +22 16057248 . G A 167 . . GP 0.988,0.012,0 0,1,0 1,0,0 +22 16057320 . G A 20.0168 . . GP 0,0.998,0.002 1,0,0 1,0,0 +22 16057417 . C T 16.3704 . . GP 0,1,0 1,0,0 1,0,0 +22 16058070 . A G 452 . . GP 0,0,1 0,0,1 0,0,1 +22 16058415 . A G 212 . . GP 0.997,0.003,0 0,0,1 1,0,0 +22 16058463 . C T 136 . . GP 0,0.666,0.334 1,0,0 1,0,0 +22 16058758 . C A 107 . . GP 0,0.166,0.834 1,0,0 1,0,0 +22 16058766 . G A 15.517 . . GP 0.999,0.001,0 0,0.201,0.799 1,0,0 +22 16058852 . A T 198 . . GP 0,0.112,0.888 0,0,1 1,0,0 +22 16058883 . A G 129 . . GP 0,0.334,0.666 0,0,1 1,0,0 +22 16059081 . A G 212 . . GP 0.984,0.016,0 0,0,1 1,0,0 +22 16059734 . C T 114 . . GP 0,0.038,0.962 1,0,0 1,0,0 +22 16059753 . A T 212 . . GP 0.998,0.002,0 0,0,1 1,0,0 +Y 16059973 . C A 195 . . GP 0.975,0.025 1,0 0,1 +Y 16060178 . G A 187 . . GP 0.969,0.031 0,1 0.5,0.5 diff --git a/test/view.GT.vcf b/test/view.GT.vcf new file mode 100644 index 000000000..2cf172559 --- /dev/null +++ b/test/view.GT.vcf @@ -0,0 +1,42 @@ +##fileformat=VCFv4.2 +##FILTER= +##contig= +##contig= +##FORMAT= +#CHROM POS ID REF ALT QUAL FILTER INFO FORMAT NA12890 NA12891 NA12892 +22 16050159 . C T 68 . . GT 0/0 0/1 0/0 +22 16050252 . A T 85 . . GT 0/0 0/1 0/0 +22 16051249 . T C 32.1761 . . GT 0/1 0/0 0/0 +22 16051347 . G C 283 . . GT ./. 0/1 0/0 +22 16051453 . A C 3.42882 . . GT 0/1 0/0 0/0 +22 16051497 . A G 362 . . GT 1/1 0/1 0/0 +22 16051968 . C A 136 . . GT 0/0 0/1 0/0 +22 16052167 . AAAACAAACAAACAAACAAACAAACAAACAAAC AAAACAAACAAACAAACAAACAAACAAACAAACAAACAAAC 217 . . GT ./. 1/1 0/0 +22 16052169 . AACAAACA AACAAACAGACAAACA 241 . . GT 0/1 0/1 0/0 +22 16052180 . AAAC AAACCAACTAAC 221 . . GT 0/0 0/1 0/0 +22 16052239 . A G 172 . . GT 0/0 0/1 0/0 +22 16052513 . G C 153 . . GT 0/0 0/1 0/0 +22 16052618 . G A 124 . . GT 0/0 0/1 0/0 +22 16053659 . A C 352 . . GT 1/1 1/1 0/0 +22 16053791 . C A 287 . . GT 0/1 0/1 0/0 +22 16054454 . C T 14.2772 . . GT ./. 0/0 0/0 +22 16054667 . C G 179 . . GT 0/0 0/1 0/0 +22 16054740 . A G 126 . . GT 0/0 0/1 0/0 +22 16055942 . C T 385 . . GT 1/1 1/1 0/0 +22 16056126 . G A 263 . . GT 0/1 0/1 0/0 +22 16056854 . G GA 17.3105 . . GT 0/0 0/1 0/0 +22 16057248 . G A 167 . . GT 0/0 0/1 0/0 +22 16057320 . G A 20.0168 . . GT 0/1 0/0 0/0 +22 16057417 . C T 16.3704 . . GT 0/1 0/0 0/0 +22 16058070 . A G 452 . . GT 1/1 1/1 1/1 +22 16058415 . A G 212 . . GT 0/0 1/1 0/0 +22 16058463 . C T 136 . . GT ./. 0/0 0/0 +22 16058758 . C A 107 . . GT 1/1 0/0 0/0 +22 16058766 . G A 15.517 . . GT 0/0 ./. 0/0 +22 16058852 . A T 198 . . GT 1/1 1/1 0/0 +22 16058883 . A G 129 . . GT ./. 1/1 0/0 +22 16059081 . A G 212 . . GT 0/0 1/1 0/0 +22 16059734 . C T 114 . . GT 1/1 0/0 0/0 +22 16059753 . A T 212 . . GT 0/0 1/1 0/0 +Y 16059973 . C A 195 . . GT 0 0 1 +Y 16060178 . G A 187 . . GT 0 1 . From 3c7df1dd22ad42f9dfe0e4afc83e690db5019918 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Wed, 3 Feb 2016 15:10:18 +0000 Subject: [PATCH 184/211] plugin: new trio-switch-rate plugin --- plugins/trio-switch-rate.c | 264 +++++++++++++++++++++++++++++++++++++ 1 file changed, 264 insertions(+) create mode 100644 plugins/trio-switch-rate.c diff --git a/plugins/trio-switch-rate.c b/plugins/trio-switch-rate.c new file mode 100644 index 000000000..254d8c1fd --- /dev/null +++ b/plugins/trio-switch-rate.c @@ -0,0 +1,264 @@ +/* The MIT License + + Copyright (c) 2016 Genome Research Ltd. + + Author: Petr Danecek + + Permission is hereby granted, free of charge, to any person obtaining a copy + of this software and associated documentation files (the "Software"), to deal + in the Software without restriction, including without limitation the rights + to use, copy, modify, merge, publish, distribute, sublicense, and/or sell + copies of the Software, and to permit persons to whom the Software is + furnished to do so, subject to the following conditions: + + The above copyright notice and this permission notice shall be included in + all copies or substantial portions of the Software. + + THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS OR + IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF MERCHANTABILITY, + FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. IN NO EVENT SHALL THE + AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY CLAIM, DAMAGES OR OTHER + LIABILITY, WHETHER IN AN ACTION OF CONTRACT, TORT OR OTHERWISE, ARISING FROM, + OUT OF OR IN CONNECTION WITH THE SOFTWARE OR THE USE OR OTHER DEALINGS IN + THE SOFTWARE. + + */ + +#include +#include +#include +#include +#include +#include +#include +#include +#include +#include "bcftools.h" + +typedef struct +{ + int father, mother, child; // VCF sample index + int prev, ipop; + uint32_t err, nswitch, ntest; +} +trio_t; + +typedef struct +{ + char *name; + uint32_t err, nswitch, ntest, ntrio; + float pswitch; +} +pop_t; + +typedef struct +{ + int argc; + char **argv; + bcf_hdr_t *hdr; + trio_t *trio; + int ntrio, mtrio; + int32_t *gt_arr; + int npop; + pop_t *pop; + int mgt_arr, prev_rid; +} +args_t; + +args_t args; + +const char *about(void) +{ + return "Calculate phase switch rate in trio samples, children samples must have phased GTs.\n"; +} + +const char *usage(void) +{ + return + "\n" + "About: Calculate phase switch rate in trio children.\n" + "Usage: bcftools +trio-swich-rate [General Options] -- [Plugin Options]\n" + "Options:\n" + " run \"bcftools plugin\" for a list of common options\n" + "\n" + "Plugin options:\n" + " -p, --ped \n" + "\n" + "Example:\n" + " bcftools +trio-switch-rate file.bcf -- -p file.ped\n" + "\n"; +} + +void parse_ped(args_t *args, char *fname) +{ + htsFile *fp = hts_open(fname, "r"); + if ( !fp ) error("Could not read: %s\n", fname); + + kstring_t str = {0,0,0}; + if ( hts_getline(fp, KS_SEP_LINE, &str) <= 0 ) error("Empty file: %s\n", fname); + + void *pop2i = khash_str2int_init(); + + int moff = 0, *off = NULL; + while ( hts_getline(fp, KS_SEP_LINE, &str)>=0 ) + { + // BB03 HG01884 HG01885 HG01956 2 0 ACB child 0 0 0 0 + int ncols = ksplit_core(str.s,'\t',&moff,&off); + if ( ncols<4 ) error("Could not parse the ped file: %s\n", str.s); + + int father = bcf_hdr_id2int(args->hdr,BCF_DT_SAMPLE,&str.s[off[2]]); + if ( father<0 ) continue; + int mother = bcf_hdr_id2int(args->hdr,BCF_DT_SAMPLE,&str.s[off[3]]); + if ( mother<0 ) continue; + int child = bcf_hdr_id2int(args->hdr,BCF_DT_SAMPLE,&str.s[off[1]]); + if ( child<0 ) continue; + + args->ntrio++; + hts_expand0(trio_t,args->ntrio,args->mtrio,args->trio); + trio_t *trio = &args->trio[args->ntrio-1]; + trio->father = father; + trio->mother = mother; + trio->child = child; + + char *pop_name = &str.s[off[6]]; + if ( !khash_str2int_has_key(pop2i,pop_name) ) + { + pop_name = strdup(&str.s[off[6]]); + khash_str2int_set(pop2i,pop_name,args->npop); + args->npop++; + args->pop = (pop_t*) realloc(args->pop,args->npop*sizeof(*args->pop)); + memset(args->pop+args->npop-1,0,sizeof(*args->pop)); + args->pop[args->npop-1].name = pop_name; + } + khash_str2int_get(pop2i,pop_name,&trio->ipop); + args->pop[trio->ipop].ntrio++; + } + + khash_str2int_destroy(pop2i); + free(str.s); + free(off); + hts_close(fp); +} + +int init(int argc, char **argv, bcf_hdr_t *in, bcf_hdr_t *out) +{ + memset(&args,0,sizeof(args_t)); + args.argc = argc; args.argv = argv; + args.prev_rid = -1; + args.hdr = in; + char *ped_fname = NULL; + static struct option loptions[] = + { + {"ped",1,0,'p'}, + {0,0,0,0} + }; + int c; + while ((c = getopt_long(argc, argv, "?hp:",loptions,NULL)) >= 0) + { + switch (c) + { + case 'p': ped_fname = optarg; break; + case 'h': + case '?': + default: error("%s", usage()); break; + } + } + if ( !ped_fname ) error("Expected the -p option\n"); + parse_ped(&args, ped_fname); + return 1; +} + +typedef struct +{ + int a, b, phased; +} +gt_t; + +inline int parse_genotype(gt_t *gt, int32_t *ptr) +{ + if ( ptr[0]==bcf_gt_missing ) return 0; + if ( ptr[1]==bcf_gt_missing ) return 0; + if ( ptr[1]==bcf_int32_vector_end ) return 0; + gt->phased = bcf_gt_is_phased(ptr[1]) ? 1 : 0; + gt->a = bcf_gt_allele(ptr[0]); if ( gt->a > 1 ) return 0; // consider only the first two alleles at biallelic sites + gt->b = bcf_gt_allele(ptr[1]); if ( gt->b > 1 ) return 0; + return 1; +} + +bcf1_t *process(bcf1_t *rec) +{ + int ngt = bcf_get_genotypes(args.hdr, rec, &args.gt_arr, &args.mgt_arr); + if ( ngt<0 ) return NULL; + ngt /= bcf_hdr_nsamples(args.hdr); + if ( ngt!=2 ) return NULL; + + int i; + if ( rec->rid!=args.prev_rid ) + { + args.prev_rid = rec->rid; + for (i=0; ichild) ) continue; + if ( !child.phased ) continue; + if ( child.a+child.b != 1 ) continue; // child is not a het + + if ( !parse_genotype(&father, args.gt_arr + ngt*trio->father) ) continue; + if ( !parse_genotype(&mother, args.gt_arr + ngt*trio->mother) ) continue; + if ( father.a+father.b == 1 && mother.a+mother.b == 1 ) continue; // both parents are hets + if ( father.a+father.b == mother.a+mother.b ) { trio->err++; continue; } // mendelian error + + int test_phase = 0; + if ( father.a==father.b ) test_phase = 1 + (child.a==father.a); + else if ( mother.a==mother.b ) test_phase = 1 + (child.b==mother.a); + if ( trio->prev > 0 ) + { + if ( trio->prev!=test_phase ) trio->nswitch++; + } + trio->ntest++; + trio->prev = test_phase; + } + return NULL; +} + +void destroy(void) +{ + int i; + printf("# This file was produced by: bcftools +trio-switch-rate(%s+htslib-%s)\n", bcftools_version(),hts_version()); + printf("# The command line was:\tbcftools +%s", args.argv[0]); + for (i=1; ifather), + bcf_hdr_int2id(args.hdr,BCF_DT_SAMPLE,trio->mother), + bcf_hdr_int2id(args.hdr,BCF_DT_SAMPLE,trio->child), + trio->ntest, trio->err, trio->nswitch, trio->nswitch*100./trio->ntest + ); + pop_t *pop = &args.pop[trio->ipop]; + pop->err += trio->err; + pop->nswitch += trio->nswitch; + pop->ntest += trio->ntest; + pop->pswitch += trio->nswitch*100./trio->ntest; + } + for (i=0; iname,pop->ntrio, + (float)pop->ntest/pop->ntrio,(float)pop->err/pop->ntrio,(float)pop->nswitch/pop->ntrio, + pop->pswitch/pop->ntrio); + } + for (i=0; i Date: Mon, 27 Jun 2016 13:31:22 +0100 Subject: [PATCH 185/211] trio-switch-rate: add test and clean a few edge cases * added a test * do not ignore the first line of the PED file. Standard PED files do not have a header line * prevent segfault when population column is not provided - this is an optional column * fix divide by zero case * PED files can be space or tab delimited * declare inline `parse_genotype` function to avoid undefined symbol error when compiling with `-std=gnu99` --- plugins/trio-switch-rate.c | 57 ++++++++++++++++++++++---------------- test/test.pl | 1 + test/trio.out | 7 +++++ test/trio.ped | 6 ++++ test/trio.vcf | 16 +++++++++++ 5 files changed, 63 insertions(+), 24 deletions(-) create mode 100644 test/trio.out create mode 100644 test/trio.ped create mode 100644 test/trio.vcf diff --git a/plugins/trio-switch-rate.c b/plugins/trio-switch-rate.c index 254d8c1fd..34f840dd1 100644 --- a/plugins/trio-switch-rate.c +++ b/plugins/trio-switch-rate.c @@ -82,7 +82,8 @@ const char *usage(void) " run \"bcftools plugin\" for a list of common options\n" "\n" "Plugin options:\n" - " -p, --ped \n" + " -p, --ped PED file with optional 7th column to group\n" + " results by population\n" "\n" "Example:\n" " bcftools +trio-switch-rate file.bcf -- -p file.ped\n" @@ -100,10 +101,11 @@ void parse_ped(args_t *args, char *fname) void *pop2i = khash_str2int_init(); int moff = 0, *off = NULL; - while ( hts_getline(fp, KS_SEP_LINE, &str)>=0 ) + do { + // familyID sampleID paternalID maternalID sex phenotype population relationship siblings secondOrder thirdOrder children comment // BB03 HG01884 HG01885 HG01956 2 0 ACB child 0 0 0 0 - int ncols = ksplit_core(str.s,'\t',&moff,&off); + int ncols = ksplit_core(str.s,0,&moff,&off); if ( ncols<4 ) error("Could not parse the ped file: %s\n", str.s); int father = bcf_hdr_id2int(args->hdr,BCF_DT_SAMPLE,&str.s[off[2]]); @@ -120,19 +122,21 @@ void parse_ped(args_t *args, char *fname) trio->mother = mother; trio->child = child; - char *pop_name = &str.s[off[6]]; - if ( !khash_str2int_has_key(pop2i,pop_name) ) - { - pop_name = strdup(&str.s[off[6]]); - khash_str2int_set(pop2i,pop_name,args->npop); - args->npop++; - args->pop = (pop_t*) realloc(args->pop,args->npop*sizeof(*args->pop)); - memset(args->pop+args->npop-1,0,sizeof(*args->pop)); - args->pop[args->npop-1].name = pop_name; + if (ncols>6) { + char *pop_name = &str.s[off[6]]; + if ( !khash_str2int_has_key(pop2i,pop_name) ) + { + pop_name = strdup(&str.s[off[6]]); + khash_str2int_set(pop2i,pop_name,args->npop); + args->npop++; + args->pop = (pop_t*) realloc(args->pop,args->npop*sizeof(*args->pop)); + memset(args->pop+args->npop-1,0,sizeof(*args->pop)); + args->pop[args->npop-1].name = pop_name; + } + khash_str2int_get(pop2i,pop_name,&trio->ipop); + args->pop[trio->ipop].ntrio++; } - khash_str2int_get(pop2i,pop_name,&trio->ipop); - args->pop[trio->ipop].ntrio++; - } + } while ( hts_getline(fp, KS_SEP_LINE, &str)>=0 ); khash_str2int_destroy(pop2i); free(str.s); @@ -149,7 +153,7 @@ int init(int argc, char **argv, bcf_hdr_t *in, bcf_hdr_t *out) char *ped_fname = NULL; static struct option loptions[] = { - {"ped",1,0,'p'}, + {"ped",required_argument,NULL,'p'}, {0,0,0,0} }; int c; @@ -174,6 +178,8 @@ typedef struct } gt_t; +int parse_genotype(gt_t *gt, int32_t *ptr); + inline int parse_genotype(gt_t *gt, int32_t *ptr) { if ( ptr[0]==bcf_gt_missing ) return 0; @@ -230,11 +236,10 @@ void destroy(void) { int i; printf("# This file was produced by: bcftools +trio-switch-rate(%s+htslib-%s)\n", bcftools_version(),hts_version()); - printf("# The command line was:\tbcftools +%s", args.argv[0]); + printf("# The command line was:\tbcftools +trio-switch-rate %s", args.argv[0]); for (i=1; ifather), bcf_hdr_int2id(args.hdr,BCF_DT_SAMPLE,trio->mother), bcf_hdr_int2id(args.hdr,BCF_DT_SAMPLE,trio->child), - trio->ntest, trio->err, trio->nswitch, trio->nswitch*100./trio->ntest + trio->ntest, trio->err, trio->nswitch, trio->ntest ? trio->nswitch*100./trio->ntest : 0 ); - pop_t *pop = &args.pop[trio->ipop]; - pop->err += trio->err; - pop->nswitch += trio->nswitch; - pop->ntest += trio->ntest; - pop->pswitch += trio->nswitch*100./trio->ntest; + if (args.npop) { + pop_t *pop = &args.pop[trio->ipop]; + pop->err += trio->err; + pop->nswitch += trio->nswitch; + pop->ntest += trio->ntest; + pop->pswitch += trio->ntest ? trio->nswitch*100./trio->ntest : 0; + } } + printf("# POP\tpopulation or other grouping defined by an optional 7-th column of the PED file\n"); + printf("# POP\t[2]Name\t[3]Number of trios\t[4]avgTested\t[5]avgMendelian Errors\t[6]avgSwitch\t[7]avgSwitch (%%)\n"); for (i=0; i'view',out=>'view.GTisec.m.out',cmd=>'+GTisec',args=>'-- -m | grep -v bcftools'); test_vcf_plugin($opts,in=>'view',out=>'view.GTisec.mv.out',cmd=>'+GTisec',args=>'-- -mv | grep -v bcftools'); test_vcf_plugin($opts,in=>'view',out=>'view.GTisec.v.out',cmd=>'+GTisec',args=>'-- -v | grep -v bcftools'); +test_vcf_plugin($opts,in=>'trio',out=>'trio.out',cmd=>'+trio-switch-rate',args=>'-- -p {PATH}/trio.ped | grep -v bcftools'); test_vcf_concat($opts,in=>['concat.1.a','concat.1.b'],out=>'concat.1.vcf.out',do_bcf=>0,args=>''); test_vcf_concat($opts,in=>['concat.1.a','concat.1.b'],out=>'concat.1.bcf.out',do_bcf=>1,args=>''); test_vcf_concat($opts,in=>['concat.2.a','concat.2.b'],out=>'concat.2.vcf.out',do_bcf=>0,args=>'-a'); diff --git a/test/trio.out b/test/trio.out new file mode 100644 index 000000000..6c9f4a673 --- /dev/null +++ b/test/trio.out @@ -0,0 +1,7 @@ +# +# TRIO [2]Father [3]Mother [4]Child [5]nTested [6]nMendelian Errors [7]nSwitch [8]nSwitch (%) +TRIO HG00101 HG00102 HG00100 5 4 0 0.00 +TRIO HG00201 HG00202 HG00200 11 0 2 18.18 +# POP population or other grouping defined by an optional 7-th column of the PED file +# POP [2]Name [3]Number of trios [4]avgTested [5]avgMendelian Errors [6]avgSwitch [7]avgSwitch (%) +POP CEU 2 8 2 1 9.09 diff --git a/test/trio.ped b/test/trio.ped new file mode 100644 index 000000000..22fa04951 --- /dev/null +++ b/test/trio.ped @@ -0,0 +1,6 @@ +HG00100 HG00100 HG00101 HG00102 2 0 CEU +HG00101 HG00101 0 0 1 0 CEU +HG00102 HG00102 0 0 2 0 CEU +HG00200 HG00200 HG00201 HG00202 2 0 CEU +HG00201 HG00201 0 0 1 0 CEU +HG00202 HG00202 0 0 2 0 CEU diff --git a/test/trio.vcf b/test/trio.vcf new file mode 100644 index 000000000..a9f36c0c4 --- /dev/null +++ b/test/trio.vcf @@ -0,0 +1,16 @@ +##fileformat=VCFv4.2 +##FILTER= +##contig= +##FORMAT= +#CHROM POS ID REF ALT QUAL FILTER INFO FORMAT HG00100 HG00101 HG00102 HG00200 HG00201 HG00202 +20 302 . T TA 999 . . GT 0|1 1|0 1|1 0|1 1|0 1|1 +20 828 . T C 999 . . GT 0|1 1|1 1|1 0|1 1|0 1|1 +20 834 . G A 999 . . GT 0|1 0|1 1|1 1|0 1|0 1|1 +20 1665 . T C 999 . . GT 1|0 0|1 0|1 0|1 1|0 1|1 +20 1869 . A T 999 . . GT 0|1 0|0 1|1 0|1 1|0 1|1 +20 2041 . G A 999 . . GT 0|1 1|1 1|1 0|1 1|0 1|1 +20 2220 . G A 999 . . GT 0|1 1|0 1|1 0|1 1|0 1|1 +20 2564 . A G 999 . . GT 0|1 1|1 1|1 0|1 1|0 1|1 +20 3104 . C T 999 . . GT 0|0 0|0 0|1 0|1 1|0 1|1 +20 3587 . G A 999 . . GT 0|1 0|1 1|1 0|1 1|0 1|1 +20 3936 . A G 999 . . GT 0|1 1|1 1|1 0|1 1|0 1|1 From c78a6f50bbb7c5dde953d7896dbde5f82b45a27f Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Thu, 17 Mar 2016 15:26:35 +0000 Subject: [PATCH 186/211] plugin: new plugin to detect sites with statistically significant differences in FMT/AD --- plugins/ad-bias.c | 206 ++++++++++++++++++++++++++++++++++++++++++++++ 1 file changed, 206 insertions(+) create mode 100644 plugins/ad-bias.c diff --git a/plugins/ad-bias.c b/plugins/ad-bias.c new file mode 100644 index 000000000..6dcac7c96 --- /dev/null +++ b/plugins/ad-bias.c @@ -0,0 +1,206 @@ +/* The MIT License + + Copyright (c) 2016 Genome Research Ltd. + + Author: Petr Danecek + + Permission is hereby granted, free of charge, to any person obtaining a copy + of this software and associated documentation files (the "Software"), to deal + in the Software without restriction, including without limitation the rights + to use, copy, modify, merge, publish, distribute, sublicense, and/or sell + copies of the Software, and to permit persons to whom the Software is + furnished to do so, subject to the following conditions: + + The above copyright notice and this permission notice shall be included in + all copies or substantial portions of the Software. + + THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS OR + IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF MERCHANTABILITY, + FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. IN NO EVENT SHALL THE + AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY CLAIM, DAMAGES OR OTHER + LIABILITY, WHETHER IN AN ACTION OF CONTRACT, TORT OR OTHERWISE, ARISING FROM, + OUT OF OR IN CONNECTION WITH THE SOFTWARE OR THE USE OR OTHER DEALINGS IN + THE SOFTWARE. + + */ + +#include +#include +#include +#include +#include +#include +#include +#include +#include +#include +#include "bcftools.h" +#include "convert.h" + +typedef struct +{ + int smpl,ctrl; // VCF sample index + const char *smpl_name, *ctrl_name; +} +pair_t; + +typedef struct +{ + bcf_hdr_t *hdr; + pair_t *pair; + int npair, mpair; + int32_t *ad_arr; + int mad_arr; + double th; + convert_t *convert; + kstring_t str; + uint64_t nsite,ncmp; +} +args_t; + +args_t args; + +const char *about(void) +{ + return "Find positions with wildly varying ALT allele frequency (Fisher test on FMT/AD).\n"; +} + +const char *usage(void) +{ + return + "\n" + "About: Find positions with wildly varying ALT allele frequency (Fisher test on FMT/AD).\n" + "Usage: bcftools +ad-bias [General Options] -- [Plugin Options]\n" + "Options:\n" + " run \"bcftools plugin\" for a list of common options\n" + "\n" + "Plugin options:\n" + " -f, --format Optional tags to append to output (`bcftools query` style of format)\n" + " -s, --samples List of sample pairs, one tab-delimited pair per line\n" + " -t, --threshold Output only hits with p-value smaller than [1e-3]\n" + "\n" + "Example:\n" + " bcftools +ad-bias file.bcf -- -t 1e-3 -s samples.txt\n" + "\n"; +} + +void parse_samples(args_t *args, char *fname) +{ + htsFile *fp = hts_open(fname, "r"); + if ( !fp ) error("Could not read: %s\n", fname); + + kstring_t str = {0,0,0}; + if ( hts_getline(fp, KS_SEP_LINE, &str) <= 0 ) error("Empty file: %s\n", fname); + + int moff = 0, *off = NULL; + while ( hts_getline(fp, KS_SEP_LINE, &str)>=0 ) + { + // HPSI0513i-veqz_6 HPSI0513pf-veqz + int ncols = ksplit_core(str.s,'\t',&moff,&off); + if ( ncols<2 ) error("Could not parse the sample file: %s\n", str.s); + + int smpl = bcf_hdr_id2int(args->hdr,BCF_DT_SAMPLE,&str.s[off[0]]); + if ( smpl<0 ) continue; + int ctrl = bcf_hdr_id2int(args->hdr,BCF_DT_SAMPLE,&str.s[off[1]]); + if ( ctrl<0 ) continue; + + args->npair++; + hts_expand0(pair_t,args->npair,args->mpair,args->pair); + pair_t *pair = &args->pair[args->npair-1]; + pair->ctrl = ctrl; + pair->smpl = smpl; + pair->smpl_name = bcf_hdr_int2id(args->hdr,BCF_DT_SAMPLE,pair->smpl); + pair->ctrl_name = bcf_hdr_int2id(args->hdr,BCF_DT_SAMPLE,pair->ctrl); + } + + free(str.s); + free(off); + hts_close(fp); +} + +int init(int argc, char **argv, bcf_hdr_t *in, bcf_hdr_t *out) +{ + memset(&args,0,sizeof(args_t)); + args.hdr = in; + args.th = 1e-3; + char *fname = NULL, *format = NULL; + static struct option loptions[] = + { + {"format",1,0,'f'}, + {"samples",1,0,'s'}, + {"threshold",1,0,'t'}, + {0,0,0,0} + }; + int c; + char *tmp; + while ((c = getopt_long(argc, argv, "?hs:t:f:",loptions,NULL)) >= 0) + { + switch (c) + { + case 't': + args.th = strtod(optarg,&tmp); + if ( *tmp ) error("Could not parse: -t %s\n", optarg); + break; + case 's': fname = optarg; break; + case 'f': format = optarg; break; + case 'h': + case '?': + default: error("%s", usage()); break; + } + } + if ( !fname ) error("Expected the -s option\n"); + parse_samples(&args, fname); + if ( format ) args.convert = convert_init(args.hdr, NULL, 0, format); + printf("# [1]FT, Fisher Test\t[2]Sample\t[3]Control\t[4]Chrom\t[5]Pos\t[6]smpl.nREF\t[7]smpl.nALT\t[8]ctrl.nREF\t[9]ctrl.nALT\t[10]P-value"); + if ( format ) printf("\t[11-]User data: %s", format); + printf("\n"); + printf("# [1]SN, Summary Numbers\t[2]Number of Pairs\t[3]Number of Sites\t[4]Number of comparisons\t[5]P-value output threshold\n"); + return 1; +} + +bcf1_t *process(bcf1_t *rec) +{ + int nad = bcf_get_format_int32(args.hdr, rec, "AD", &args.ad_arr, &args.mad_arr); + if ( nad<0 ) return NULL; + nad /= bcf_hdr_nsamples(args.hdr); + + if ( args.convert ) convert_line(args.convert, rec, &args.str); + args.nsite++; + + int i; + for (i=0; ismpl; + int32_t *bptr = args.ad_arr + nad*pair->ctrl; + + if ( aptr[0]==bcf_int32_missing ) continue; + if ( bptr[0]==bcf_int32_missing ) continue; + + args.ncmp++; + + int n11 = aptr[0], n12 = aptr[1]; + int n21 = bptr[0], n22 = bptr[1]; + double left, right, two; + double fisher = kt_fisher_exact(n11,n12,n21,n22, &left,&right,&two); + if ( fisher >= args.th ) continue; + + printf("FT\t%s\t%s\t%s\t%d\t%d\t%d\t%d\t%d\t%e", + pair->smpl_name,pair->ctrl_name, + bcf_hdr_id2name(args.hdr,rec->rid), rec->pos+1, + n11,n12,n21,n22, fisher + ); + if ( args.convert ) printf("\t%s", args.str.s); + printf("\n"); + } + return NULL; +} + +void destroy(void) +{ + printf("SN\t%d\t%"PRId64"\t%"PRId64"\t%e\n",args.npair,args.nsite,args.ncmp,args.th); + if ( args.convert) convert_destroy(args.convert); + free(args.str.s); + free(args.pair); + free(args.ad_arr); +} From dd118898d198836d3cd54f97d891cdf7c8195624 Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Tue, 28 Jun 2016 09:00:17 +0100 Subject: [PATCH 187/211] ad-bias: do not skip first line of samples file; added test --- plugins/ad-bias.c | 22 +++++++++++++--------- test/ad-bias.out | 25 +++++++++++++++++++++++++ test/ad-bias.samples | 2 ++ test/ad-bias.vcf | 42 ++++++++++++++++++++++++++++++++++++++++++ test/test.pl | 1 + 5 files changed, 83 insertions(+), 9 deletions(-) create mode 100644 test/ad-bias.out create mode 100644 test/ad-bias.samples create mode 100644 test/ad-bias.vcf diff --git a/plugins/ad-bias.c b/plugins/ad-bias.c index 6dcac7c96..f0a993701 100644 --- a/plugins/ad-bias.c +++ b/plugins/ad-bias.c @@ -93,7 +93,7 @@ void parse_samples(args_t *args, char *fname) if ( hts_getline(fp, KS_SEP_LINE, &str) <= 0 ) error("Empty file: %s\n", fname); int moff = 0, *off = NULL; - while ( hts_getline(fp, KS_SEP_LINE, &str)>=0 ) + do { // HPSI0513i-veqz_6 HPSI0513pf-veqz int ncols = ksplit_core(str.s,'\t',&moff,&off); @@ -111,7 +111,7 @@ void parse_samples(args_t *args, char *fname) pair->smpl = smpl; pair->smpl_name = bcf_hdr_int2id(args->hdr,BCF_DT_SAMPLE,pair->smpl); pair->ctrl_name = bcf_hdr_int2id(args->hdr,BCF_DT_SAMPLE,pair->ctrl); - } + } while ( hts_getline(fp, KS_SEP_LINE, &str)>=0 ); free(str.s); free(off); @@ -126,10 +126,10 @@ int init(int argc, char **argv, bcf_hdr_t *in, bcf_hdr_t *out) char *fname = NULL, *format = NULL; static struct option loptions[] = { - {"format",1,0,'f'}, - {"samples",1,0,'s'}, - {"threshold",1,0,'t'}, - {0,0,0,0} + {"format",required_argument,NULL,'f'}, + {"samples",required_argument,NULL,'s'}, + {"threshold",required_argument,NULL,'t'}, + {NULL,0,NULL,0} }; int c; char *tmp; @@ -151,10 +151,13 @@ int init(int argc, char **argv, bcf_hdr_t *in, bcf_hdr_t *out) if ( !fname ) error("Expected the -s option\n"); parse_samples(&args, fname); if ( format ) args.convert = convert_init(args.hdr, NULL, 0, format); - printf("# [1]FT, Fisher Test\t[2]Sample\t[3]Control\t[4]Chrom\t[5]Pos\t[6]smpl.nREF\t[7]smpl.nALT\t[8]ctrl.nREF\t[9]ctrl.nALT\t[10]P-value"); + printf("# This file was produced by: bcftools +ad-bias(%s+htslib-%s)\n", bcftools_version(),hts_version()); + printf("# The command line was:\tbcftools +ad-bias %s", argv[0]); + for (c=1; c +##contig= +##FORMAT= +##FORMAT= +#CHROM POS ID REF ALT QUAL FILTER INFO FORMAT NA12890 NA12891 NA12892 +22 16050159 . C T 68 . . GT:AD 0/0:4,0 0/1:6,8 0/0:26,0 +22 16050252 . A T 85 . . GT:AD 0/0:3,0 0/1:13,13 0/0:40,0 +22 16051249 . T C 32.1761 . . GT:AD 0/1:4,3 0/0:41,0 0/0:55,0 +22 16051347 . G C 283 . . GT:AD 1/1:2,4 0/1:20,20 0/0:43,0 +22 16051453 . A C 3.42882 . . GT:AD 0/1:5,4 0/0:39,0 0/0:47,0 +22 16051497 . A G 362 . . GT:AD 1/1:0,8 0/1:14,20 0/0:44,0 +22 16051968 . C A 136 . . GT:AD 0/0:4,0 0/1:11,11 0/0:13,0 +22 16052167 . AAAACAAACAAACAAACAAACAAACAAACAAAC AAAACAAACAAACAAACAAACAAACAAACAAACAAACAAAC 217 . . GT:AD ./.:0,0 1/1:0,27 0/0:46,0 +22 16052169 . AACAAACA AACAAACAGACAAACA 241 . . GT:AD 0/1:1,1 0/1:7,29 0/0:54,0 +22 16052180 . AAAC AAACCAACTAAC 221 . . GT:AD 0/0:2,0 0/1:16,15 0/0:55,0 +22 16052239 . A G 172 . . GT:AD 0/0:5,0 0/1:12,17 0/0:44,0 +22 16052513 . G C 153 . . GT:AD 0/0:11,0 0/1:25,16 0/0:38,0 +22 16052618 . G A 124 . . GT:AD 0/0:7,0 0/1:29,12 0/0:41,0 +22 16053659 . A C 352 . . GT:AD 1/1:0,9 1/1:0,21 0/0:30,0 +22 16053791 . C A 287 . . GT:AD 0/1:4,4 0/1:13,16 0/0:32,0 +22 16054454 . C T 14.2772 . . GT:AD 0/1:2,2 0/0:34,0 0/0:31,0 +22 16054667 . C G 179 . . GT:AD 0/0:8,0 0/1:12,15 0/0:27,0 +22 16054740 . A G 126 . . GT:AD 0/0:6,0 0/1:11,16 0/0:26,0 +22 16055942 . C T 385 . . GT:AD 1/1:0,7 1/1:0,22 0/0:31,0 +22 16056126 . G A 263 . . GT:AD 0/1:2,6 0/1:12,16 0/0:27,0 +22 16056854 . G GA 17.3105 . . GT:AD 0/0:7,0 0/1:11,15 0/0:35,0 +22 16057248 . G A 167 . . GT:AD 0/0:5,0 0/1:15,14 0/0:32,0 +22 16057320 . G A 20.0168 . . GT:AD 0/1:2,2 0/0:25,0 0/0:36,0 +22 16057417 . C T 16.3704 . . GT:AD 0/1:2,2 0/0:36,0 0/0:25,0 +22 16058070 . A G 452 . . GT:AD 1/1:0,4 1/1:0,21 1/1:0,22 +22 16058415 . A G 212 . . GT:AD 0/0:9,0 1/1:0,37 0/0:35,2 +22 16058463 . C T 136 . . GT:AD 0/1:1,8 0/0:40,0 0/0:45,0 +22 16058758 . C A 107 . . GT:AD 1/1:2,8 0/0:19,0 0/0:34,0 +22 16058766 . G A 15.517 . . GT:AD 0/0:11,0 1/1:0,4 0/0:32,0 +22 16058852 . A T 198 . . GT:AD 1/1:0,3 1/1:0,19 0/0:36,0 +22 16058883 . A G 129 . . GT:AD 1/1:0,1 1/1:0,18 0/0:36,0 +22 16059081 . A G 212 . . GT:AD 0/0:6,0 1/1:0,35 0/0:35,0 +22 16059734 . C T 114 . . GT:AD 1/1:1,9 0/0:23,0 0/0:31,0 +22 16059753 . A T 212 . . GT:AD 0/0:9,0 1/1:0,19 0/0:28,0 +22 16059973 . C A 195 . . GT:AD 0/0:4,0 0/0:21,0 0/1:21,18 +22 16060178 . G A 187 . . GT:AD 0/0:5,0 1/1:1,20 0/0:36,0 diff --git a/test/test.pl b/test/test.pl index 992451ef4..a91bd3fa9 100755 --- a/test/test.pl +++ b/test/test.pl @@ -202,6 +202,7 @@ test_vcf_plugin($opts,in=>'view',out=>'view.GTisec.mv.out',cmd=>'+GTisec',args=>'-- -mv | grep -v bcftools'); test_vcf_plugin($opts,in=>'view',out=>'view.GTisec.v.out',cmd=>'+GTisec',args=>'-- -v | grep -v bcftools'); test_vcf_plugin($opts,in=>'trio',out=>'trio.out',cmd=>'+trio-switch-rate',args=>'-- -p {PATH}/trio.ped | grep -v bcftools'); +test_vcf_plugin($opts,in=>'ad-bias',out=>'ad-bias.out',cmd=>'+ad-bias',args=>'-- -s {PATH}/ad-bias.samples | grep -v bcftools'); test_vcf_concat($opts,in=>['concat.1.a','concat.1.b'],out=>'concat.1.vcf.out',do_bcf=>0,args=>''); test_vcf_concat($opts,in=>['concat.1.a','concat.1.b'],out=>'concat.1.bcf.out',do_bcf=>1,args=>''); test_vcf_concat($opts,in=>['concat.2.a','concat.2.b'],out=>'concat.2.vcf.out',do_bcf=>0,args=>'-a'); From e43ca8c70bbc78a4ef29be723c60a2ec7a029436 Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Fri, 1 Jul 2016 09:47:56 +0100 Subject: [PATCH 188/211] norm: avoid regression when ALT is a spanning deletion `*` * add tests for #452 and #439 Resolves #452 --- test/norm.out | 1 + test/norm.vcf | 2 ++ test/test.pl | 2 +- vcfnorm.c | 10 ++++++---- 4 files changed, 10 insertions(+), 5 deletions(-) diff --git a/test/norm.out b/test/norm.out index e6796d1e1..002acdb6c 100644 --- a/test/norm.out +++ b/test/norm.out @@ -53,5 +53,6 @@ 20 275 . A C,G 999 PASS INDEL;AN=2;AC=0,2 GT:PL:DP:FGF:FGI:FGS:FSTR 2:0,0,0:0:1e+06,2e+06,3e+06:1111,2222,3333:A,BB,CCC:WORD 2:0,0,0:0:1e+06,2e+06,3e+06:1111,2222,3333:A,BB,CCC:WORD 3 10 . GTGGAC GTGGACACAC,GTGGACAC,GTGGACACACAC,GTGG,GTGGACACACACAC,ATGGACACACAC 999 PASS INDEL;AN=0 GT:DP ./.:0 ./.:0 3 17 . CA C 999 PASS INDEL;AN=0 GT:DP ./.:0 ./.:0 +4 25 . T TT,* 999 PASS INDEL;AN=0 GT:DP ./.:0 ./.:0 4 36 . TC C,TT,TTC 999 PASS INDEL;AN=0 GT:DP ./.:0 ./.:0 5 21 . A AAG 999 PASS INDEL;AN=0 GT:DP ./.:0 ./.:0 diff --git a/test/norm.vcf b/test/norm.vcf index d000655cc..d7d784167 100644 --- a/test/norm.vcf +++ b/test/norm.vcf @@ -54,4 +54,6 @@ 3 10 . GTGGAC GTGGACACAC,GTGGACAC,GTGGACACACAC,GTGG,GTGGACACACACAC,ATGGACACACAC 999 PASS INDEL;AN=0 GT:DP ./.:0 ./.:0 3 15 . CACA CAC 999 PASS INDEL;AN=0 GT:DP ./.:0 ./.:0 4 21 . ATTTTTTTTTTTTTTTC ATTTTTTTTTTTTTTC,ATTTTTTTTTTTTTTTT,ATTTTTTTTTTTTTTTTC 999 PASS INDEL;AN=0 GT:DP ./.:0 ./.:0 +4 25 . T TT,* 999 PASS INDEL;AN=0 GT:DP ./.:0 ./.:0 +4 37 . C I 999 PASS INDEL;AN=0 GT:DP ./.:0 ./.:0 5 22 . A AGA 999 PASS INDEL;AN=0 GT:DP ./.:0 ./.:0 diff --git a/test/test.pl b/test/test.pl index a91bd3fa9..981cc0b56 100755 --- a/test/test.pl +++ b/test/test.pl @@ -95,7 +95,7 @@ test_vcf_query($opts,in=>'missing',out=>'query.23.out',args=>q[-e'ISTR="."' -f'%POS %ISTR\\n']); test_vcf_query($opts,in=>'missing',out=>'query.22.out',args=>q[-e'ISTR!="."' -f'%POS %ISTR\\n']); test_vcf_query($opts,in=>'missing',out=>'query.24.out',args=>q[-i'FILTER="q11"' -f'%POS %ISTR\\n']); -test_vcf_norm($opts,in=>'norm',out=>'norm.out',fai=>'norm'); +test_vcf_norm($opts,in=>'norm',out=>'norm.out',fai=>'norm',args=>'-cx'); test_vcf_norm($opts,in=>'norm.split',out=>'norm.split.out',args=>'-m-'); test_vcf_norm($opts,in=>'norm.split.2',out=>'norm.split.2.out',args=>'-m-'); test_vcf_norm($opts,in=>'norm.split',fai=>'norm',out=>'norm.split.and.norm.out',args=>'-m-'); diff --git a/vcfnorm.c b/vcfnorm.c index daac7532e..8fe10a8fa 100644 --- a/vcfnorm.c +++ b/vcfnorm.c @@ -259,10 +259,11 @@ static void fix_dup_alt(args_t *args, bcf1_t *line) if ( changed ) bcf_update_genotypes(args->hdr,line,gts,ngts); } -#define ERR_DUP_ALLELE -2 -#define ERR_REF_MISMATCH -1 -#define ERR_OK 0 -#define ERR_SYMBOLIC 1 +#define ERR_DUP_ALLELE -2 +#define ERR_REF_MISMATCH -1 +#define ERR_OK 0 +#define ERR_SYMBOLIC 1 +#define ERR_SPANNING_DELETION 2 static int realign(args_t *args, bcf1_t *line) { @@ -304,6 +305,7 @@ static int realign(args_t *args, bcf1_t *line) for (i=0; in_allele; i++) { if ( line->d.allele[i][0]=='<' ) return ERR_SYMBOLIC; // symbolic allele + if ( line->d.allele[i][0]=='*' ) return ERR_SPANNING_DELETION; // spanning deletion if ( has_non_acgtn(line->d.allele[i],0) ) { if ( args->check_ref==CHECK_REF_EXIT ) From fe43a831e432676da977827e5883d3f139372960 Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Mon, 25 Apr 2016 12:43:29 +0100 Subject: [PATCH 189/211] copy over mpileup files from samtools Not functional yet. Just copying over the files. * bam_plcmd.c for the mpileup command * bam2bcf.[ch] bam2bcf_indel.c for the VCF/BCF creation * sample.[ch] for RG:SM handling --- bam2bcf.c | 843 ++++++++++++++++++++++++++++++++++++++ bam2bcf.h | 139 +++++++ bam2bcf_indel.c | 533 ++++++++++++++++++++++++ bam_plcmd.c | 1027 +++++++++++++++++++++++++++++++++++++++++++++++ sample.c | 134 +++++++ sample.h | 41 ++ 6 files changed, 2717 insertions(+) create mode 100644 bam2bcf.c create mode 100644 bam2bcf.h create mode 100644 bam2bcf_indel.c create mode 100644 bam_plcmd.c create mode 100644 sample.c create mode 100644 sample.h diff --git a/bam2bcf.c b/bam2bcf.c new file mode 100644 index 000000000..a824d5ac0 --- /dev/null +++ b/bam2bcf.c @@ -0,0 +1,843 @@ +/* bam2bcf.c -- variant calling. + + Copyright (C) 2010-2012 Broad Institute. + Copyright (C) 2012-2014 Genome Research Ltd. + + Author: Heng Li + +Permission is hereby granted, free of charge, to any person obtaining a copy +of this software and associated documentation files (the "Software"), to deal +in the Software without restriction, including without limitation the rights +to use, copy, modify, merge, publish, distribute, sublicense, and/or sell +copies of the Software, and to permit persons to whom the Software is +furnished to do so, subject to the following conditions: + +The above copyright notice and this permission notice shall be included in +all copies or substantial portions of the Software. + +THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS OR +IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF MERCHANTABILITY, +FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. IN NO EVENT SHALL +THE AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY CLAIM, DAMAGES OR OTHER +LIABILITY, WHETHER IN AN ACTION OF CONTRACT, TORT OR OTHERWISE, ARISING +FROM, OUT OF OR IN CONNECTION WITH THE SOFTWARE OR THE USE OR OTHER +DEALINGS IN THE SOFTWARE. */ + +#include + +#include +#include +#include +#include +#include +#include +#include +#include +#include "bam2bcf.h" + +extern void ks_introsort_uint32_t(size_t n, uint32_t a[]); + +#define CALL_DEFTHETA 0.83 +#define DEF_MAPQ 20 + +#define CAP_DIST 25 + +bcf_callaux_t *bcf_call_init(double theta, int min_baseQ) +{ + bcf_callaux_t *bca; + if (theta <= 0.) theta = CALL_DEFTHETA; + bca = calloc(1, sizeof(bcf_callaux_t)); + bca->capQ = 60; + bca->openQ = 40; bca->extQ = 20; bca->tandemQ = 100; + bca->min_baseQ = min_baseQ; + bca->e = errmod_init(1. - theta); + bca->min_frac = 0.002; + bca->min_support = 1; + bca->per_sample_flt = 0; + bca->npos = 100; + bca->ref_pos = malloc(bca->npos*sizeof(int)); + bca->alt_pos = malloc(bca->npos*sizeof(int)); + bca->nqual = 60; + bca->ref_mq = malloc(bca->nqual*sizeof(int)); + bca->alt_mq = malloc(bca->nqual*sizeof(int)); + bca->ref_bq = malloc(bca->nqual*sizeof(int)); + bca->alt_bq = malloc(bca->nqual*sizeof(int)); + bca->fwd_mqs = malloc(bca->nqual*sizeof(int)); + bca->rev_mqs = malloc(bca->nqual*sizeof(int)); + return bca; +} + +void bcf_call_destroy(bcf_callaux_t *bca) +{ + if (bca == 0) return; + errmod_destroy(bca->e); + if (bca->npos) { free(bca->ref_pos); free(bca->alt_pos); bca->npos = 0; } + free(bca->ref_mq); free(bca->alt_mq); free(bca->ref_bq); free(bca->alt_bq); + free(bca->fwd_mqs); free(bca->rev_mqs); + bca->nqual = 0; + free(bca->bases); free(bca->inscns); free(bca); +} + +// position in the sequence with respect to the aligned part of the read +static int get_position(const bam_pileup1_t *p, int *len) +{ + int icig, n_tot_bases = 0, iread = 0, edist = p->qpos + 1; + for (icig=0; icigb->core.n_cigar; icig++) + { + int cig = bam_get_cigar(p->b)[icig] & BAM_CIGAR_MASK; + int ncig = bam_get_cigar(p->b)[icig] >> BAM_CIGAR_SHIFT; + if ( cig==BAM_CMATCH || cig==BAM_CEQUAL || cig==BAM_CDIFF ) + { + n_tot_bases += ncig; + iread += ncig; + continue; + } + if ( cig==BAM_CINS ) + { + n_tot_bases += ncig; + iread += ncig; + continue; + } + if ( cig==BAM_CSOFT_CLIP ) + { + iread += ncig; + if ( iread<=p->qpos ) edist -= ncig; + continue; + } + if ( cig==BAM_CDEL ) continue; + if ( cig==BAM_CHARD_CLIP ) continue; + if ( cig==BAM_CPAD ) continue; + if ( cig==BAM_CREF_SKIP ) continue; + fprintf(stderr,"todo: cigar %d\n", cig); + assert(0); + } + *len = n_tot_bases; + return edist; +} + +void bcf_callaux_clean(bcf_callaux_t *bca, bcf_call_t *call) +{ + memset(bca->ref_pos,0,sizeof(int)*bca->npos); + memset(bca->alt_pos,0,sizeof(int)*bca->npos); + memset(bca->ref_mq,0,sizeof(int)*bca->nqual); + memset(bca->alt_mq,0,sizeof(int)*bca->nqual); + memset(bca->ref_bq,0,sizeof(int)*bca->nqual); + memset(bca->alt_bq,0,sizeof(int)*bca->nqual); + memset(bca->fwd_mqs,0,sizeof(int)*bca->nqual); + memset(bca->rev_mqs,0,sizeof(int)*bca->nqual); + if ( call->ADF ) memset(call->ADF,0,sizeof(int32_t)*(call->n+1)*B2B_MAX_ALLELES); + if ( call->ADR ) memset(call->ADR,0,sizeof(int32_t)*(call->n+1)*B2B_MAX_ALLELES); +} + +/* + Notes: + - Called from bam_plcmd.c by mpileup. Amongst other things, sets the bcf_callret1_t.qsum frequencies + which are carried over via bcf_call_combine and bcf_call2bcf to the output BCF as the QS annotation. + Later it's used for multiallelic calling by bcftools -m + - ref_base is the 4-bit representation of the reference base. It is negative if we are looking at an indel. + */ +/* + * This function is called once for each sample. + * _n is number of pilesups pl contributing reads to this sample + * pl is pointer to array of _n pileups (one pileup per read) + * ref_base is the 4-bit representation of the reference base. It is negative if we are looking at an indel. + * bca is the settings to perform calls across all samples + * r is the returned value of the call + */ +int bcf_call_glfgen(int _n, const bam_pileup1_t *pl, int ref_base, bcf_callaux_t *bca, bcf_callret1_t *r) +{ + int i, n, ref4, is_indel, ori_depth = 0; + + // clean from previous run + r->ori_depth = 0; + r->mq0 = 0; + memset(r->qsum,0,sizeof(float)*4); + memset(r->anno,0,sizeof(double)*16); + memset(r->p,0,sizeof(float)*25); + + if (ref_base >= 0) { + ref4 = seq_nt16_int[ref_base]; + is_indel = 0; + } else ref4 = 4, is_indel = 1; + if (_n == 0) return -1; + // enlarge the bases array if necessary + if (bca->max_bases < _n) { + bca->max_bases = _n; + kroundup32(bca->max_bases); + bca->bases = (uint16_t*)realloc(bca->bases, 2 * bca->max_bases); + } + // fill the bases array + for (i = n = 0; i < _n; ++i) { + const bam_pileup1_t *p = pl + i; + int q, b, mapQ, baseQ, is_diff, min_dist, seqQ; + // set base + if (p->is_del || p->is_refskip || (p->b->core.flag&BAM_FUNMAP)) continue; + ++ori_depth; + mapQ = p->b->core.qual < 255? p->b->core.qual : DEF_MAPQ; // special case for mapQ==255 + if ( !mapQ ) r->mq0++; + baseQ = q = is_indel? p->aux&0xff : (int)bam_get_qual(p->b)[p->qpos]; // base/indel quality + seqQ = is_indel? (p->aux>>8&0xff) : 99; + if (q < bca->min_baseQ) continue; + if (q > seqQ) q = seqQ; + mapQ = mapQ < bca->capQ? mapQ : bca->capQ; + if (q > mapQ) q = mapQ; + if (q > 63) q = 63; + if (q < 4) q = 4; // MQ=0 reads count as BQ=4 + if (!is_indel) { + b = bam_seqi(bam_get_seq(p->b), p->qpos); // base + b = seq_nt16_int[b? b : ref_base]; // b is the 2-bit base + is_diff = (ref4 < 4 && b == ref4)? 0 : 1; + } else { + b = p->aux>>16&0x3f; + is_diff = (b != 0); + } + bca->bases[n++] = q<<5 | (int)bam_is_rev(p->b)<<4 | b; + // collect annotations + if (b < 4) + { + r->qsum[b] += q; + if ( r->ADF ) + { + if ( bam_is_rev(p->b) ) + r->ADR[b]++; + else + r->ADF[b]++; + } + } + ++r->anno[0<<2|is_diff<<1|bam_is_rev(p->b)]; + min_dist = p->b->core.l_qseq - 1 - p->qpos; + if (min_dist > p->qpos) min_dist = p->qpos; + if (min_dist > CAP_DIST) min_dist = CAP_DIST; + r->anno[1<<2|is_diff<<1|0] += baseQ; + r->anno[1<<2|is_diff<<1|1] += baseQ * baseQ; + r->anno[2<<2|is_diff<<1|0] += mapQ; + r->anno[2<<2|is_diff<<1|1] += mapQ * mapQ; + r->anno[3<<2|is_diff<<1|0] += min_dist; + r->anno[3<<2|is_diff<<1|1] += min_dist * min_dist; + + // collect for bias tests + if ( baseQ > 59 ) baseQ = 59; + if ( mapQ > 59 ) mapQ = 59; + int len, pos = get_position(p, &len); + int epos = (double)pos/(len+1) * bca->npos; + int ibq = baseQ/60. * bca->nqual; + int imq = mapQ/60. * bca->nqual; + if ( bam_is_rev(p->b) ) bca->rev_mqs[imq]++; + else bca->fwd_mqs[imq]++; + if ( bam_seqi(bam_get_seq(p->b),p->qpos) == ref_base ) + { + bca->ref_pos[epos]++; + bca->ref_bq[ibq]++; + bca->ref_mq[imq]++; + } + else + { + bca->alt_pos[epos]++; + bca->alt_bq[ibq]++; + bca->alt_mq[imq]++; + } + } + r->ori_depth = ori_depth; + // glfgen + errmod_cal(bca->e, n, 5, bca->bases, r->p); // calculate PL of each genotype + return n; +} + + +/* + * calc_vdb() - returns value between zero (most biased) and one (no bias) + * on success, or HUGE_VAL when VDB cannot be calculated because + * of insufficient depth (<2x) + * + * Variant Distance Bias tests if the variant bases are positioned within the + * reads with sufficient randomness. Unlike other tests, it looks only at + * variant reads and therefore gives different kind of information than Read + * Position Bias for instance. VDB was developed for detecting artefacts in + * RNA-seq calls where reads from spliced transcripts span splice site + * boundaries. The current implementation differs somewhat from the original + * version described in supplementary material of PMID:22524474, but the idea + * remains the same. (Here the random variable tested is the average distance + * from the averaged position, not the average pairwise distance.) + * + * For coverage of 2x, the calculation is exact but is approximated for the + * rest. The result is most accurate between 4-200x. For 3x or >200x, the + * reported values are slightly more favourable than those of a true random + * distribution. + */ +double calc_vdb(int *pos, int npos) +{ + // Note well: the parameters were obtained by fitting to simulated data of + // 100bp reads. This assumes rescaling to 100bp in bcf_call_glfgen(). + const int readlen = 100; + assert( npos==readlen ); + + #define nparam 15 + const float param[nparam][3] = { {3,0.079,18}, {4,0.09,19.8}, {5,0.1,20.5}, {6,0.11,21.5}, + {7,0.125,21.6}, {8,0.135,22}, {9,0.14,22.2}, {10,0.153,22.3}, {15,0.19,22.8}, + {20,0.22,23.2}, {30,0.26,23.4}, {40,0.29,23.5}, {50,0.35,23.65}, {100,0.5,23.7}, + {200,0.7,23.7} }; + + int i, dp = 0; + float mean_pos = 0, mean_diff = 0; + for (i=0; i=200 ) + i = nparam; // shortcut for big depths + else + { + for (i=0; i=dp ) break; + } + float pshift, pscale; + if ( i==nparam ) + { + // the depth is too high, go with 200x + pscale = param[nparam-1][1]; + pshift = param[nparam-1][2]; + } + else if ( i>0 && param[i][0]!=dp ) + { + // linear interpolation of parameters + pscale = (param[i-1][1] + param[i][1])*0.5; + pshift = (param[i-1][2] + param[i][2])*0.5; + } + else + { + pscale = param[i][1]; + pshift = param[i][2]; + } + return 0.5*kf_erfc(-(mean_diff-pshift)*pscale); +} + +double calc_chisq_bias(int *a, int *b, int n) +{ + int na = 0, nb = 0, i, ndf = n; + for (i=0; i=8 && nb>=8 and reasonable if na<8 or nb<8 + if ( na>=8 || nb>=8 ) + { + double mean = ((double)na*nb)*0.5; + // Correction for ties: + // double N = na+nb; + // double var2 = (N*N-1)*N-ties; + // if ( var2==0 ) return 1.0; + // var2 *= ((double)na*nb)/N/(N-1)/12.0; + // No correction for ties: + double var2 = ((double)na*nb)*(na+nb+1)/12.0; + double z = (U_min - mean)/sqrt(2*var2); // z is N(0,1) + return 2.0 - kf_erfc(z); // which is 1 + erf(z) + } + + // Exact calculation + double pval = 2*mann_whitney_1947_cdf(na,nb,U_min); + return pval>1 ? 1 : pval; +} + +double calc_mwu_bias(int *a, int *b, int n) +{ + int na = 0, nb = 0, i; + double U = 0, ties = 0; + for (i=0; imean ? (2.0*mean-U)/mean : U/mean; + } + // Correction for ties: + // double N = na+nb; + // double var2 = (N*N-1)*N-ties; + // if ( var2==0 ) return 1.0; + // var2 *= ((double)na*nb)/N/(N-1)/12.0; + // No correction for ties: + double var2 = ((double)na*nb)*(na+nb+1)/12.0; + if ( na>=8 || nb>=8 ) + { + // Normal approximation, very good for na>=8 && nb>=8 and reasonable if na<8 or nb<8 + return exp(-0.5*(U-mean)*(U-mean)/var2); + } + + // Exact calculation + return mann_whitney_1947(na,nb,U) * sqrt(2*M_PI*var2); +} + +static inline double logsumexp2(double a, double b) +{ + if ( a>b ) + return log(1 + exp(b-a)) + a; + else + return log(1 + exp(a-b)) + b; +} + +void calc_SegBias(const bcf_callret1_t *bcr, bcf_call_t *call) +{ + call->seg_bias = HUGE_VAL; + if ( !bcr ) return; + + int nr = call->anno[2] + call->anno[3]; // number of observed non-reference reads + if ( !nr ) return; + + int avg_dp = (call->anno[0] + call->anno[1] + nr) / call->n; // average depth + double M = floor((double)nr / avg_dp + 0.5); // an approximate number of variants samples in the population + if ( M>call->n ) M = call->n; // clamp M at the number of samples + else if ( M==0 ) M = 1; + double f = M / 2. / call->n; // allele frequency + double p = (double) nr / call->n; // number of variant reads per sample expected if variant not real (poisson) + double q = (double) nr / M; // number of variant reads per sample expected if variant is real (poisson) + double sum = 0; + const double log2 = log(2.0); + + // fprintf(stderr,"M=%.1f p=%e q=%e f=%f dp=%d\n",M,p,q,f,avg_dp); + int i; + for (i=0; in; i++) + { + int oi = bcr[i].anno[2] + bcr[i].anno[3]; // observed number of non-ref reads + double tmp; + if ( oi ) + { + // tmp = log(f) + oi*log(q/p) - q + log(2*(1-f) + f*pow(2,oi)*exp(-q)) + p; // this can under/overflow + tmp = logsumexp2(log(2*(1-f)), log(f) + oi*log2 - q); + tmp += log(f) + oi*log(q/p) - q + p; + } + else + tmp = log(2*f*(1-f)*exp(-q) + f*f*exp(-2*q) + (1-f)*(1-f)) + p; + sum += tmp; + // fprintf(stderr,"oi=%d %e\n", oi,tmp); + } + call->seg_bias = sum; +} + +/** + * bcf_call_combine() - sets the PL array and VDB, RPB annotations, finds the top two alleles + * @n: number of samples + * @calls: each sample's calls + * @bca: auxiliary data structure for holding temporary values + * @ref_base: the reference base + * @call: filled with the annotations + * + * Combines calls across the various samples being studied + * 1. For each allele at each base across all samples the quality is summed so + * you end up with a set of quality sums for each allele present 2. The quality + * sums are sorted. + * 3. Using the sorted quality sums we now create the allele ordering array + * A\subN. This is done by doing the following: + * a) If the reference allele is known it always comes first, otherwise N + * comes first. + * b) Then the rest of the alleles are output in descending order of quality + * sum (which we already know the qsum array was sorted). Any allelles with + * qsum 0 will be excluded. + * 4. Using the allele ordering array we create the genotype ordering array. + * In the worst case with an unknown reference this will be: A0/A0 A1/A0 A1/A1 + * A2/A0 A2/A1 A2/A2 A3/A0 A3/A1 A3/A2 A3/A3 A4/A0 A4/A1 A4/A2 A4/A3 A4/A4 + * 5. The genotype ordering array is then used to extract data from the error + * model 5*5 matrix and is used to produce a Phread likelihood array for each + * sample. + */ +int bcf_call_combine(int n, const bcf_callret1_t *calls, bcf_callaux_t *bca, int ref_base /*4-bit*/, bcf_call_t *call) +{ + int ref4, i, j; + float qsum[5] = {0,0,0,0,0}; + if (ref_base >= 0) { + call->ori_ref = ref4 = seq_nt16_int[ref_base]; + if (ref4 > 4) ref4 = 4; + } else call->ori_ref = -1, ref4 = 0; + + // calculate qsum, this is done by summing normalized qsum across all samples, + // to account for differences in coverage + for (i = 0; i < n; ++i) + { + float sum = 0; + for (j = 0; j < 4; ++j) sum += calls[i].qsum[j]; + if ( sum ) + for (j = 0; j < 4; j++) qsum[j] += calls[i].qsum[j] / sum; + } + + // sort qsum in ascending order (insertion sort) + float *ptr[5], *tmp; + for (i=0; i<5; i++) ptr[i] = &qsum[i]; + for (i=1; i<4; i++) + for (j=i; j>0 && *ptr[j] < *ptr[j-1]; j--) + tmp = ptr[j], ptr[j] = ptr[j-1], ptr[j-1] = tmp; + + // Set the reference allele and alternative allele(s) + for (i=0; i<5; i++) call->a[i] = -1; + for (i=0; i<5; i++) call->qsum[i] = 0; + call->unseen = -1; + call->a[0] = ref4; + for (i=3, j=1; i>=0; i--) // i: alleles sorted by QS; j, a[j]: output allele ordering + { + int ipos = ptr[i] - qsum; // position in sorted qsum array + if ( ipos==ref4 ) + call->qsum[0] = qsum[ipos]; // REF's qsum + else + { + if ( !qsum[ipos] ) break; // qsum is 0, this and consequent alleles are not seen in the pileup + call->qsum[j] = qsum[ipos]; + call->a[j++] = ipos; + } + } + if (ref_base >= 0) + { + // for SNPs, find the "unseen" base + if (((ref4 < 4 && j < 4) || (ref4 == 4 && j < 5)) && i >= 0) + call->unseen = j, call->a[j++] = ptr[i] - qsum; + call->n_alleles = j; + } + else + { + call->n_alleles = j; + if (call->n_alleles == 1) return -1; // no reliable supporting read. stop doing anything + } + /* + * Set the phread likelihood array (call->PL) This array is 15 entries long + * for each sample because that is size of an upper or lower triangle of a + * worst case 5x5 matrix of possible genotypes. This worst case matrix will + * occur when all 4 possible alleles are present and the reference allele + * is unknown. The sides of the matrix will correspond to the reference + * allele (if known) followed by the alleles present in descending order of + * quality sum + */ + { + int x, g[15], z; + double sum_min = 0.; + x = call->n_alleles * (call->n_alleles + 1) / 2; + // get the possible genotypes + // this is done by creating an ordered list of locations g for call (allele a, allele b) in the genotype likelihood matrix + for (i = z = 0; i < call->n_alleles; ++i) { + for (j = 0; j <= i; ++j) { + g[z++] = call->a[j] * 5 + call->a[i]; + } + } + // for each sample calculate the PL + for (i = 0; i < n; ++i) + { + int32_t *PL = call->PL + x * i; + const bcf_callret1_t *r = calls + i; + float min = FLT_MAX; + for (j = 0; j < x; ++j) { + if (min > r->p[g[j]]) min = r->p[g[j]]; + } + sum_min += min; + for (j = 0; j < x; ++j) { + int y; + y = (int)(r->p[g[j]] - min + .499); + if (y > 255) y = 255; + PL[j] = y; + } + } + if ( call->DP4 ) + { + for (i=0; iDP4[4*i] = calls[i].anno[0]; + call->DP4[4*i+1] = calls[i].anno[1]; + call->DP4[4*i+2] = calls[i].anno[2]; + call->DP4[4*i+3] = calls[i].anno[3]; + } + } + if ( call->ADF ) + { + assert( call->n_alleles<=B2B_MAX_ALLELES ); // this is always true for SNPs and so far for indels as well + + // reorder ADR,ADF to match the allele ordering at this site + int32_t tmp[B2B_MAX_ALLELES]; + int32_t *adr = call->ADR + B2B_MAX_ALLELES, *adr_out = call->ADR + B2B_MAX_ALLELES; + int32_t *adf = call->ADF + B2B_MAX_ALLELES, *adf_out = call->ADF + B2B_MAX_ALLELES; + int32_t *adr_tot = call->ADR; // the first bin stores total counts per site + int32_t *adf_tot = call->ADF; + for (i=0; in_alleles; j++) + { + tmp[j] = adr[ call->a[j] ]; + adr_tot[j] += tmp[j]; + } + for (j=0; jn_alleles; j++) adr_out[j] = tmp[j]; + for (j=0; jn_alleles; j++) + { + tmp[j] = adf[ call->a[j] ]; + adf_tot[j] += tmp[j]; + } + for (j=0; jn_alleles; j++) adf_out[j] = tmp[j]; + adf_out += call->n_alleles; + adr_out += call->n_alleles; + adr += B2B_MAX_ALLELES; + adf += B2B_MAX_ALLELES; + } + } + +// if (ref_base < 0) fprintf(stderr, "%d,%d,%f,%d\n", call->n_alleles, x, sum_min, call->unseen); + call->shift = (int)(sum_min + .499); + } + // combine annotations + memset(call->anno, 0, 16 * sizeof(double)); + call->ori_depth = 0; + call->depth = 0; + call->mq0 = 0; + for (i = 0; i < n; ++i) { + call->depth += calls[i].anno[0] + calls[i].anno[1] + calls[i].anno[2] + calls[i].anno[3]; + call->ori_depth += calls[i].ori_depth; + call->mq0 += calls[i].mq0; + for (j = 0; j < 16; ++j) call->anno[j] += calls[i].anno[j]; + } + + calc_SegBias(calls, call); + + // calc_chisq_bias("XPOS", call->bcf_hdr->id[BCF_DT_CTG][call->tid].key, call->pos, bca->ref_pos, bca->alt_pos, bca->npos); + // calc_chisq_bias("XMQ", call->bcf_hdr->id[BCF_DT_CTG][call->tid].key, call->pos, bca->ref_mq, bca->alt_mq, bca->nqual); + // calc_chisq_bias("XBQ", call->bcf_hdr->id[BCF_DT_CTG][call->tid].key, call->pos, bca->ref_bq, bca->alt_bq, bca->nqual); + + call->mwu_pos = calc_mwu_bias(bca->ref_pos, bca->alt_pos, bca->npos); + call->mwu_mq = calc_mwu_bias(bca->ref_mq, bca->alt_mq, bca->nqual); + call->mwu_bq = calc_mwu_bias(bca->ref_bq, bca->alt_bq, bca->nqual); + call->mwu_mqs = calc_mwu_bias(bca->fwd_mqs, bca->rev_mqs, bca->nqual); + +#if CDF_MWU_TESTS + call->mwu_pos_cdf = calc_mwu_bias_cdf(bca->ref_pos, bca->alt_pos, bca->npos); + call->mwu_mq_cdf = calc_mwu_bias_cdf(bca->ref_mq, bca->alt_mq, bca->nqual); + call->mwu_bq_cdf = calc_mwu_bias_cdf(bca->ref_bq, bca->alt_bq, bca->nqual); + call->mwu_mqs_cdf = calc_mwu_bias_cdf(bca->fwd_mqs, bca->rev_mqs, bca->nqual); +#endif + + call->vdb = calc_vdb(bca->alt_pos, bca->npos); + + return 0; +} + +int bcf_call2bcf(bcf_call_t *bc, bcf1_t *rec, bcf_callret1_t *bcr, int fmt_flag, const bcf_callaux_t *bca, const char *ref) +{ + extern double kt_fisher_exact(int n11, int n12, int n21, int n22, double *_left, double *_right, double *two); + int i, j, nals = 1; + + bcf_hdr_t *hdr = bc->bcf_hdr; + rec->rid = bc->tid; + rec->pos = bc->pos; + rec->qual = 0; + + bc->tmp.l = 0; + if (bc->ori_ref < 0) // indel + { + // REF + kputc(ref[bc->pos], &bc->tmp); + for (j = 0; j < bca->indelreg; ++j) kputc(ref[bc->pos+1+j], &bc->tmp); + + // ALT + for (i=1; i<4; i++) + { + if (bc->a[i] < 0) break; + kputc(',', &bc->tmp); kputc(ref[bc->pos], &bc->tmp); + + if (bca->indel_types[bc->a[i]] < 0) { // deletion + for (j = -bca->indel_types[bc->a[i]]; j < bca->indelreg; ++j) + kputc(ref[bc->pos+1+j], &bc->tmp); + } else { // insertion; cannot be a reference unless a bug + char *inscns = &bca->inscns[bc->a[i] * bca->maxins]; + for (j = 0; j < bca->indel_types[bc->a[i]]; ++j) + kputc("ACGTN"[(int)inscns[j]], &bc->tmp); + for (j = 0; j < bca->indelreg; ++j) kputc(ref[bc->pos+1+j], &bc->tmp); + } + nals++; + } + } + else // SNP + { + kputc("ACGTN"[bc->ori_ref], &bc->tmp); + for (i=1; i<5; i++) + { + if (bc->a[i] < 0) break; + kputc(',', &bc->tmp); + if ( bc->unseen==i ) kputs("<*>", &bc->tmp); + else kputc("ACGT"[bc->a[i]], &bc->tmp); + nals++; + } + } + bcf_update_alleles_str(hdr, rec, bc->tmp.s); + + bc->tmp.l = 0; + + // INFO + if (bc->ori_ref < 0) + { + bcf_update_info_flag(hdr, rec, "INDEL", NULL, 1); + bcf_update_info_int32(hdr, rec, "IDV", &bca->max_support, 1); + bcf_update_info_float(hdr, rec, "IMF", &bca->max_frac, 1); + } + bcf_update_info_int32(hdr, rec, "DP", &bc->ori_depth, 1); + if ( fmt_flag&B2B_INFO_ADF ) + bcf_update_info_int32(hdr, rec, "ADF", bc->ADF, rec->n_allele); + if ( fmt_flag&B2B_INFO_ADR ) + bcf_update_info_int32(hdr, rec, "ADR", bc->ADR, rec->n_allele); + if ( fmt_flag&(B2B_INFO_AD|B2B_INFO_DPR) ) + { + for (i=0; in_allele; i++) bc->ADF[i] += bc->ADR[i]; + if ( fmt_flag&B2B_INFO_AD ) + bcf_update_info_int32(hdr, rec, "AD", bc->ADF, rec->n_allele); + if ( fmt_flag&B2B_INFO_DPR ) + bcf_update_info_int32(hdr, rec, "DPR", bc->ADF, rec->n_allele); + } + + float tmpf[16]; + for (i=0; i<16; i++) tmpf[i] = bc->anno[i]; + bcf_update_info_float(hdr, rec, "I16", tmpf, 16); + bcf_update_info_float(hdr, rec, "QS", bc->qsum, nals); + + if ( bc->vdb != HUGE_VAL ) bcf_update_info_float(hdr, rec, "VDB", &bc->vdb, 1); + if ( bc->seg_bias != HUGE_VAL ) bcf_update_info_float(hdr, rec, "SGB", &bc->seg_bias, 1); + if ( bc->mwu_pos != HUGE_VAL ) bcf_update_info_float(hdr, rec, "RPB", &bc->mwu_pos, 1); + if ( bc->mwu_mq != HUGE_VAL ) bcf_update_info_float(hdr, rec, "MQB", &bc->mwu_mq, 1); + if ( bc->mwu_mqs != HUGE_VAL ) bcf_update_info_float(hdr, rec, "MQSB", &bc->mwu_mqs, 1); + if ( bc->mwu_bq != HUGE_VAL ) bcf_update_info_float(hdr, rec, "BQB", &bc->mwu_bq, 1); +#if CDF_MWU_TESTS + if ( bc->mwu_pos_cdf != HUGE_VAL ) bcf_update_info_float(hdr, rec, "RPB2", &bc->mwu_pos_cdf, 1); + if ( bc->mwu_mq_cdf != HUGE_VAL ) bcf_update_info_float(hdr, rec, "MQB2", &bc->mwu_mq_cdf, 1); + if ( bc->mwu_mqs_cdf != HUGE_VAL ) bcf_update_info_float(hdr, rec, "MQSB2", &bc->mwu_mqs_cdf, 1); + if ( bc->mwu_bq_cdf != HUGE_VAL ) bcf_update_info_float(hdr, rec, "BQB2", &bc->mwu_bq_cdf, 1); +#endif + tmpf[0] = bc->ori_depth ? (float)bc->mq0/bc->ori_depth : 0; + bcf_update_info_float(hdr, rec, "MQ0F", tmpf, 1); + + // FORMAT + rec->n_sample = bc->n; + bcf_update_format_int32(hdr, rec, "PL", bc->PL, nals*(nals+1)/2 * rec->n_sample); + if ( fmt_flag&B2B_FMT_DP ) + { + int32_t *ptr = (int32_t*) bc->fmt_arr; + for (i=0; in; i++) + ptr[i] = bc->DP4[4*i] + bc->DP4[4*i+1] + bc->DP4[4*i+2] + bc->DP4[4*i+3]; + bcf_update_format_int32(hdr, rec, "DP", bc->fmt_arr, rec->n_sample); + } + if ( fmt_flag&B2B_FMT_DV ) + { + int32_t *ptr = (int32_t*) bc->fmt_arr; + for (i=0; in; i++) + ptr[i] = bc->DP4[4*i+2] + bc->DP4[4*i+3]; + bcf_update_format_int32(hdr, rec, "DV", bc->fmt_arr, rec->n_sample); + } + if ( fmt_flag&B2B_FMT_SP ) + { + int32_t *ptr = (int32_t*) bc->fmt_arr; + for (i=0; in; i++) + { + int fwd_ref = bc->DP4[4*i], rev_ref = bc->DP4[4*i+1], fwd_alt = bc->DP4[4*i+2], rev_alt = bc->DP4[4*i+3]; + if ( fwd_ref+rev_ref<2 || fwd_alt+rev_alt<2 || fwd_ref+fwd_alt<2 || rev_ref+rev_alt<2 ) + ptr[i] = 0; + else + { + double left, right, two; + kt_fisher_exact(fwd_ref, rev_ref, fwd_alt, rev_alt, &left, &right, &two); + int32_t x = (int)(-4.343 * log(two) + .499); + if (x > 255) x = 255; + ptr[i] = x; + } + } + bcf_update_format_int32(hdr, rec, "SP", bc->fmt_arr, rec->n_sample); + } + if ( fmt_flag&B2B_FMT_DP4 ) + bcf_update_format_int32(hdr, rec, "DP4", bc->DP4, rec->n_sample*4); + if ( fmt_flag&B2B_FMT_ADF ) + bcf_update_format_int32(hdr, rec, "ADF", bc->ADF+B2B_MAX_ALLELES, rec->n_sample*rec->n_allele); + if ( fmt_flag&B2B_FMT_ADR ) + bcf_update_format_int32(hdr, rec, "ADR", bc->ADR+B2B_MAX_ALLELES, rec->n_sample*rec->n_allele); + if ( fmt_flag&(B2B_FMT_AD|B2B_FMT_DPR) ) + { + for (i=0; in_sample*rec->n_allele; i++) bc->ADF[B2B_MAX_ALLELES+i] += bc->ADR[B2B_MAX_ALLELES+i]; + if ( fmt_flag&B2B_FMT_AD ) + bcf_update_format_int32(hdr, rec, "AD", bc->ADF+B2B_MAX_ALLELES, rec->n_sample*rec->n_allele); + if ( fmt_flag&B2B_FMT_DPR ) + bcf_update_format_int32(hdr, rec, "DPR", bc->ADF+B2B_MAX_ALLELES, rec->n_sample*rec->n_allele); + } + + return 0; +} diff --git a/bam2bcf.h b/bam2bcf.h new file mode 100644 index 000000000..54e5faaaa --- /dev/null +++ b/bam2bcf.h @@ -0,0 +1,139 @@ +/* bam2bcf.h -- variant calling. + + Copyright (C) 2010-2012 Broad Institute. + Copyright (C) 2012-2014 Genome Research Ltd. + + Author: Heng Li + +Permission is hereby granted, free of charge, to any person obtaining a copy +of this software and associated documentation files (the "Software"), to deal +in the Software without restriction, including without limitation the rights +to use, copy, modify, merge, publish, distribute, sublicense, and/or sell +copies of the Software, and to permit persons to whom the Software is +furnished to do so, subject to the following conditions: + +The above copyright notice and this permission notice shall be included in +all copies or substantial portions of the Software. + +THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS OR +IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF MERCHANTABILITY, +FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. IN NO EVENT SHALL +THE AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY CLAIM, DAMAGES OR OTHER +LIABILITY, WHETHER IN AN ACTION OF CONTRACT, TORT OR OTHERWISE, ARISING +FROM, OUT OF OR IN CONNECTION WITH THE SOFTWARE OR THE USE OR OTHER +DEALINGS IN THE SOFTWARE. */ + +#ifndef BAM2BCF_H +#define BAM2BCF_H + +#include +#include +#include + +/** + * A simplified version of Mann-Whitney U-test is calculated + * by default (no CDF) because it is faster and seems to work + * better in machine learning filtering. When enabled by setting + * CDF_MWU_TESTS, additional annotations will appear on mpileup's + * output (RPB2 in addition to RPB, etc.). + */ +#ifndef CDF_MWU_TESTS +#define CDF_MWU_TESTS 0 +#endif + +#define B2B_INDEL_NULL 10000 + +#define B2B_FMT_DP (1<<0) +#define B2B_FMT_SP (1<<1) +#define B2B_FMT_DV (1<<2) +#define B2B_FMT_DP4 (1<<3) +#define B2B_FMT_DPR (1<<4) +#define B2B_INFO_DPR (1<<5) +#define B2B_FMT_AD (1<<6) +#define B2B_FMT_ADF (1<<7) +#define B2B_FMT_ADR (1<<8) +#define B2B_INFO_AD (1<<9) +#define B2B_INFO_ADF (1<<10) +#define B2B_INFO_ADR (1<<11) + +#define B2B_MAX_ALLELES 5 + +typedef struct __bcf_callaux_t { + int capQ, min_baseQ; + int openQ, extQ, tandemQ; // for indels + uint32_t min_support, max_support; // for collecting indel candidates + double min_frac; // for collecting indel candidates + float max_frac; // for collecting indel candidates + int per_sample_flt; // indel filtering strategy + int *ref_pos, *alt_pos, npos, *ref_mq, *alt_mq, *ref_bq, *alt_bq, *fwd_mqs, *rev_mqs, nqual; // for bias tests + // for internal uses + int max_bases; + int indel_types[4]; // indel lengths + int maxins, indelreg; + int read_len; + char *inscns; + uint16_t *bases; // 5bit: unused, 6:quality, 1:is_rev, 4:2-bit base or indel allele (index to bcf_callaux_t.indel_types) + errmod_t *e; + void *rghash; +} bcf_callaux_t; + +typedef struct { + uint32_t ori_depth; + unsigned int mq0; + int32_t *ADF, *ADR; + float qsum[4]; + // The fields are: + // depth fwd .. ref (0) and non-ref (2) + // depth rev .. ref (1) and non-ref (3) + // baseQ .. ref (4) and non-ref (6) + // baseQ^2 .. ref (5) and non-ref (7) + // mapQ .. ref (8) and non-ref (10) + // mapQ^2 .. ref (9) and non-ref (11) + // minDist .. ref (12) and non-ref (14) + // minDist^2 .. ref (13) and non-ref (15) + // Note that this probably needs a more thorough fix: int types in + // bcf_call_t do overflow with high-coverage data, such as exomes, and + // BCFv2 supports only floats which may not suffice. + double anno[16]; + float p[25]; // phred-scaled likelihood of each genotype +} bcf_callret1_t; + +typedef struct { + int tid, pos; + bcf_hdr_t *bcf_hdr; + int a[5]; // alleles: ref, alt, alt2, alt3 + float qsum[5]; // for the QS tag + int n, n_alleles, shift, ori_ref, unseen; + int n_supp; // number of supporting non-reference reads + double anno[16]; + unsigned int depth, ori_depth, mq0; + int32_t *PL, *DP4, *ADR, *ADF; + uint8_t *fmt_arr; + float vdb; // variant distance bias + float mwu_pos, mwu_mq, mwu_bq, mwu_mqs; +#if CDF_MWU_TESTS + float mwu_pos_cdf, mwu_mq_cdf, mwu_bq_cdf, mwu_mqs_cdf; +#endif + float seg_bias; + kstring_t tmp; +} bcf_call_t; + +#ifdef __cplusplus +extern "C" { +#endif + + bcf_callaux_t *bcf_call_init(double theta, int min_baseQ); + void bcf_call_destroy(bcf_callaux_t *bca); + int bcf_call_glfgen(int _n, const bam_pileup1_t *pl, int ref_base, bcf_callaux_t *bca, bcf_callret1_t *r); + int bcf_call_combine(int n, const bcf_callret1_t *calls, bcf_callaux_t *bca, int ref_base /*4-bit*/, bcf_call_t *call); + int bcf_call2bcf(bcf_call_t *bc, bcf1_t *b, bcf_callret1_t *bcr, int fmt_flag, + const bcf_callaux_t *bca, const char *ref); + int bcf_call_gap_prep(int n, int *n_plp, bam_pileup1_t **plp, int pos, bcf_callaux_t *bca, const char *ref, + const void *rghash); + void bcf_callaux_clean(bcf_callaux_t *bca, bcf_call_t *call); + +#ifdef __cplusplus +} +#endif + +#endif diff --git a/bam2bcf_indel.c b/bam2bcf_indel.c new file mode 100644 index 000000000..2b42b09d7 --- /dev/null +++ b/bam2bcf_indel.c @@ -0,0 +1,533 @@ +/* bam2bcf_indel.c -- indel caller. + + Copyright (C) 2010, 2011 Broad Institute. + Copyright (C) 2012-2014 Genome Research Ltd. + + Author: Heng Li + +Permission is hereby granted, free of charge, to any person obtaining a copy +of this software and associated documentation files (the "Software"), to deal +in the Software without restriction, including without limitation the rights +to use, copy, modify, merge, publish, distribute, sublicense, and/or sell +copies of the Software, and to permit persons to whom the Software is +furnished to do so, subject to the following conditions: + +The above copyright notice and this permission notice shall be included in +all copies or substantial portions of the Software. + +THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS OR +IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF MERCHANTABILITY, +FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. IN NO EVENT SHALL +THE AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY CLAIM, DAMAGES OR OTHER +LIABILITY, WHETHER IN AN ACTION OF CONTRACT, TORT OR OTHERWISE, ARISING +FROM, OUT OF OR IN CONNECTION WITH THE SOFTWARE OR THE USE OR OTHER +DEALINGS IN THE SOFTWARE. */ + +#include + +#include +#include +#include +#include "htslib/hts.h" +#include "htslib/sam.h" +#include "bam2bcf.h" +#include "htslib/khash.h" +KHASH_SET_INIT_STR(rg) + +#include "htslib/ksort.h" +KSORT_INIT_GENERIC(uint32_t) + +#define MINUS_CONST 0x10000000 +#define INDEL_WINDOW_SIZE 50 + +void *bcf_call_add_rg(void *_hash, const char *hdtext, const char *list) +{ + const char *s, *p, *q, *r, *t; + khash_t(rg) *hash; + if (list == 0 || hdtext == 0) return _hash; + if (_hash == 0) _hash = kh_init(rg); + hash = (khash_t(rg)*)_hash; + if ((s = strstr(hdtext, "@RG\t")) == 0) return hash; + do { + t = strstr(s + 4, "@RG\t"); // the next @RG + if ((p = strstr(s, "\tID:")) != 0) p += 4; + if ((q = strstr(s, "\tPL:")) != 0) q += 4; + if (p && q && (t == 0 || (p < t && q < t))) { // ID and PL are both present + int lp, lq; + char *x; + for (r = p; *r && *r != '\t' && *r != '\n'; ++r) { } + lp = r - p; + for (r = q; *r && *r != '\t' && *r != '\n'; ++r) { } + lq = r - q; + x = calloc((lp > lq? lp : lq) + 1, 1); + for (r = q; *r && *r != '\t' && *r != '\n'; ++r) x[r-q] = *r; + if (strstr(list, x)) { // insert ID to the hash table + khint_t k; + int ret; + for (r = p; *r && *r != '\t' && *r != '\n'; ++r) x[r-p] = *r; + x[r-p] = 0; + k = kh_get(rg, hash, x); + if (k == kh_end(hash)) k = kh_put(rg, hash, x, &ret); + else free(x); + } else free(x); + } + s = t; + } while (s); + return hash; +} + +void bcf_call_del_rghash(void *_hash) +{ + khint_t k; + khash_t(rg) *hash = (khash_t(rg)*)_hash; + if (hash == 0) return; + for (k = kh_begin(hash); k < kh_end(hash); ++k) + if (kh_exist(hash, k)) + free((char*)kh_key(hash, k)); + kh_destroy(rg, hash); +} + +static int tpos2qpos(const bam1_core_t *c, const uint32_t *cigar, int32_t tpos, int is_left, int32_t *_tpos) +{ + int k, x = c->pos, y = 0, last_y = 0; + *_tpos = c->pos; + for (k = 0; k < c->n_cigar; ++k) { + int op = cigar[k] & BAM_CIGAR_MASK; + int l = cigar[k] >> BAM_CIGAR_SHIFT; + if (op == BAM_CMATCH || op == BAM_CEQUAL || op == BAM_CDIFF) { + if (c->pos > tpos) return y; + if (x + l > tpos) { + *_tpos = tpos; + return y + (tpos - x); + } + x += l; y += l; + last_y = y; + } else if (op == BAM_CINS || op == BAM_CSOFT_CLIP) y += l; + else if (op == BAM_CDEL || op == BAM_CREF_SKIP) { + if (x + l > tpos) { + *_tpos = is_left? x : x + l; + return y; + } + x += l; + } + } + *_tpos = x; + return last_y; +} +// FIXME: check if the inserted sequence is consistent with the homopolymer run +// l is the relative gap length and l_run is the length of the homopolymer on the reference +static inline int est_seqQ(const bcf_callaux_t *bca, int l, int l_run) +{ + int q, qh; + q = bca->openQ + bca->extQ * (abs(l) - 1); + qh = l_run >= 3? (int)(bca->tandemQ * (double)abs(l) / l_run + .499) : 1000; + return q < qh? q : qh; +} + +static inline int est_indelreg(int pos, const char *ref, int l, char *ins4) +{ + int i, j, max = 0, max_i = pos, score = 0; + l = abs(l); + for (i = pos + 1, j = 0; ref[i]; ++i, ++j) { + if (ins4) score += (toupper(ref[i]) != "ACGTN"[(int)ins4[j%l]])? -10 : 1; + else score += (toupper(ref[i]) != toupper(ref[pos+1+j%l]))? -10 : 1; + if (score < 0) break; + if (max < score) max = score, max_i = i; + } + return max_i - pos; +} + +/* + notes: + - n .. number of samples + - the routine sets bam_pileup1_t.aux of each read as follows: + - 6: unused + - 6: the call; index to bcf_callaux_t.indel_types .. (aux>>16)&0x3f + - 8: estimated sequence quality .. (aux>>8)&0xff + - 8: indel quality .. aux&0xff + */ +int bcf_call_gap_prep(int n, int *n_plp, bam_pileup1_t **plp, int pos, bcf_callaux_t *bca, const char *ref, + const void *rghash) +{ + int i, s, j, k, t, n_types, *types, max_rd_len, left, right, max_ins, *score1, *score2, max_ref2; + int N, K, l_run, ref_type, n_alt; + char *inscns = 0, *ref2, *query, **ref_sample; + khash_t(rg) *hash = (khash_t(rg)*)rghash; + if (ref == 0 || bca == 0) return -1; + // mark filtered reads + if (rghash) { + N = 0; + for (s = N = 0; s < n; ++s) { + for (i = 0; i < n_plp[s]; ++i) { + bam_pileup1_t *p = plp[s] + i; + const uint8_t *rg = bam_aux_get(p->b, "RG"); + p->aux = 1; // filtered by default + if (rg) { + khint_t k = kh_get(rg, hash, (const char*)(rg + 1)); + if (k != kh_end(hash)) p->aux = 0, ++N; // not filtered + } + } + } + if (N == 0) return -1; // no reads left + } + // determine if there is a gap + for (s = N = 0; s < n; ++s) { + for (i = 0; i < n_plp[s]; ++i) + if (plp[s][i].indel != 0) break; + if (i < n_plp[s]) break; + } + if (s == n) return -1; // there is no indel at this position. + for (s = N = 0; s < n; ++s) N += n_plp[s]; // N is the total number of reads + { // find out how many types of indels are present + bca->max_support = bca->max_frac = 0; + int m, n_alt = 0, n_tot = 0, indel_support_ok = 0; + uint32_t *aux; + aux = calloc(N + 1, 4); + m = max_rd_len = 0; + aux[m++] = MINUS_CONST; // zero indel is always a type + for (s = 0; s < n; ++s) { + int na = 0, nt = 0; + for (i = 0; i < n_plp[s]; ++i) { + const bam_pileup1_t *p = plp[s] + i; + if (rghash == 0 || p->aux == 0) { + ++nt; + if (p->indel != 0) { + ++na; + aux[m++] = MINUS_CONST + p->indel; + } + } + j = bam_cigar2qlen(p->b->core.n_cigar, bam_get_cigar(p->b)); + if (j > max_rd_len) max_rd_len = j; + } + double frac = (double)na/nt; + if ( !indel_support_ok && na >= bca->min_support && frac >= bca->min_frac ) + indel_support_ok = 1; + if ( na > bca->max_support && frac > 0 ) bca->max_support = na, bca->max_frac = frac; + n_alt += na; + n_tot += nt; + } + // To prevent long stretches of N's to be mistaken for indels (sometimes thousands of bases), + // check the number of N's in the sequence and skip places where half or more reference bases are Ns. + int nN=0; for (i=pos; i-pos(i-pos) ) { free(aux); return -1; } + + ks_introsort(uint32_t, m, aux); + // squeeze out identical types + for (i = 1, n_types = 1; i < m; ++i) + if (aux[i] != aux[i-1]) ++n_types; + // Taking totals makes it hard to call rare indels + if ( !bca->per_sample_flt ) + indel_support_ok = ( (double)n_alt / n_tot < bca->min_frac || n_alt < bca->min_support ) ? 0 : 1; + if ( n_types == 1 || !indel_support_ok ) { // then skip + free(aux); return -1; + } + if (n_types >= 64) { + free(aux); + // TODO revisit how/whether to control printing this warning + if (hts_verbose >= 2) + fprintf(stderr, "[%s] excessive INDEL alleles at position %d. Skip the position.\n", __func__, pos + 1); + return -1; + } + types = (int*)calloc(n_types, sizeof(int)); + t = 0; + types[t++] = aux[0] - MINUS_CONST; + for (i = 1; i < m; ++i) + if (aux[i] != aux[i-1]) + types[t++] = aux[i] - MINUS_CONST; + free(aux); + for (t = 0; t < n_types; ++t) + if (types[t] == 0) break; + ref_type = t; // the index of the reference type (0) + } + { // calculate left and right boundary + left = pos > INDEL_WINDOW_SIZE? pos - INDEL_WINDOW_SIZE : 0; + right = pos + INDEL_WINDOW_SIZE; + if (types[0] < 0) right -= types[0]; + // in case the alignments stand out the reference + for (i = pos; i < right; ++i) + if (ref[i] == 0) break; + right = i; + } + /* The following block fixes a long-existing flaw in the INDEL + * calling model: the interference of nearby SNPs. However, it also + * reduces the power because sometimes, substitutions caused by + * indels are not distinguishable from true mutations. Multiple + * sequence realignment helps to increase the power. + * + * Masks mismatches present in at least 70% of the reads with 'N'. + */ + { // construct per-sample consensus + int L = right - left + 1, max_i, max2_i; + uint32_t *cns, max, max2; + char *ref0, *r; + ref_sample = calloc(n, sizeof(char*)); + cns = calloc(L, 4); + ref0 = calloc(L, 1); + for (i = 0; i < right - left; ++i) + ref0[i] = seq_nt16_table[(int)ref[i+left]]; + for (s = 0; s < n; ++s) { + r = ref_sample[s] = calloc(L, 1); + memset(cns, 0, sizeof(int) * L); + // collect ref and non-ref counts + for (i = 0; i < n_plp[s]; ++i) { + bam_pileup1_t *p = plp[s] + i; + bam1_t *b = p->b; + uint32_t *cigar = bam_get_cigar(b); + uint8_t *seq = bam_get_seq(b); + int x = b->core.pos, y = 0; + for (k = 0; k < b->core.n_cigar; ++k) { + int op = cigar[k]&0xf; + int j, l = cigar[k]>>4; + if (op == BAM_CMATCH || op == BAM_CEQUAL || op == BAM_CDIFF) { + for (j = 0; j < l; ++j) + if (x + j >= left && x + j < right) + cns[x+j-left] += (bam_seqi(seq, y+j) == ref0[x+j-left])? 1 : 0x10000; + x += l; y += l; + } else if (op == BAM_CDEL || op == BAM_CREF_SKIP) x += l; + else if (op == BAM_CINS || op == BAM_CSOFT_CLIP) y += l; + } + } + // determine the consensus + for (i = 0; i < right - left; ++i) r[i] = ref0[i]; + max = max2 = 0; max_i = max2_i = -1; + for (i = 0; i < right - left; ++i) { + if (cns[i]>>16 >= max>>16) max2 = max, max2_i = max_i, max = cns[i], max_i = i; + else if (cns[i]>>16 >= max2>>16) max2 = cns[i], max2_i = i; + } + if ((double)(max&0xffff) / ((max&0xffff) + (max>>16)) >= 0.7) max_i = -1; + if ((double)(max2&0xffff) / ((max2&0xffff) + (max2>>16)) >= 0.7) max2_i = -1; + if (max_i >= 0) r[max_i] = 15; + if (max2_i >= 0) r[max2_i] = 15; + //for (i = 0; i < right - left; ++i) fputc("=ACMGRSVTWYHKDBN"[(int)r[i]], stderr); fputc('\n', stderr); + } + free(ref0); free(cns); + } + { // the length of the homopolymer run around the current position + int c = seq_nt16_table[(int)ref[pos + 1]]; + if (c == 15) l_run = 1; + else { + for (i = pos + 2; ref[i]; ++i) + if (seq_nt16_table[(int)ref[i]] != c) break; + l_run = i; + for (i = pos; i >= 0; --i) + if (seq_nt16_table[(int)ref[i]] != c) break; + l_run -= i + 1; + } + } + // construct the consensus sequence + max_ins = types[n_types - 1]; // max_ins is at least 0 + if (max_ins > 0) { + int *inscns_aux = calloc(5 * n_types * max_ins, sizeof(int)); + // count the number of occurrences of each base at each position for each type of insertion + for (t = 0; t < n_types; ++t) { + if (types[t] > 0) { + for (s = 0; s < n; ++s) { + for (i = 0; i < n_plp[s]; ++i) { + bam_pileup1_t *p = plp[s] + i; + if (p->indel == types[t]) { + uint8_t *seq = bam_get_seq(p->b); + for (k = 1; k <= p->indel; ++k) { + int c = seq_nt16_int[bam_seqi(seq, p->qpos + k)]; + assert(c<5); + ++inscns_aux[(t*max_ins+(k-1))*5 + c]; + } + } + } + } + } + } + // use the majority rule to construct the consensus + inscns = calloc(n_types * max_ins, 1); + for (t = 0; t < n_types; ++t) { + for (j = 0; j < types[t]; ++j) { + int max = 0, max_k = -1, *ia = &inscns_aux[(t*max_ins+j)*5]; + for (k = 0; k < 5; ++k) + if (ia[k] > max) + max = ia[k], max_k = k; + inscns[t*max_ins + j] = max? max_k : 4; + if ( max_k==4 ) { types[t] = 0; break; } // discard insertions which contain N's + } + } + free(inscns_aux); + } + // compute the likelihood given each type of indel for each read + max_ref2 = right - left + 2 + 2 * (max_ins > -types[0]? max_ins : -types[0]); + ref2 = calloc(max_ref2, 1); + query = calloc(right - left + max_rd_len + max_ins + 2, 1); + score1 = calloc(N * n_types, sizeof(int)); + score2 = calloc(N * n_types, sizeof(int)); + bca->indelreg = 0; + for (t = 0; t < n_types; ++t) { + int l, ir; + probaln_par_t apf1 = { 1e-4, 1e-2, 10 }, apf2 = { 1e-6, 1e-3, 10 }; + apf1.bw = apf2.bw = abs(types[t]) + 3; + // compute indelreg + if (types[t] == 0) ir = 0; + else if (types[t] > 0) ir = est_indelreg(pos, ref, types[t], &inscns[t*max_ins]); + else ir = est_indelreg(pos, ref, -types[t], 0); + if (ir > bca->indelreg) bca->indelreg = ir; +// fprintf(stderr, "%d, %d, %d\n", pos, types[t], ir); + // realignment + for (s = K = 0; s < n; ++s) { + // write ref2 + for (k = 0, j = left; j <= pos; ++j) + ref2[k++] = seq_nt16_int[(int)ref_sample[s][j-left]]; + if (types[t] <= 0) j += -types[t]; + else for (l = 0; l < types[t]; ++l) + ref2[k++] = inscns[t*max_ins + l]; + for (; j < right && ref[j]; ++j) + ref2[k++] = seq_nt16_int[(int)ref_sample[s][j-left]]; + for (; k < max_ref2; ++k) ref2[k] = 4; + if (j < right) right = j; + // align each read to ref2 + for (i = 0; i < n_plp[s]; ++i, ++K) { + bam_pileup1_t *p = plp[s] + i; + int qbeg, qend, tbeg, tend, sc, kk; + uint8_t *seq = bam_get_seq(p->b); + uint32_t *cigar = bam_get_cigar(p->b); + if (p->b->core.flag&4) continue; // unmapped reads + // FIXME: the following loop should be better moved outside; nonetheless, realignment should be much slower anyway. + for (kk = 0; kk < p->b->core.n_cigar; ++kk) + if ((cigar[kk]&BAM_CIGAR_MASK) == BAM_CREF_SKIP) break; + if (kk < p->b->core.n_cigar) continue; + // FIXME: the following skips soft clips, but using them may be more sensitive. + // determine the start and end of sequences for alignment + qbeg = tpos2qpos(&p->b->core, bam_get_cigar(p->b), left, 0, &tbeg); + qend = tpos2qpos(&p->b->core, bam_get_cigar(p->b), right, 1, &tend); + if (types[t] < 0) { + int l = -types[t]; + tbeg = tbeg - l > left? tbeg - l : left; + } + // write the query sequence + for (l = qbeg; l < qend; ++l) + query[l - qbeg] = seq_nt16_int[bam_seqi(seq, l)]; + { // do realignment; this is the bottleneck + const uint8_t *qual = bam_get_qual(p->b), *bq; + uint8_t *qq; + qq = calloc(qend - qbeg, 1); + bq = (uint8_t*)bam_aux_get(p->b, "ZQ"); + if (bq) ++bq; // skip type + for (l = qbeg; l < qend; ++l) { + qq[l - qbeg] = bq? qual[l] + (bq[l] - 64) : qual[l]; + if (qq[l - qbeg] > 30) qq[l - qbeg] = 30; + if (qq[l - qbeg] < 7) qq[l - qbeg] = 7; + } + sc = probaln_glocal((uint8_t*)ref2 + tbeg - left, tend - tbeg + abs(types[t]), + (uint8_t*)query, qend - qbeg, qq, &apf1, 0, 0); + l = (int)(100. * sc / (qend - qbeg) + .499); // used for adjusting indelQ below + if (l > 255) l = 255; + score1[K*n_types + t] = score2[K*n_types + t] = sc<<8 | l; + if (sc > 5) { + sc = probaln_glocal((uint8_t*)ref2 + tbeg - left, tend - tbeg + abs(types[t]), + (uint8_t*)query, qend - qbeg, qq, &apf2, 0, 0); + l = (int)(100. * sc / (qend - qbeg) + .499); + if (l > 255) l = 255; + score2[K*n_types + t] = sc<<8 | l; + } + free(qq); + } +/* + for (l = 0; l < tend - tbeg + abs(types[t]); ++l) + fputc("ACGTN"[(int)ref2[tbeg-left+l]], stderr); + fputc('\n', stderr); + for (l = 0; l < qend - qbeg; ++l) fputc("ACGTN"[(int)query[l]], stderr); + fputc('\n', stderr); + fprintf(stderr, "pos=%d type=%d read=%d:%d name=%s qbeg=%d tbeg=%d score=%d\n", pos, types[t], s, i, bam1_qname(p->b), qbeg, tbeg, sc); +*/ + } + } + } + free(ref2); free(query); + { // compute indelQ + int *sc, tmp, *sumq; + sc = alloca(n_types * sizeof(int)); + sumq = alloca(n_types * sizeof(int)); + memset(sumq, 0, sizeof(int) * n_types); + for (s = K = 0; s < n; ++s) { + for (i = 0; i < n_plp[s]; ++i, ++K) { + bam_pileup1_t *p = plp[s] + i; + int *sct = &score1[K*n_types], indelQ1, indelQ2, seqQ, indelQ; + for (t = 0; t < n_types; ++t) sc[t] = sct[t]<<6 | t; + for (t = 1; t < n_types; ++t) // insertion sort + for (j = t; j > 0 && sc[j] < sc[j-1]; --j) + tmp = sc[j], sc[j] = sc[j-1], sc[j-1] = tmp; + /* errmod_cal() assumes that if the call is wrong, the + * likelihoods of other events are equal. This is about + * right for substitutions, but is not desired for + * indels. To reuse errmod_cal(), I have to make + * compromise for multi-allelic indels. + */ + if ((sc[0]&0x3f) == ref_type) { + indelQ1 = (sc[1]>>14) - (sc[0]>>14); + seqQ = est_seqQ(bca, types[sc[1]&0x3f], l_run); + } else { + for (t = 0; t < n_types; ++t) // look for the reference type + if ((sc[t]&0x3f) == ref_type) break; + indelQ1 = (sc[t]>>14) - (sc[0]>>14); + seqQ = est_seqQ(bca, types[sc[0]&0x3f], l_run); + } + tmp = sc[0]>>6 & 0xff; + indelQ1 = tmp > 111? 0 : (int)((1. - tmp/111.) * indelQ1 + .499); // reduce indelQ + sct = &score2[K*n_types]; + for (t = 0; t < n_types; ++t) sc[t] = sct[t]<<6 | t; + for (t = 1; t < n_types; ++t) // insertion sort + for (j = t; j > 0 && sc[j] < sc[j-1]; --j) + tmp = sc[j], sc[j] = sc[j-1], sc[j-1] = tmp; + if ((sc[0]&0x3f) == ref_type) { + indelQ2 = (sc[1]>>14) - (sc[0]>>14); + } else { + for (t = 0; t < n_types; ++t) // look for the reference type + if ((sc[t]&0x3f) == ref_type) break; + indelQ2 = (sc[t]>>14) - (sc[0]>>14); + } + tmp = sc[0]>>6 & 0xff; + indelQ2 = tmp > 111? 0 : (int)((1. - tmp/111.) * indelQ2 + .499); + // pick the smaller between indelQ1 and indelQ2 + indelQ = indelQ1 < indelQ2? indelQ1 : indelQ2; + if (indelQ > 255) indelQ = 255; + if (seqQ > 255) seqQ = 255; + p->aux = (sc[0]&0x3f)<<16 | seqQ<<8 | indelQ; // use 22 bits in total + sumq[sc[0]&0x3f] += indelQ < seqQ? indelQ : seqQ; +// fprintf(stderr, "pos=%d read=%d:%d name=%s call=%d indelQ=%d seqQ=%d\n", pos, s, i, bam1_qname(p->b), types[sc[0]&0x3f], indelQ, seqQ); + } + } + // determine bca->indel_types[] and bca->inscns + bca->maxins = max_ins; + bca->inscns = realloc(bca->inscns, bca->maxins * 4); + for (t = 0; t < n_types; ++t) + sumq[t] = sumq[t]<<6 | t; + for (t = 1; t < n_types; ++t) // insertion sort + for (j = t; j > 0 && sumq[j] > sumq[j-1]; --j) + tmp = sumq[j], sumq[j] = sumq[j-1], sumq[j-1] = tmp; + for (t = 0; t < n_types; ++t) // look for the reference type + if ((sumq[t]&0x3f) == ref_type) break; + if (t) { // then move the reference type to the first + tmp = sumq[t]; + for (; t > 0; --t) sumq[t] = sumq[t-1]; + sumq[0] = tmp; + } + for (t = 0; t < 4; ++t) bca->indel_types[t] = B2B_INDEL_NULL; + for (t = 0; t < 4 && t < n_types; ++t) { + bca->indel_types[t] = types[sumq[t]&0x3f]; + memcpy(&bca->inscns[t * bca->maxins], &inscns[(sumq[t]&0x3f) * max_ins], bca->maxins); + } + // update p->aux + for (s = n_alt = 0; s < n; ++s) { + for (i = 0; i < n_plp[s]; ++i) { + bam_pileup1_t *p = plp[s] + i; + int x = types[p->aux>>16&0x3f]; + for (j = 0; j < 4; ++j) + if (x == bca->indel_types[j]) break; + p->aux = j<<16 | (j == 4? 0 : (p->aux&0xffff)); + if ((p->aux>>16&0x3f) > 0) ++n_alt; + //fprintf(stderr, "X pos=%d read=%d:%d name=%s call=%d type=%d seqQ=%d indelQ=%d\n", pos, s, i, bam1_qname(p->b), (p->aux>>16)&0x3f, bca->indel_types[(p->aux>>16)&0x3f], (p->aux>>8)&0xff, p->aux&0xff); + } + } + } + free(score1); free(score2); + // free + for (i = 0; i < n; ++i) free(ref_sample[i]); + free(ref_sample); + free(types); free(inscns); + return n_alt > 0? 0 : -1; +} diff --git a/bam_plcmd.c b/bam_plcmd.c new file mode 100644 index 000000000..ddd2f0043 --- /dev/null +++ b/bam_plcmd.c @@ -0,0 +1,1027 @@ +/* bam_plcmd.c -- mpileup subcommand. + + Copyright (C) 2008-2015 Genome Research Ltd. + Portions copyright (C) 2009-2012 Broad Institute. + + Author: Heng Li + +Permission is hereby granted, free of charge, to any person obtaining a copy +of this software and associated documentation files (the "Software"), to deal +in the Software without restriction, including without limitation the rights +to use, copy, modify, merge, publish, distribute, sublicense, and/or sell +copies of the Software, and to permit persons to whom the Software is +furnished to do so, subject to the following conditions: + +The above copyright notice and this permission notice shall be included in +all copies or substantial portions of the Software. + +THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS OR +IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF MERCHANTABILITY, +FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. IN NO EVENT SHALL +THE AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY CLAIM, DAMAGES OR OTHER +LIABILITY, WHETHER IN AN ACTION OF CONTRACT, TORT OR OTHERWISE, ARISING +FROM, OUT OF OR IN CONNECTION WITH THE SOFTWARE OR THE USE OR OTHER +DEALINGS IN THE SOFTWARE. */ + +#include + +#include +#include +#include +#include +#include +#include +#include +#include +#include +#include +#include +#include +#include +#include +#include "sam_header.h" +#include "samtools.h" +#include "sam_opts.h" + +static inline int printw(int c, FILE *fp) +{ + char buf[16]; + int l, x; + if (c == 0) return fputc('0', fp); + for (l = 0, x = c < 0? -c : c; x > 0; x /= 10) buf[l++] = x%10 + '0'; + if (c < 0) buf[l++] = '-'; + buf[l] = 0; + for (x = 0; x < l/2; ++x) { + int y = buf[x]; buf[x] = buf[l-1-x]; buf[l-1-x] = y; + } + fputs(buf, fp); + return 0; +} + +static inline void pileup_seq(FILE *fp, const bam_pileup1_t *p, int pos, int ref_len, const char *ref) +{ + int j; + if (p->is_head) { + putc('^', fp); + putc(p->b->core.qual > 93? 126 : p->b->core.qual + 33, fp); + } + if (!p->is_del) { + int c = p->qpos < p->b->core.l_qseq + ? seq_nt16_str[bam_seqi(bam_get_seq(p->b), p->qpos)] + : 'N'; + if (ref) { + int rb = pos < ref_len? ref[pos] : 'N'; + if (c == '=' || seq_nt16_table[c] == seq_nt16_table[rb]) c = bam_is_rev(p->b)? ',' : '.'; + else c = bam_is_rev(p->b)? tolower(c) : toupper(c); + } else { + if (c == '=') c = bam_is_rev(p->b)? ',' : '.'; + else c = bam_is_rev(p->b)? tolower(c) : toupper(c); + } + putc(c, fp); + } else putc(p->is_refskip? (bam_is_rev(p->b)? '<' : '>') : '*', fp); + if (p->indel > 0) { + putc('+', fp); printw(p->indel, fp); + for (j = 1; j <= p->indel; ++j) { + int c = seq_nt16_str[bam_seqi(bam_get_seq(p->b), p->qpos + j)]; + putc(bam_is_rev(p->b)? tolower(c) : toupper(c), fp); + } + } else if (p->indel < 0) { + printw(p->indel, fp); + for (j = 1; j <= -p->indel; ++j) { + int c = (ref && (int)pos+j < ref_len)? ref[pos+j] : 'N'; + putc(bam_is_rev(p->b)? tolower(c) : toupper(c), fp); + } + } + if (p->is_tail) putc('$', fp); +} + +#include +#include "bam2bcf.h" +#include "sample.h" + +#define MPLP_BCF 1 +#define MPLP_VCF (1<<1) +#define MPLP_NO_COMP (1<<2) +#define MPLP_NO_ORPHAN (1<<3) +#define MPLP_REALN (1<<4) +#define MPLP_NO_INDEL (1<<5) +#define MPLP_REDO_BAQ (1<<6) +#define MPLP_ILLUMINA13 (1<<7) +#define MPLP_IGNORE_RG (1<<8) +#define MPLP_PRINT_POS (1<<9) +#define MPLP_PRINT_MAPQ (1<<10) +#define MPLP_PER_SAMPLE (1<<11) +#define MPLP_SMART_OVERLAPS (1<<12) + +void *bed_read(const char *fn); +void bed_destroy(void *_h); +int bed_overlap(const void *_h, const char *chr, int beg, int end); + +typedef struct { + int min_mq, flag, min_baseQ, capQ_thres, max_depth, max_indel_depth, fmt_flag; + int rflag_require, rflag_filter; + int openQ, extQ, tandemQ, min_support; // for indels + double min_frac; // for indels + char *reg, *pl_list, *fai_fname, *output_fname; + faidx_t *fai; + void *bed, *rghash; + int argc; + char **argv; + sam_global_args ga; +} mplp_conf_t; + +typedef struct { + char *ref[2]; + int ref_id[2]; + int ref_len[2]; +} mplp_ref_t; + +#define MPLP_REF_INIT {{NULL,NULL},{-1,-1},{0,0}} + +typedef struct { + samFile *fp; + hts_itr_t *iter; + bam_hdr_t *h; + mplp_ref_t *ref; + const mplp_conf_t *conf; +} mplp_aux_t; + +typedef struct { + int n; + int *n_plp, *m_plp; + bam_pileup1_t **plp; +} mplp_pileup_t; + +static int mplp_get_ref(mplp_aux_t *ma, int tid, char **ref, int *ref_len) { + mplp_ref_t *r = ma->ref; + + //printf("get ref %d {%d/%p, %d/%p}\n", tid, r->ref_id[0], r->ref[0], r->ref_id[1], r->ref[1]); + + if (!r || !ma->conf->fai) { + *ref = NULL; + return 0; + } + + // Do we need to reference count this so multiple mplp_aux_t can + // track which references are in use? + // For now we just cache the last two. Sufficient? + if (tid == r->ref_id[0]) { + *ref = r->ref[0]; + *ref_len = r->ref_len[0]; + return 1; + } + if (tid == r->ref_id[1]) { + // Last, swap over + int tmp; + tmp = r->ref_id[0]; r->ref_id[0] = r->ref_id[1]; r->ref_id[1] = tmp; + tmp = r->ref_len[0]; r->ref_len[0] = r->ref_len[1]; r->ref_len[1] = tmp; + + char *tc; + tc = r->ref[0]; r->ref[0] = r->ref[1]; r->ref[1] = tc; + *ref = r->ref[0]; + *ref_len = r->ref_len[0]; + return 1; + } + + // New, so migrate to old and load new + free(r->ref[1]); + r->ref[1] = r->ref[0]; + r->ref_id[1] = r->ref_id[0]; + r->ref_len[1] = r->ref_len[0]; + + r->ref_id[0] = tid; + r->ref[0] = faidx_fetch_seq(ma->conf->fai, + ma->h->target_name[r->ref_id[0]], + 0, + INT_MAX, + &r->ref_len[0]); + + if (!r->ref[0]) { + r->ref[0] = NULL; + r->ref_id[0] = -1; + r->ref_len[0] = 0; + *ref = NULL; + return 0; + } + + *ref = r->ref[0]; + *ref_len = r->ref_len[0]; + return 1; +} + +static int mplp_func(void *data, bam1_t *b) +{ + char *ref; + mplp_aux_t *ma = (mplp_aux_t*)data; + int ret, skip = 0, ref_len; + do { + int has_ref; + ret = ma->iter? sam_itr_next(ma->fp, ma->iter, b) : sam_read1(ma->fp, ma->h, b); + if (ret < 0) break; + // The 'B' cigar operation is not part of the specification, considering as obsolete. + // bam_remove_B(b); + if (b->core.tid < 0 || (b->core.flag&BAM_FUNMAP)) { // exclude unmapped reads + skip = 1; + continue; + } + if (ma->conf->rflag_require && !(ma->conf->rflag_require&b->core.flag)) { skip = 1; continue; } + if (ma->conf->rflag_filter && ma->conf->rflag_filter&b->core.flag) { skip = 1; continue; } + if (ma->conf->bed) { // test overlap + skip = !bed_overlap(ma->conf->bed, ma->h->target_name[b->core.tid], b->core.pos, bam_endpos(b)); + if (skip) continue; + } + if (ma->conf->rghash) { // exclude read groups + uint8_t *rg = bam_aux_get(b, "RG"); + skip = (rg && khash_str2int_get(ma->conf->rghash, (const char*)(rg+1), NULL)==0); + if (skip) continue; + } + if (ma->conf->flag & MPLP_ILLUMINA13) { + int i; + uint8_t *qual = bam_get_qual(b); + for (i = 0; i < b->core.l_qseq; ++i) + qual[i] = qual[i] > 31? qual[i] - 31 : 0; + } + + if (ma->conf->fai && b->core.tid >= 0) { + has_ref = mplp_get_ref(ma, b->core.tid, &ref, &ref_len); + if (has_ref && ref_len <= b->core.pos) { // exclude reads outside of the reference sequence + fprintf(stderr,"[%s] Skipping because %d is outside of %d [ref:%d]\n", + __func__, b->core.pos, ref_len, b->core.tid); + skip = 1; + continue; + } + } else { + has_ref = 0; + } + + skip = 0; + if (has_ref && (ma->conf->flag&MPLP_REALN)) sam_prob_realn(b, ref, ref_len, (ma->conf->flag & MPLP_REDO_BAQ)? 7 : 3); + if (has_ref && ma->conf->capQ_thres > 10) { + int q = sam_cap_mapq(b, ref, ref_len, ma->conf->capQ_thres); + if (q < 0) skip = 1; + else if (b->core.qual > q) b->core.qual = q; + } + if (b->core.qual < ma->conf->min_mq) skip = 1; + else if ((ma->conf->flag&MPLP_NO_ORPHAN) && (b->core.flag&BAM_FPAIRED) && !(b->core.flag&BAM_FPROPER_PAIR)) skip = 1; + } while (skip); + return ret; +} + +static void group_smpl(mplp_pileup_t *m, bam_sample_t *sm, kstring_t *buf, + int n, char *const*fn, int *n_plp, const bam_pileup1_t **plp, int ignore_rg) +{ + int i, j; + memset(m->n_plp, 0, m->n * sizeof(int)); + for (i = 0; i < n; ++i) { + for (j = 0; j < n_plp[i]; ++j) { + const bam_pileup1_t *p = plp[i] + j; + uint8_t *q; + int id = -1; + q = ignore_rg? NULL : bam_aux_get(p->b, "RG"); + if (q) id = bam_smpl_rg2smid(sm, fn[i], (char*)q+1, buf); + if (id < 0) id = bam_smpl_rg2smid(sm, fn[i], 0, buf); + if (id < 0 || id >= m->n) { + assert(q); // otherwise a bug + fprintf(stderr, "[%s] Read group %s used in file %s but absent from the header or an alignment missing read group.\n", __func__, (char*)q+1, fn[i]); + exit(EXIT_FAILURE); + } + if (m->n_plp[id] == m->m_plp[id]) { + m->m_plp[id] = m->m_plp[id]? m->m_plp[id]<<1 : 8; + m->plp[id] = realloc(m->plp[id], sizeof(bam_pileup1_t) * m->m_plp[id]); + } + m->plp[id][m->n_plp[id]++] = *p; + } + } +} + +/* + * Performs pileup + * @param conf configuration for this pileup + * @param n number of files specified in fn + * @param fn filenames + */ +static int mpileup(mplp_conf_t *conf, int n, char **fn) +{ + extern void *bcf_call_add_rg(void *rghash, const char *hdtext, const char *list); + extern void bcf_call_del_rghash(void *rghash); + mplp_aux_t **data; + int i, tid, pos, *n_plp, beg0 = 0, end0 = INT_MAX, ref_len, max_depth, max_indel_depth; + const bam_pileup1_t **plp; + mplp_ref_t mp_ref = MPLP_REF_INIT; + bam_mplp_t iter; + bam_hdr_t *h = NULL; /* header of first file in input list */ + char *ref; + void *rghash = NULL; + FILE *pileup_fp = NULL; + + bcf_callaux_t *bca = NULL; + bcf_callret1_t *bcr = NULL; + bcf_call_t bc; + htsFile *bcf_fp = NULL; + bcf_hdr_t *bcf_hdr = NULL; + + bam_sample_t *sm = NULL; + kstring_t buf; + mplp_pileup_t gplp; + + memset(&gplp, 0, sizeof(mplp_pileup_t)); + memset(&buf, 0, sizeof(kstring_t)); + memset(&bc, 0, sizeof(bcf_call_t)); + data = calloc(n, sizeof(mplp_aux_t*)); + plp = calloc(n, sizeof(bam_pileup1_t*)); + n_plp = calloc(n, sizeof(int)); + sm = bam_smpl_init(); + + if (n == 0) { + fprintf(stderr,"[%s] no input file/data given\n", __func__); + exit(EXIT_FAILURE); + } + + // read the header of each file in the list and initialize data + for (i = 0; i < n; ++i) { + bam_hdr_t *h_tmp; + data[i] = calloc(1, sizeof(mplp_aux_t)); + data[i]->fp = sam_open_format(fn[i], "rb", &conf->ga.in); + if ( !data[i]->fp ) + { + fprintf(stderr, "[%s] failed to open %s: %s\n", __func__, fn[i], strerror(errno)); + exit(EXIT_FAILURE); + } + if (hts_set_opt(data[i]->fp, CRAM_OPT_DECODE_MD, 0)) { + fprintf(stderr, "Failed to set CRAM_OPT_DECODE_MD value\n"); + exit(EXIT_FAILURE); + } + if (conf->fai_fname && hts_set_fai_filename(data[i]->fp, conf->fai_fname) != 0) { + fprintf(stderr, "[%s] failed to process %s: %s\n", + __func__, conf->fai_fname, strerror(errno)); + exit(EXIT_FAILURE); + } + data[i]->conf = conf; + data[i]->ref = &mp_ref; + h_tmp = sam_hdr_read(data[i]->fp); + if ( !h_tmp ) { + fprintf(stderr,"[%s] fail to read the header of %s\n", __func__, fn[i]); + exit(EXIT_FAILURE); + } + bam_smpl_add(sm, fn[i], (conf->flag&MPLP_IGNORE_RG)? 0 : h_tmp->text); + // Collect read group IDs with PL (platform) listed in pl_list (note: fragile, strstr search) + rghash = bcf_call_add_rg(rghash, h_tmp->text, conf->pl_list); + if (conf->reg) { + hts_idx_t *idx = sam_index_load(data[i]->fp, fn[i]); + if (idx == NULL) { + fprintf(stderr, "[%s] fail to load index for %s\n", __func__, fn[i]); + exit(EXIT_FAILURE); + } + if ( (data[i]->iter=sam_itr_querys(idx, h_tmp, conf->reg)) == 0) { + fprintf(stderr, "[E::%s] fail to parse region '%s' with %s\n", __func__, conf->reg, fn[i]); + exit(EXIT_FAILURE); + } + if (i == 0) beg0 = data[i]->iter->beg, end0 = data[i]->iter->end; + hts_idx_destroy(idx); + } + else + data[i]->iter = NULL; + + if (i == 0) h = data[i]->h = h_tmp; // save the header of the first file + else { + // FIXME: check consistency between h and h_tmp + bam_hdr_destroy(h_tmp); + + // we store only the first file's header; it's (alleged to be) + // compatible with the i-th file's target_name lookup needs + data[i]->h = h; + } + } + // allocate data storage proportionate to number of samples being studied sm->n + gplp.n = sm->n; + gplp.n_plp = calloc(sm->n, sizeof(int)); + gplp.m_plp = calloc(sm->n, sizeof(int)); + gplp.plp = calloc(sm->n, sizeof(bam_pileup1_t*)); + + fprintf(stderr, "[%s] %d samples in %d input files\n", __func__, sm->n, n); + // write the VCF header + if (conf->flag & MPLP_BCF) + { + const char *mode; + if ( conf->flag & MPLP_VCF ) + mode = (conf->flag&MPLP_NO_COMP)? "wu" : "wz"; // uncompressed VCF or compressed VCF + else + mode = (conf->flag&MPLP_NO_COMP)? "wub" : "wb"; // uncompressed BCF or compressed BCF + + bcf_fp = bcf_open(conf->output_fname? conf->output_fname : "-", mode); + if (bcf_fp == NULL) { + fprintf(stderr, "[%s] failed to write to %s: %s\n", __func__, conf->output_fname? conf->output_fname : "standard output", strerror(errno)); + exit(EXIT_FAILURE); + } + + // BCF header creation + bcf_hdr = bcf_hdr_init("w"); + kstring_t str = {0,0,NULL}; + + ksprintf(&str, "##samtoolsVersion=%s+htslib-%s\n",samtools_version(),hts_version()); + bcf_hdr_append(bcf_hdr, str.s); + + str.l = 0; + ksprintf(&str, "##samtoolsCommand=samtools mpileup"); + for (i=1; iargc; i++) ksprintf(&str, " %s", conf->argv[i]); + kputc('\n', &str); + bcf_hdr_append(bcf_hdr, str.s); + + if (conf->fai_fname) + { + str.l = 0; + ksprintf(&str, "##reference=file://%s\n", conf->fai_fname); + bcf_hdr_append(bcf_hdr, str.s); + } + + // Translate BAM @SQ tags to BCF ##contig tags + // todo: use/write new BAM header manipulation routines, fill also UR, M5 + for (i=0; in_targets; i++) + { + str.l = 0; + ksprintf(&str, "##contig=", h->target_name[i], h->target_len[i]); + bcf_hdr_append(bcf_hdr, str.s); + } + free(str.s); + bcf_hdr_append(bcf_hdr,"##ALT="); + bcf_hdr_append(bcf_hdr,"##INFO="); + bcf_hdr_append(bcf_hdr,"##INFO="); + bcf_hdr_append(bcf_hdr,"##INFO="); + bcf_hdr_append(bcf_hdr,"##INFO="); + bcf_hdr_append(bcf_hdr,"##INFO="); + bcf_hdr_append(bcf_hdr,"##INFO="); + bcf_hdr_append(bcf_hdr,"##INFO="); + bcf_hdr_append(bcf_hdr,"##INFO="); + bcf_hdr_append(bcf_hdr,"##INFO="); +#if CDF_MWU_TESTS + bcf_hdr_append(bcf_hdr,"##INFO="); + bcf_hdr_append(bcf_hdr,"##INFO="); + bcf_hdr_append(bcf_hdr,"##INFO="); + bcf_hdr_append(bcf_hdr,"##INFO="); +#endif + bcf_hdr_append(bcf_hdr,"##INFO="); + bcf_hdr_append(bcf_hdr,"##INFO="); + bcf_hdr_append(bcf_hdr,"##INFO="); + bcf_hdr_append(bcf_hdr,"##INFO="); + bcf_hdr_append(bcf_hdr,"##FORMAT="); + if ( conf->fmt_flag&B2B_FMT_DP ) + bcf_hdr_append(bcf_hdr,"##FORMAT="); + if ( conf->fmt_flag&B2B_FMT_DV ) + bcf_hdr_append(bcf_hdr,"##FORMAT="); + if ( conf->fmt_flag&B2B_FMT_DPR ) + bcf_hdr_append(bcf_hdr,"##FORMAT="); + if ( conf->fmt_flag&B2B_INFO_DPR ) + bcf_hdr_append(bcf_hdr,"##INFO="); + if ( conf->fmt_flag&B2B_FMT_DP4 ) + bcf_hdr_append(bcf_hdr,"##FORMAT="); + if ( conf->fmt_flag&B2B_FMT_SP ) + bcf_hdr_append(bcf_hdr,"##FORMAT="); + if ( conf->fmt_flag&B2B_FMT_AD ) + bcf_hdr_append(bcf_hdr,"##FORMAT="); + if ( conf->fmt_flag&B2B_FMT_ADF ) + bcf_hdr_append(bcf_hdr,"##FORMAT="); + if ( conf->fmt_flag&B2B_FMT_ADR ) + bcf_hdr_append(bcf_hdr,"##FORMAT="); + if ( conf->fmt_flag&B2B_INFO_AD ) + bcf_hdr_append(bcf_hdr,"##INFO="); + if ( conf->fmt_flag&B2B_INFO_ADF ) + bcf_hdr_append(bcf_hdr,"##INFO="); + if ( conf->fmt_flag&B2B_INFO_ADR ) + bcf_hdr_append(bcf_hdr,"##INFO="); + + for (i=0; in; i++) + bcf_hdr_add_sample(bcf_hdr, sm->smpl[i]); + bcf_hdr_add_sample(bcf_hdr, NULL); + bcf_hdr_write(bcf_fp, bcf_hdr); + // End of BCF header creation + + // Initialise the calling algorithm + bca = bcf_call_init(-1., conf->min_baseQ); + bcr = calloc(sm->n, sizeof(bcf_callret1_t)); + bca->rghash = rghash; + bca->openQ = conf->openQ, bca->extQ = conf->extQ, bca->tandemQ = conf->tandemQ; + bca->min_frac = conf->min_frac; + bca->min_support = conf->min_support; + bca->per_sample_flt = conf->flag & MPLP_PER_SAMPLE; + + bc.bcf_hdr = bcf_hdr; + bc.n = sm->n; + bc.PL = malloc(15 * sm->n * sizeof(*bc.PL)); + if (conf->fmt_flag) + { + assert( sizeof(float)==sizeof(int32_t) ); + bc.DP4 = malloc(sm->n * sizeof(int32_t) * 4); + bc.fmt_arr = malloc(sm->n * sizeof(float)); // all fmt_flag fields + if ( conf->fmt_flag&(B2B_INFO_DPR|B2B_FMT_DPR|B2B_INFO_AD|B2B_INFO_ADF|B2B_INFO_ADR|B2B_FMT_AD|B2B_FMT_ADF|B2B_FMT_ADR) ) + { + // first B2B_MAX_ALLELES fields for total numbers, the rest per-sample + bc.ADR = (int32_t*) malloc((sm->n+1)*B2B_MAX_ALLELES*sizeof(int32_t)); + bc.ADF = (int32_t*) malloc((sm->n+1)*B2B_MAX_ALLELES*sizeof(int32_t)); + for (i=0; in; i++) + { + bcr[i].ADR = bc.ADR + (i+1)*B2B_MAX_ALLELES; + bcr[i].ADF = bc.ADF + (i+1)*B2B_MAX_ALLELES; + } + } + } + } + else { + pileup_fp = conf->output_fname? fopen(conf->output_fname, "w") : stdout; + + if (pileup_fp == NULL) { + fprintf(stderr, "[%s] failed to write to %s: %s\n", __func__, conf->output_fname, strerror(errno)); + exit(EXIT_FAILURE); + } + } + + // init pileup + iter = bam_mplp_init(n, mplp_func, (void**)data); + if ( conf->flag & MPLP_SMART_OVERLAPS ) bam_mplp_init_overlaps(iter); + max_depth = conf->max_depth; + if (max_depth * sm->n > 1<<20) + fprintf(stderr, "(%s) Max depth is above 1M. Potential memory hog!\n", __func__); + if (max_depth * sm->n < 8000) { + max_depth = 8000 / sm->n; + fprintf(stderr, "<%s> Set max per-file depth to %d\n", __func__, max_depth); + } + max_indel_depth = conf->max_indel_depth * sm->n; + bam_mplp_set_maxcnt(iter, max_depth); + bcf1_t *bcf_rec = bcf_init1(); + int ret; + // begin pileup + while ( (ret=bam_mplp_auto(iter, &tid, &pos, n_plp, plp)) > 0) { + if (conf->reg && (pos < beg0 || pos >= end0)) continue; // out of the region requested + if (conf->bed && tid >= 0 && !bed_overlap(conf->bed, h->target_name[tid], pos, pos+1)) continue; + mplp_get_ref(data[0], tid, &ref, &ref_len); + //printf("tid=%d len=%d ref=%p/%s\n", tid, ref_len, ref, ref); + if (conf->flag & MPLP_BCF) { + int total_depth, _ref0, ref16; + for (i = total_depth = 0; i < n; ++i) total_depth += n_plp[i]; + group_smpl(&gplp, sm, &buf, n, fn, n_plp, plp, conf->flag & MPLP_IGNORE_RG); + _ref0 = (ref && pos < ref_len)? ref[pos] : 'N'; + ref16 = seq_nt16_table[_ref0]; + bcf_callaux_clean(bca, &bc); + for (i = 0; i < gplp.n; ++i) + bcf_call_glfgen(gplp.n_plp[i], gplp.plp[i], ref16, bca, bcr + i); + bc.tid = tid; bc.pos = pos; + bcf_call_combine(gplp.n, bcr, bca, ref16, &bc); + bcf_clear1(bcf_rec); + bcf_call2bcf(&bc, bcf_rec, bcr, conf->fmt_flag, 0, 0); + bcf_write1(bcf_fp, bcf_hdr, bcf_rec); + // call indels; todo: subsampling with total_depth>max_indel_depth instead of ignoring? + if (!(conf->flag&MPLP_NO_INDEL) && total_depth < max_indel_depth && bcf_call_gap_prep(gplp.n, gplp.n_plp, gplp.plp, pos, bca, ref, rghash) >= 0) + { + bcf_callaux_clean(bca, &bc); + for (i = 0; i < gplp.n; ++i) + bcf_call_glfgen(gplp.n_plp[i], gplp.plp[i], -1, bca, bcr + i); + if (bcf_call_combine(gplp.n, bcr, bca, -1, &bc) >= 0) { + bcf_clear1(bcf_rec); + bcf_call2bcf(&bc, bcf_rec, bcr, conf->fmt_flag, bca, ref); + bcf_write1(bcf_fp, bcf_hdr, bcf_rec); + } + } + } else { + fprintf(pileup_fp, "%s\t%d\t%c", h->target_name[tid], pos + 1, (ref && pos < ref_len)? ref[pos] : 'N'); + for (i = 0; i < n; ++i) { + int j, cnt; + for (j = cnt = 0; j < n_plp[i]; ++j) { + const bam_pileup1_t *p = plp[i] + j; + int c = p->qpos < p->b->core.l_qseq + ? bam_get_qual(p->b)[p->qpos] + : 0; + if (c >= conf->min_baseQ) ++cnt; + } + fprintf(pileup_fp, "\t%d\t", cnt); + if (n_plp[i] == 0) { + fputs("*\t*", pileup_fp); + if (conf->flag & MPLP_PRINT_MAPQ) fputs("\t*", pileup_fp); + if (conf->flag & MPLP_PRINT_POS) fputs("\t*", pileup_fp); + } else { + for (j = 0; j < n_plp[i]; ++j) { + const bam_pileup1_t *p = plp[i] + j; + int c = p->qpos < p->b->core.l_qseq + ? bam_get_qual(p->b)[p->qpos] + : 0; + if (c >= conf->min_baseQ) + pileup_seq(pileup_fp, plp[i] + j, pos, ref_len, ref); + } + putc('\t', pileup_fp); + for (j = 0; j < n_plp[i]; ++j) { + const bam_pileup1_t *p = plp[i] + j; + int c = p->qpos < p->b->core.l_qseq + ? bam_get_qual(p->b)[p->qpos] + : 0; + if (c >= conf->min_baseQ) { + c = c + 33 < 126? c + 33 : 126; + putc(c, pileup_fp); + } + } + if (conf->flag & MPLP_PRINT_MAPQ) { + putc('\t', pileup_fp); + for (j = 0; j < n_plp[i]; ++j) { + const bam_pileup1_t *p = plp[i] + j; + int c = bam_get_qual(p->b)[p->qpos]; + if ( c < conf->min_baseQ ) continue; + c = plp[i][j].b->core.qual + 33; + if (c > 126) c = 126; + putc(c, pileup_fp); + } + } + if (conf->flag & MPLP_PRINT_POS) { + putc('\t', pileup_fp); + int last = 0; + for (j = 0; j < n_plp[i]; ++j) { + const bam_pileup1_t *p = plp[i] + j; + int c = bam_get_qual(p->b)[p->qpos]; + if ( c < conf->min_baseQ ) continue; + + if (last++) putc(',', pileup_fp); + fprintf(pileup_fp, "%d", plp[i][j].qpos + 1); // FIXME: printf() is very slow... + } + } + } + } + putc('\n', pileup_fp); + } + } + + // clean up + free(bc.tmp.s); + bcf_destroy1(bcf_rec); + if (bcf_fp) + { + hts_close(bcf_fp); + bcf_hdr_destroy(bcf_hdr); + bcf_call_destroy(bca); + free(bc.PL); + free(bc.DP4); + free(bc.ADR); + free(bc.ADF); + free(bc.fmt_arr); + free(bcr); + } + if (pileup_fp && conf->output_fname) fclose(pileup_fp); + bam_smpl_destroy(sm); free(buf.s); + for (i = 0; i < gplp.n; ++i) free(gplp.plp[i]); + free(gplp.plp); free(gplp.n_plp); free(gplp.m_plp); + bcf_call_del_rghash(rghash); + bam_mplp_destroy(iter); + bam_hdr_destroy(h); + for (i = 0; i < n; ++i) { + sam_close(data[i]->fp); + if (data[i]->iter) hts_itr_destroy(data[i]->iter); + free(data[i]); + } + free(data); free(plp); free(n_plp); + free(mp_ref.ref[0]); + free(mp_ref.ref[1]); + return ret; +} + +#define MAX_PATH_LEN 1024 +int read_file_list(const char *file_list,int *n,char **argv[]) +{ + char buf[MAX_PATH_LEN]; + int len, nfiles = 0; + char **files = NULL; + struct stat sb; + + *n = 0; + *argv = NULL; + + FILE *fh = fopen(file_list,"r"); + if ( !fh ) + { + fprintf(stderr,"%s: %s\n", file_list,strerror(errno)); + return 1; + } + + files = calloc(nfiles,sizeof(char*)); + nfiles = 0; + while ( fgets(buf,MAX_PATH_LEN,fh) ) + { + // allow empty lines and trailing spaces + len = strlen(buf); + while ( len>0 && isspace(buf[len-1]) ) len--; + if ( !len ) continue; + + // check sanity of the file list + buf[len] = 0; + if (stat(buf, &sb) != 0) + { + // no such file, check if it is safe to print its name + int i, safe_to_print = 1; + for (i=0; irflag_require); + char *tmp_filter = bam_flag2str(mplp->rflag_filter); + + // Display usage information, formatted for the standard 80 columns. + // (The unusual string formatting here aids the readability of this + // source code in 80 columns, to the extent that's possible.) + + fprintf(fp, +"\n" +"Usage: samtools mpileup [options] in1.bam [in2.bam [...]]\n" +"\n" +"Input options:\n" +" -6, --illumina1.3+ quality is in the Illumina-1.3+ encoding\n" +" -A, --count-orphans do not discard anomalous read pairs\n" +" -b, --bam-list FILE list of input BAM filenames, one per line\n" +" -B, --no-BAQ disable BAQ (per-Base Alignment Quality)\n" +" -C, --adjust-MQ INT adjust mapping quality; recommended:50, disable:0 [0]\n" +" -d, --max-depth INT max per-file depth; avoids excessive memory usage [%d]\n", mplp->max_depth); + fprintf(fp, +" -E, --redo-BAQ recalculate BAQ on the fly, ignore existing BQs\n" +" -f, --fasta-ref FILE faidx indexed reference sequence file\n" +" -G, --exclude-RG FILE exclude read groups listed in FILE\n" +" -l, --positions FILE skip unlisted positions (chr pos) or regions (BED)\n" +" -q, --min-MQ INT skip alignments with mapQ smaller than INT [%d]\n", mplp->min_mq); + fprintf(fp, +" -Q, --min-BQ INT skip bases with baseQ/BAQ smaller than INT [%d]\n", mplp->min_baseQ); + fprintf(fp, +" -r, --region REG region in which pileup is generated\n" +" -R, --ignore-RG ignore RG tags (one BAM = one sample)\n" +" --rf, --incl-flags STR|INT required flags: skip reads with mask bits unset [%s]\n", tmp_require); + fprintf(fp, +" --ff, --excl-flags STR|INT filter flags: skip reads with mask bits set\n" +" [%s]\n", tmp_filter); + fprintf(fp, +" -x, --ignore-overlaps disable read-pair overlap detection\n" +"\n" +"Output options:\n" +" -o, --output FILE write output to FILE [standard output]\n" +" -g, --BCF generate genotype likelihoods in BCF format\n" +" -v, --VCF generate genotype likelihoods in VCF format\n" +"\n" +"Output options for mpileup format (without -g/-v):\n" +" -O, --output-BP output base positions on reads\n" +" -s, --output-MQ output mapping quality\n" +"\n" +"Output options for genotype likelihoods (when -g/-v is used):\n" +" -t, --output-tags LIST optional tags to output:\n" +" DP,AD,ADF,ADR,SP,INFO/AD,INFO/ADF,INFO/ADR []\n" +" -u, --uncompressed generate uncompressed VCF/BCF output\n" +"\n" +"SNP/INDEL genotype likelihoods options (effective with -g/-v):\n" +" -e, --ext-prob INT Phred-scaled gap extension seq error probability [%d]\n", mplp->extQ); + fprintf(fp, +" -F, --gap-frac FLOAT minimum fraction of gapped reads [%g]\n", mplp->min_frac); + fprintf(fp, +" -h, --tandem-qual INT coefficient for homopolymer errors [%d]\n", mplp->tandemQ); + fprintf(fp, +" -I, --skip-indels do not perform indel calling\n" +" -L, --max-idepth INT maximum per-file depth for INDEL calling [%d]\n", mplp->max_indel_depth); + fprintf(fp, +" -m, --min-ireads INT minimum number gapped reads for indel candidates [%d]\n", mplp->min_support); + fprintf(fp, +" -o, --open-prob INT Phred-scaled gap open seq error probability [%d]\n", mplp->openQ); + fprintf(fp, +" -p, --per-sample-mF apply -m and -F per-sample for increased sensitivity\n" +" -P, --platforms STR comma separated list of platforms for indels [all]\n"); + sam_global_opt_help(fp, "-.--."); + fprintf(fp, +"\n" +"Notes: Assuming diploid individuals.\n"); + + free(tmp_require); + free(tmp_filter); +} + +int bam_mpileup(int argc, char *argv[]) +{ + int c; + const char *file_list = NULL; + char **fn = NULL; + int nfiles = 0, use_orphan = 0; + mplp_conf_t mplp; + memset(&mplp, 0, sizeof(mplp_conf_t)); + mplp.min_baseQ = 13; + mplp.capQ_thres = 0; + mplp.max_depth = 250; mplp.max_indel_depth = 250; + mplp.openQ = 40; mplp.extQ = 20; mplp.tandemQ = 100; + mplp.min_frac = 0.002; mplp.min_support = 1; + mplp.flag = MPLP_NO_ORPHAN | MPLP_REALN | MPLP_SMART_OVERLAPS; + mplp.argc = argc; mplp.argv = argv; + mplp.rflag_filter = BAM_FUNMAP | BAM_FSECONDARY | BAM_FQCFAIL | BAM_FDUP; + mplp.output_fname = NULL; + sam_global_args_init(&mplp.ga); + + static const struct option lopts[] = + { + SAM_OPT_GLOBAL_OPTIONS('-', 0, '-', '-', 0), + {"rf", required_argument, NULL, 1}, // require flag + {"ff", required_argument, NULL, 2}, // filter flag + {"incl-flags", required_argument, NULL, 1}, + {"excl-flags", required_argument, NULL, 2}, + {"output", required_argument, NULL, 3}, + {"open-prob", required_argument, NULL, 4}, + {"illumina1.3+", no_argument, NULL, '6'}, + {"count-orphans", no_argument, NULL, 'A'}, + {"bam-list", required_argument, NULL, 'b'}, + {"no-BAQ", no_argument, NULL, 'B'}, + {"no-baq", no_argument, NULL, 'B'}, + {"adjust-MQ", required_argument, NULL, 'C'}, + {"adjust-mq", required_argument, NULL, 'C'}, + {"max-depth", required_argument, NULL, 'd'}, + {"redo-BAQ", no_argument, NULL, 'E'}, + {"redo-baq", no_argument, NULL, 'E'}, + {"fasta-ref", required_argument, NULL, 'f'}, + {"exclude-RG", required_argument, NULL, 'G'}, + {"exclude-rg", required_argument, NULL, 'G'}, + {"positions", required_argument, NULL, 'l'}, + {"region", required_argument, NULL, 'r'}, + {"ignore-RG", no_argument, NULL, 'R'}, + {"ignore-rg", no_argument, NULL, 'R'}, + {"min-MQ", required_argument, NULL, 'q'}, + {"min-mq", required_argument, NULL, 'q'}, + {"min-BQ", required_argument, NULL, 'Q'}, + {"min-bq", required_argument, NULL, 'Q'}, + {"ignore-overlaps", no_argument, NULL, 'x'}, + {"BCF", no_argument, NULL, 'g'}, + {"bcf", no_argument, NULL, 'g'}, + {"VCF", no_argument, NULL, 'v'}, + {"vcf", no_argument, NULL, 'v'}, + {"output-BP", no_argument, NULL, 'O'}, + {"output-bp", no_argument, NULL, 'O'}, + {"output-MQ", no_argument, NULL, 's'}, + {"output-mq", no_argument, NULL, 's'}, + {"output-tags", required_argument, NULL, 't'}, + {"uncompressed", no_argument, NULL, 'u'}, + {"ext-prob", required_argument, NULL, 'e'}, + {"gap-frac", required_argument, NULL, 'F'}, + {"tandem-qual", required_argument, NULL, 'h'}, + {"skip-indels", no_argument, NULL, 'I'}, + {"max-idepth", required_argument, NULL, 'L'}, + {"min-ireads ", required_argument, NULL, 'm'}, + {"per-sample-mF", no_argument, NULL, 'p'}, + {"per-sample-mf", no_argument, NULL, 'p'}, + {"platforms", required_argument, NULL, 'P'}, + {NULL, 0, NULL, 0} + }; + while ((c = getopt_long(argc, argv, "Agf:r:l:q:Q:uRC:BDSd:L:b:P:po:e:h:Im:F:EG:6OsVvxt:",lopts,NULL)) >= 0) { + switch (c) { + case 'x': mplp.flag &= ~MPLP_SMART_OVERLAPS; break; + case 1 : + mplp.rflag_require = bam_str2flag(optarg); + if ( mplp.rflag_require<0 ) { fprintf(stderr,"Could not parse --rf %s\n", optarg); return 1; } + break; + case 2 : + mplp.rflag_filter = bam_str2flag(optarg); + if ( mplp.rflag_filter<0 ) { fprintf(stderr,"Could not parse --ff %s\n", optarg); return 1; } + break; + case 3 : mplp.output_fname = optarg; break; + case 4 : mplp.openQ = atoi(optarg); break; + case 'f': + mplp.fai = fai_load(optarg); + if (mplp.fai == NULL) return 1; + mplp.fai_fname = optarg; + break; + case 'd': mplp.max_depth = atoi(optarg); break; + case 'r': mplp.reg = strdup(optarg); break; + case 'l': + // In the original version the whole BAM was streamed which is inefficient + // with few BED intervals and big BAMs. Todo: devise a heuristic to determine + // best strategy, that is streaming or jumping. + mplp.bed = bed_read(optarg); + if (!mplp.bed) { print_error_errno("mpileup", "Could not read file \"%s\"", optarg); return 1; } + break; + case 'P': mplp.pl_list = strdup(optarg); break; + case 'p': mplp.flag |= MPLP_PER_SAMPLE; break; + case 'g': mplp.flag |= MPLP_BCF; break; + case 'v': mplp.flag |= MPLP_BCF | MPLP_VCF; break; + case 'u': mplp.flag |= MPLP_NO_COMP | MPLP_BCF; break; + case 'B': mplp.flag &= ~MPLP_REALN; break; + case 'D': mplp.fmt_flag |= B2B_FMT_DP; fprintf(stderr, "[warning] samtools mpileup option `-D` is functional, but deprecated. Please switch to `-t DP` in future.\n"); break; + case 'S': mplp.fmt_flag |= B2B_FMT_SP; fprintf(stderr, "[warning] samtools mpileup option `-S` is functional, but deprecated. Please switch to `-t SP` in future.\n"); break; + case 'V': mplp.fmt_flag |= B2B_FMT_DV; fprintf(stderr, "[warning] samtools mpileup option `-V` is functional, but deprecated. Please switch to `-t DV` in future.\n"); break; + case 'I': mplp.flag |= MPLP_NO_INDEL; break; + case 'E': mplp.flag |= MPLP_REDO_BAQ; break; + case '6': mplp.flag |= MPLP_ILLUMINA13; break; + case 'R': mplp.flag |= MPLP_IGNORE_RG; break; + case 's': mplp.flag |= MPLP_PRINT_MAPQ; break; + case 'O': mplp.flag |= MPLP_PRINT_POS; break; + case 'C': mplp.capQ_thres = atoi(optarg); break; + case 'q': mplp.min_mq = atoi(optarg); break; + case 'Q': mplp.min_baseQ = atoi(optarg); break; + case 'b': file_list = optarg; break; + case 'o': { + char *end; + long value = strtol(optarg, &end, 10); + // Distinguish between -o INT and -o FILE (a bit of a hack!) + if (*end == '\0') mplp.openQ = value; + else mplp.output_fname = optarg; + } + break; + case 'e': mplp.extQ = atoi(optarg); break; + case 'h': mplp.tandemQ = atoi(optarg); break; + case 'A': use_orphan = 1; break; + case 'F': mplp.min_frac = atof(optarg); break; + case 'm': mplp.min_support = atoi(optarg); break; + case 'L': mplp.max_indel_depth = atoi(optarg); break; + case 'G': { + FILE *fp_rg; + char buf[1024]; + mplp.rghash = khash_str2int_init(); + if ((fp_rg = fopen(optarg, "r")) == NULL) + fprintf(stderr, "(%s) Fail to open file %s. Continue anyway.\n", __func__, optarg); + while (!feof(fp_rg) && fscanf(fp_rg, "%s", buf) > 0) // this is not a good style, but forgive me... + khash_str2int_inc(mplp.rghash, strdup(buf)); + fclose(fp_rg); + } + break; + case 't': mplp.fmt_flag |= parse_format_flag(optarg); break; + default: + if (parse_sam_global_opt(c, optarg, lopts, &mplp.ga) == 0) break; + /* else fall-through */ + case '?': + print_usage(stderr, &mplp); + return 1; + } + } + if (!mplp.fai && mplp.ga.reference) { + mplp.fai_fname = mplp.ga.reference; + mplp.fai = fai_load(mplp.fai_fname); + if (mplp.fai == NULL) return 1; + } + + if ( !(mplp.flag&MPLP_REALN) && mplp.flag&MPLP_REDO_BAQ ) + { + fprintf(stderr,"Error: The -B option cannot be combined with -E\n"); + return 1; + } + if (use_orphan) mplp.flag &= ~MPLP_NO_ORPHAN; + if (argc == 1) + { + print_usage(stderr, &mplp); + return 1; + } + int ret; + if (file_list) { + if ( read_file_list(file_list,&nfiles,&fn) ) return 1; + ret = mpileup(&mplp,nfiles,fn); + for (c=0; c + +Permission is hereby granted, free of charge, to any person obtaining a copy +of this software and associated documentation files (the "Software"), to deal +in the Software without restriction, including without limitation the rights +to use, copy, modify, merge, publish, distribute, sublicense, and/or sell +copies of the Software, and to permit persons to whom the Software is +furnished to do so, subject to the following conditions: + +The above copyright notice and this permission notice shall be included in +all copies or substantial portions of the Software. + +THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS OR +IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF MERCHANTABILITY, +FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. IN NO EVENT SHALL +THE AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY CLAIM, DAMAGES OR OTHER +LIABILITY, WHETHER IN AN ACTION OF CONTRACT, TORT OR OTHERWISE, ARISING +FROM, OUT OF OR IN CONNECTION WITH THE SOFTWARE OR THE USE OR OTHER +DEALINGS IN THE SOFTWARE. */ + +#include + +#include +#include +#include "sample.h" +#include "htslib/khash.h" +KHASH_MAP_INIT_STR(sm, int) + +bam_sample_t *bam_smpl_init(void) +{ + bam_sample_t *s; + s = calloc(1, sizeof(bam_sample_t)); + s->rg2smid = kh_init(sm); + s->sm2id = kh_init(sm); + return s; +} + +void bam_smpl_destroy(bam_sample_t *sm) +{ + int i; + khint_t k; + khash_t(sm) *rg2smid = (khash_t(sm)*)sm->rg2smid; + if (sm == 0) return; + for (i = 0; i < sm->n; ++i) free(sm->smpl[i]); + free(sm->smpl); + for (k = kh_begin(rg2smid); k != kh_end(rg2smid); ++k) + if (kh_exist(rg2smid, k)) free((char*)kh_key(rg2smid, k)); + kh_destroy(sm, sm->rg2smid); + kh_destroy(sm, sm->sm2id); + free(sm); +} + +static void add_pair(bam_sample_t *sm, khash_t(sm) *sm2id, const char *key, const char *val) +{ + khint_t k_rg, k_sm; + int ret; + khash_t(sm) *rg2smid = (khash_t(sm)*)sm->rg2smid; + k_rg = kh_get(sm, rg2smid, key); + if (k_rg != kh_end(rg2smid)) return; // duplicated @RG-ID + k_rg = kh_put(sm, rg2smid, strdup(key), &ret); + k_sm = kh_get(sm, sm2id, val); + if (k_sm == kh_end(sm2id)) { // absent + if (sm->n == sm->m) { + sm->m = sm->m? sm->m<<1 : 1; + sm->smpl = realloc(sm->smpl, sizeof(char*) * sm->m); + } + sm->smpl[sm->n] = strdup(val); + k_sm = kh_put(sm, sm2id, sm->smpl[sm->n], &ret); + kh_val(sm2id, k_sm) = sm->n++; + } + kh_val(rg2smid, k_rg) = kh_val(sm2id, k_sm); +} + +int bam_smpl_add(bam_sample_t *sm, const char *fn, const char *txt) +{ + const char *p = txt, *q, *r; + kstring_t buf, first_sm; + int n = 0; + khash_t(sm) *sm2id = (khash_t(sm)*)sm->sm2id; + if (txt == 0) { + add_pair(sm, sm2id, fn, fn); + return 0; + } + memset(&buf, 0, sizeof(kstring_t)); + memset(&first_sm, 0, sizeof(kstring_t)); + while ((q = strstr(p, "@RG")) != 0) { + p = q + 3; + r = q = 0; + if ((q = strstr(p, "\tID:")) != 0) q += 4; + if ((r = strstr(p, "\tSM:")) != 0) r += 4; + if (r && q) { + char *u, *v; + int oq, or; + for (u = (char*)q; *u && *u != '\t' && *u != '\n'; ++u); + for (v = (char*)r; *v && *v != '\t' && *v != '\n'; ++v); + oq = *u; or = *v; *u = *v = '\0'; + buf.l = 0; kputs(fn, &buf); kputc('/', &buf); kputs(q, &buf); + add_pair(sm, sm2id, buf.s, r); + if ( !first_sm.s ) + kputs(r,&first_sm); + *u = oq; *v = or; + } else break; + p = q > r? q : r; + ++n; + } + if (n == 0) add_pair(sm, sm2id, fn, fn); + // If there is only one RG tag present in the header and reads are not annotated, don't refuse to work but + // use the tag instead. + else if ( n==1 && first_sm.s ) + add_pair(sm,sm2id,fn,first_sm.s); + if ( first_sm.s ) + free(first_sm.s); + +// add_pair(sm, sm2id, fn, fn); + free(buf.s); + return 0; +} + +int bam_smpl_rg2smid(const bam_sample_t *sm, const char *fn, const char *rg, kstring_t *str) +{ + khint_t k; + khash_t(sm) *rg2smid = (khash_t(sm)*)sm->rg2smid; + if (rg) { + str->l = 0; + kputs(fn, str); kputc('/', str); kputs(rg, str); + k = kh_get(sm, rg2smid, str->s); + } else k = kh_get(sm, rg2smid, fn); + return k == kh_end(rg2smid)? -1 : kh_val(rg2smid, k); +} diff --git a/sample.h b/sample.h new file mode 100644 index 000000000..8e8efa5b7 --- /dev/null +++ b/sample.h @@ -0,0 +1,41 @@ +/* sample.h -- group data by sample. + + Copyright (C) 2010 Broad Institute. + + Author: Heng Li + +Permission is hereby granted, free of charge, to any person obtaining a copy +of this software and associated documentation files (the "Software"), to deal +in the Software without restriction, including without limitation the rights +to use, copy, modify, merge, publish, distribute, sublicense, and/or sell +copies of the Software, and to permit persons to whom the Software is +furnished to do so, subject to the following conditions: + +The above copyright notice and this permission notice shall be included in +all copies or substantial portions of the Software. + +THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS OR +IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF MERCHANTABILITY, +FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. IN NO EVENT SHALL +THE AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY CLAIM, DAMAGES OR OTHER +LIABILITY, WHETHER IN AN ACTION OF CONTRACT, TORT OR OTHERWISE, ARISING +FROM, OUT OF OR IN CONNECTION WITH THE SOFTWARE OR THE USE OR OTHER +DEALINGS IN THE SOFTWARE. */ + +#ifndef BAM_SAMPLE_H +#define BAM_SAMPLE_H + +#include "htslib/kstring.h" + +typedef struct { + int n, m; + char **smpl; + void *rg2smid, *sm2id; +} bam_sample_t; + +bam_sample_t *bam_smpl_init(void); +int bam_smpl_add(bam_sample_t *sm, const char *abs, const char *txt); +int bam_smpl_rg2smid(const bam_sample_t *sm, const char *fn, const char *rg, kstring_t *str); +void bam_smpl_destroy(bam_sample_t *sm); + +#endif From e46a2cf8101d81a0327a30ef1440e2c2f265e747 Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Mon, 25 Apr 2016 13:08:17 +0100 Subject: [PATCH 190/211] rename bam_plcmd.c -> mpileup.c --- bam_plcmd.c => mpileup.c | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) rename bam_plcmd.c => mpileup.c (99%) diff --git a/bam_plcmd.c b/mpileup.c similarity index 99% rename from bam_plcmd.c rename to mpileup.c index ddd2f0043..1d47728b4 100644 --- a/bam_plcmd.c +++ b/mpileup.c @@ -1,4 +1,4 @@ -/* bam_plcmd.c -- mpileup subcommand. +/* mpileup.c -- mpileup subcommand. Previously bam_plcmd.c from samtools Copyright (C) 2008-2015 Genome Research Ltd. Portions copyright (C) 2009-2012 Broad Institute. From edc2bc644a62dc4b443e6545b134f0b0d1486469 Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Mon, 25 Apr 2016 18:45:24 +0100 Subject: [PATCH 191/211] add mpileup command to bcftools minimal changes to files copied from samtools in order to compile in bcftools. * use regidx from htslib rather than bedidx from samtools * remove sam_opts calls as sam_opts.h not copied from samtools Todo: * copy over relevant functionality from sam_opts.h * remove text based mpileup output * update options and defaults * bring over `---gvcf` and other changes from @pd3 fork --- Makefile | 5 +++ bam2bcf.c | 20 ++++++------ bam2bcf_indel.c | 34 ++++++++++---------- main.c | 5 +++ mpileup.c | 85 +++++++++++++++++++------------------------------ sample.c | 14 ++++---- 6 files changed, 75 insertions(+), 88 deletions(-) diff --git a/Makefile b/Makefile index 7dec9dd07..64f564fe6 100644 --- a/Makefile +++ b/Makefile @@ -46,6 +46,7 @@ OBJS = main.o vcfindex.o tabix.o \ vcfnorm.o vcfgtcheck.o vcfview.o vcfannotate.o vcfroh.o vcfconcat.o \ vcfcall.o mcall.o vcmp.o gvcf.o reheader.o convert.o vcfconvert.o tsv2vcf.o \ vcfcnv.o HMM.o vcfplugin.o consensus.o ploidy.o version.o \ + mpileup.o bam2bcf.o bam2bcf_indel.o sample.o \ ccall.o em.o prob1.o kmin.o # the original samtools calling EXTRA_CPPFLAGS = -I. -I$(HTSDIR) -DPLUGINPATH=\"$(pluginpath)\" @@ -138,6 +139,9 @@ ploidy_h = ploidy.h $(htslib_regidx_h) prob1_h = prob1.h $(htslib_vcf_h) $(call_h) roh_h = HMM.h $(htslib_vcf_h) $(htslib_synced_bcf_reader_h) $(HTSDIR)/htslib/kstring.h $(HTSDIR)/htslib/kseq.h $(bcftools_h) cnv_h = HMM.h $(htslib_vcf_h) $(htslib_synced_bcf_reader_h) +bam2bcf_h = bam2bcf.h $(htslib_hts_h) $(htslib_vcf_h) +sam_h = sam.h $(htslib_sam_h) $(bam_h) +sample_h = sample.h $(htslib_kstring_h) main.o: main.c $(htslib_hts_h) version.h $(bcftools_h) vcfannotate.o: vcfannotate.c $(htslib_vcf_h) $(htslib_synced_bcf_reader_h) $(HTSDIR)/htslib/kseq.h $(bcftools_h) vcmp.h $(filter_h) @@ -173,6 +177,7 @@ ploidy.o: ploidy.c $(htslib_regidx_h) $(HTSDIR)/htslib/khash_str2int.h $(HTSDIR) polysomy.o: polysomy.c $(htslib_vcf_h) $(htslib_synced_bcf_reader_h) $(bcftools_h) peakfit.h peakfit.o: peakfit.c peakfit.h $(htslib_hts_h) $(HTSDIR)/htslib/kstring.h consensus.o: consensus.c $(htslib_hts_h) $(HTSDIR)/htslib/kseq.h rbuf.h $(bcftools_h) $(HTSDIR)/htslib/regidx.h +mpileup.o: mpileup.c $(htslib_sam_h) $(htslib_faidx_h) $(htslib_kstring_h) $(htslib_khash_str2int_h) $(htslib_regidx_h) $(bcftools_h) $(bam2bcf_h) $(sample_h) version.o: version.h version.c test/test-rbuf.o: test/test-rbuf.c rbuf.h diff --git a/bam2bcf.c b/bam2bcf.c index a824d5ac0..8bb799ebd 100644 --- a/bam2bcf.c +++ b/bam2bcf.c @@ -23,8 +23,6 @@ LIABILITY, WHETHER IN AN ACTION OF CONTRACT, TORT OR OTHERWISE, ARISING FROM, OUT OF OR IN CONNECTION WITH THE SOFTWARE OR THE USE OR OTHER DEALINGS IN THE SOFTWARE. */ -#include - #include #include #include @@ -46,7 +44,7 @@ bcf_callaux_t *bcf_call_init(double theta, int min_baseQ) { bcf_callaux_t *bca; if (theta <= 0.) theta = CALL_DEFTHETA; - bca = calloc(1, sizeof(bcf_callaux_t)); + bca = (bcf_callaux_t*) calloc(1, sizeof(bcf_callaux_t)); bca->capQ = 60; bca->openQ = 40; bca->extQ = 20; bca->tandemQ = 100; bca->min_baseQ = min_baseQ; @@ -55,15 +53,15 @@ bcf_callaux_t *bcf_call_init(double theta, int min_baseQ) bca->min_support = 1; bca->per_sample_flt = 0; bca->npos = 100; - bca->ref_pos = malloc(bca->npos*sizeof(int)); - bca->alt_pos = malloc(bca->npos*sizeof(int)); + bca->ref_pos = (int*) malloc(bca->npos*sizeof(int)); + bca->alt_pos = (int*) malloc(bca->npos*sizeof(int)); bca->nqual = 60; - bca->ref_mq = malloc(bca->nqual*sizeof(int)); - bca->alt_mq = malloc(bca->nqual*sizeof(int)); - bca->ref_bq = malloc(bca->nqual*sizeof(int)); - bca->alt_bq = malloc(bca->nqual*sizeof(int)); - bca->fwd_mqs = malloc(bca->nqual*sizeof(int)); - bca->rev_mqs = malloc(bca->nqual*sizeof(int)); + bca->ref_mq = (int*) malloc(bca->nqual*sizeof(int)); + bca->alt_mq = (int*) malloc(bca->nqual*sizeof(int)); + bca->ref_bq = (int*) malloc(bca->nqual*sizeof(int)); + bca->alt_bq = (int*) malloc(bca->nqual*sizeof(int)); + bca->fwd_mqs = (int*) malloc(bca->nqual*sizeof(int)); + bca->rev_mqs = (int*) malloc(bca->nqual*sizeof(int)); return bca; } diff --git a/bam2bcf_indel.c b/bam2bcf_indel.c index 2b42b09d7..95cc5b076 100644 --- a/bam2bcf_indel.c +++ b/bam2bcf_indel.c @@ -23,8 +23,6 @@ LIABILITY, WHETHER IN AN ACTION OF CONTRACT, TORT OR OTHERWISE, ARISING FROM, OUT OF OR IN CONNECTION WITH THE SOFTWARE OR THE USE OR OTHER DEALINGS IN THE SOFTWARE. */ -#include - #include #include #include @@ -59,7 +57,7 @@ void *bcf_call_add_rg(void *_hash, const char *hdtext, const char *list) lp = r - p; for (r = q; *r && *r != '\t' && *r != '\n'; ++r) { } lq = r - q; - x = calloc((lp > lq? lp : lq) + 1, 1); + x = (char*) calloc((lp > lq? lp : lq) + 1, 1); for (r = q; *r && *r != '\t' && *r != '\n'; ++r) x[r-q] = *r; if (strstr(list, x)) { // insert ID to the hash table khint_t k; @@ -182,7 +180,7 @@ int bcf_call_gap_prep(int n, int *n_plp, bam_pileup1_t **plp, int pos, bcf_calla bca->max_support = bca->max_frac = 0; int m, n_alt = 0, n_tot = 0, indel_support_ok = 0; uint32_t *aux; - aux = calloc(N + 1, 4); + aux = (uint32_t*) calloc(N + 1, 4); m = max_rd_len = 0; aux[m++] = MINUS_CONST; // zero indel is always a type for (s = 0; s < n; ++s) { @@ -260,13 +258,13 @@ int bcf_call_gap_prep(int n, int *n_plp, bam_pileup1_t **plp, int pos, bcf_calla int L = right - left + 1, max_i, max2_i; uint32_t *cns, max, max2; char *ref0, *r; - ref_sample = calloc(n, sizeof(char*)); - cns = calloc(L, 4); - ref0 = calloc(L, 1); + ref_sample = (char**) calloc(n, sizeof(char*)); + cns = (uint32_t*) calloc(L, 4); + ref0 = (char*) calloc(L, 1); for (i = 0; i < right - left; ++i) ref0[i] = seq_nt16_table[(int)ref[i+left]]; for (s = 0; s < n; ++s) { - r = ref_sample[s] = calloc(L, 1); + r = ref_sample[s] = (char*) calloc(L, 1); memset(cns, 0, sizeof(int) * L); // collect ref and non-ref counts for (i = 0; i < n_plp[s]; ++i) { @@ -317,7 +315,7 @@ int bcf_call_gap_prep(int n, int *n_plp, bam_pileup1_t **plp, int pos, bcf_calla // construct the consensus sequence max_ins = types[n_types - 1]; // max_ins is at least 0 if (max_ins > 0) { - int *inscns_aux = calloc(5 * n_types * max_ins, sizeof(int)); + int *inscns_aux = (int*) calloc(5 * n_types * max_ins, sizeof(int)); // count the number of occurrences of each base at each position for each type of insertion for (t = 0; t < n_types; ++t) { if (types[t] > 0) { @@ -337,7 +335,7 @@ int bcf_call_gap_prep(int n, int *n_plp, bam_pileup1_t **plp, int pos, bcf_calla } } // use the majority rule to construct the consensus - inscns = calloc(n_types * max_ins, 1); + inscns = (char*) calloc(n_types * max_ins, 1); for (t = 0; t < n_types; ++t) { for (j = 0; j < types[t]; ++j) { int max = 0, max_k = -1, *ia = &inscns_aux[(t*max_ins+j)*5]; @@ -352,10 +350,10 @@ int bcf_call_gap_prep(int n, int *n_plp, bam_pileup1_t **plp, int pos, bcf_calla } // compute the likelihood given each type of indel for each read max_ref2 = right - left + 2 + 2 * (max_ins > -types[0]? max_ins : -types[0]); - ref2 = calloc(max_ref2, 1); - query = calloc(right - left + max_rd_len + max_ins + 2, 1); - score1 = calloc(N * n_types, sizeof(int)); - score2 = calloc(N * n_types, sizeof(int)); + ref2 = (char*) calloc(max_ref2, 1); + query = (char*) calloc(right - left + max_rd_len + max_ins + 2, 1); + score1 = (int*) calloc(N * n_types, sizeof(int)); + score2 = (int*) calloc(N * n_types, sizeof(int)); bca->indelreg = 0; for (t = 0; t < n_types; ++t) { int l, ir; @@ -404,7 +402,7 @@ int bcf_call_gap_prep(int n, int *n_plp, bam_pileup1_t **plp, int pos, bcf_calla { // do realignment; this is the bottleneck const uint8_t *qual = bam_get_qual(p->b), *bq; uint8_t *qq; - qq = calloc(qend - qbeg, 1); + qq = (uint8_t*) calloc(qend - qbeg, 1); bq = (uint8_t*)bam_aux_get(p->b, "ZQ"); if (bq) ++bq; // skip type for (l = qbeg; l < qend; ++l) { @@ -440,8 +438,8 @@ int bcf_call_gap_prep(int n, int *n_plp, bam_pileup1_t **plp, int pos, bcf_calla free(ref2); free(query); { // compute indelQ int *sc, tmp, *sumq; - sc = alloca(n_types * sizeof(int)); - sumq = alloca(n_types * sizeof(int)); + sc = (int*) alloca(n_types * sizeof(int)); + sumq = (int*) alloca(n_types * sizeof(int)); memset(sumq, 0, sizeof(int) * n_types); for (s = K = 0; s < n; ++s) { for (i = 0; i < n_plp[s]; ++i, ++K) { @@ -493,7 +491,7 @@ int bcf_call_gap_prep(int n, int *n_plp, bam_pileup1_t **plp, int pos, bcf_calla } // determine bca->indel_types[] and bca->inscns bca->maxins = max_ins; - bca->inscns = realloc(bca->inscns, bca->maxins * 4); + bca->inscns = (char*) realloc(bca->inscns, bca->maxins * 4); for (t = 0; t < n_types; ++t) sumq[t] = sumq[t]<<6 | t; for (t = 1; t < n_types; ++t) // insertion sort diff --git a/main.c b/main.c index 1892c1de5..2639d991b 100644 --- a/main.c +++ b/main.c @@ -54,6 +54,7 @@ int main_polysomy(int argc, char *argv[]); #endif int main_plugin(int argc, char *argv[]); int main_consensus(int argc, char *argv[]); +int bam_mpileup(int argc, char *argv[]); typedef struct { @@ -148,6 +149,10 @@ static cmd_t cmds[] = .alias = "gtcheck", .help = "check sample concordance, detect sample swaps and contamination" }, + { .func = bam_mpileup, + .alias = "mpileup", + .help = "multi-way pileup producing genotype likelihoods" + }, #if USE_GPL { .func = main_polysomy, .alias = "polysomy", diff --git a/mpileup.c b/mpileup.c index 1d47728b4..8bcca34ce 100644 --- a/mpileup.c +++ b/mpileup.c @@ -1,6 +1,6 @@ /* mpileup.c -- mpileup subcommand. Previously bam_plcmd.c from samtools - Copyright (C) 2008-2015 Genome Research Ltd. + Copyright (C) 2008-2016 Genome Research Ltd. Portions copyright (C) 2009-2012 Broad Institute. Author: Heng Li @@ -23,8 +23,6 @@ LIABILITY, WHETHER IN AN ACTION OF CONTRACT, TORT OR OTHERWISE, ARISING FROM, OUT OF OR IN CONNECTION WITH THE SOFTWARE OR THE USE OR OTHER DEALINGS IN THE SOFTWARE. */ -#include - #include #include #include @@ -39,9 +37,8 @@ DEALINGS IN THE SOFTWARE. */ #include #include #include -#include "sam_header.h" -#include "samtools.h" -#include "sam_opts.h" +#include +#include "bcftools.h" static inline int printw(int c, FILE *fp) { @@ -113,10 +110,6 @@ static inline void pileup_seq(FILE *fp, const bam_pileup1_t *p, int pos, int ref #define MPLP_PER_SAMPLE (1<<11) #define MPLP_SMART_OVERLAPS (1<<12) -void *bed_read(const char *fn); -void bed_destroy(void *_h); -int bed_overlap(const void *_h, const char *chr, int beg, int end); - typedef struct { int min_mq, flag, min_baseQ, capQ_thres, max_depth, max_indel_depth, fmt_flag; int rflag_require, rflag_filter; @@ -124,10 +117,10 @@ typedef struct { double min_frac; // for indels char *reg, *pl_list, *fai_fname, *output_fname; faidx_t *fai; - void *bed, *rghash; + void *rghash; + regidx_t *bed; int argc; char **argv; - sam_global_args ga; } mplp_conf_t; typedef struct { @@ -227,7 +220,7 @@ static int mplp_func(void *data, bam1_t *b) if (ma->conf->rflag_require && !(ma->conf->rflag_require&b->core.flag)) { skip = 1; continue; } if (ma->conf->rflag_filter && ma->conf->rflag_filter&b->core.flag) { skip = 1; continue; } if (ma->conf->bed) { // test overlap - skip = !bed_overlap(ma->conf->bed, ma->h->target_name[b->core.tid], b->core.pos, bam_endpos(b)); + skip = regidx_overlap(ma->conf->bed, ma->h->target_name[b->core.tid],b->core.pos, bam_endpos(b)-1, NULL) ? 0 : 1; if (skip) continue; } if (ma->conf->rghash) { // exclude read groups @@ -287,7 +280,7 @@ static void group_smpl(mplp_pileup_t *m, bam_sample_t *sm, kstring_t *buf, } if (m->n_plp[id] == m->m_plp[id]) { m->m_plp[id] = m->m_plp[id]? m->m_plp[id]<<1 : 8; - m->plp[id] = realloc(m->plp[id], sizeof(bam_pileup1_t) * m->m_plp[id]); + m->plp[id] = (bam_pileup1_t*) realloc(m->plp[id], sizeof(bam_pileup1_t) * m->m_plp[id]); } m->plp[id][m->n_plp[id]++] = *p; } @@ -327,9 +320,9 @@ static int mpileup(mplp_conf_t *conf, int n, char **fn) memset(&gplp, 0, sizeof(mplp_pileup_t)); memset(&buf, 0, sizeof(kstring_t)); memset(&bc, 0, sizeof(bcf_call_t)); - data = calloc(n, sizeof(mplp_aux_t*)); - plp = calloc(n, sizeof(bam_pileup1_t*)); - n_plp = calloc(n, sizeof(int)); + data = (mplp_aux_t**) calloc(n, sizeof(mplp_aux_t*)); + plp = (const bam_pileup1_t**) calloc(n, sizeof(bam_pileup1_t*)); + n_plp = (int*) calloc(n, sizeof(int)); sm = bam_smpl_init(); if (n == 0) { @@ -340,8 +333,8 @@ static int mpileup(mplp_conf_t *conf, int n, char **fn) // read the header of each file in the list and initialize data for (i = 0; i < n; ++i) { bam_hdr_t *h_tmp; - data[i] = calloc(1, sizeof(mplp_aux_t)); - data[i]->fp = sam_open_format(fn[i], "rb", &conf->ga.in); + data[i] = (mplp_aux_t*) calloc(1, sizeof(mplp_aux_t)); + data[i]->fp = sam_open(fn[i], "rb"); if ( !data[i]->fp ) { fprintf(stderr, "[%s] failed to open %s: %s\n", __func__, fn[i], strerror(errno)); @@ -394,9 +387,9 @@ static int mpileup(mplp_conf_t *conf, int n, char **fn) } // allocate data storage proportionate to number of samples being studied sm->n gplp.n = sm->n; - gplp.n_plp = calloc(sm->n, sizeof(int)); - gplp.m_plp = calloc(sm->n, sizeof(int)); - gplp.plp = calloc(sm->n, sizeof(bam_pileup1_t*)); + gplp.n_plp = (int*) calloc(sm->n, sizeof(int)); + gplp.m_plp = (int*) calloc(sm->n, sizeof(int)); + gplp.plp = (bam_pileup1_t**) calloc(sm->n, sizeof(bam_pileup1_t*)); fprintf(stderr, "[%s] %d samples in %d input files\n", __func__, sm->n, n); // write the VCF header @@ -418,11 +411,11 @@ static int mpileup(mplp_conf_t *conf, int n, char **fn) bcf_hdr = bcf_hdr_init("w"); kstring_t str = {0,0,NULL}; - ksprintf(&str, "##samtoolsVersion=%s+htslib-%s\n",samtools_version(),hts_version()); + ksprintf(&str, "##bcftoolsVersion=%s+htslib-%s\n",bcftools_version(),hts_version()); bcf_hdr_append(bcf_hdr, str.s); str.l = 0; - ksprintf(&str, "##samtoolsCommand=samtools mpileup"); + ksprintf(&str, "##bcftoolsCommand=mpileup"); for (i=1; iargc; i++) ksprintf(&str, " %s", conf->argv[i]); kputc('\n', &str); bcf_hdr_append(bcf_hdr, str.s); @@ -497,7 +490,7 @@ static int mpileup(mplp_conf_t *conf, int n, char **fn) // Initialise the calling algorithm bca = bcf_call_init(-1., conf->min_baseQ); - bcr = calloc(sm->n, sizeof(bcf_callret1_t)); + bcr = (bcf_callret1_t*) calloc(sm->n, sizeof(bcf_callret1_t)); bca->rghash = rghash; bca->openQ = conf->openQ, bca->extQ = conf->extQ, bca->tandemQ = conf->tandemQ; bca->min_frac = conf->min_frac; @@ -506,12 +499,12 @@ static int mpileup(mplp_conf_t *conf, int n, char **fn) bc.bcf_hdr = bcf_hdr; bc.n = sm->n; - bc.PL = malloc(15 * sm->n * sizeof(*bc.PL)); + bc.PL = (int32_t*) malloc(15 * sm->n * sizeof(*bc.PL)); if (conf->fmt_flag) { assert( sizeof(float)==sizeof(int32_t) ); - bc.DP4 = malloc(sm->n * sizeof(int32_t) * 4); - bc.fmt_arr = malloc(sm->n * sizeof(float)); // all fmt_flag fields + bc.DP4 = (int32_t*) malloc(sm->n * sizeof(int32_t) * 4); + bc.fmt_arr = (uint8_t*) malloc(sm->n * sizeof(float)); // all fmt_flag fields if ( conf->fmt_flag&(B2B_INFO_DPR|B2B_FMT_DPR|B2B_INFO_AD|B2B_INFO_ADF|B2B_INFO_ADR|B2B_FMT_AD|B2B_FMT_ADF|B2B_FMT_ADR) ) { // first B2B_MAX_ALLELES fields for total numbers, the rest per-sample @@ -551,7 +544,7 @@ static int mpileup(mplp_conf_t *conf, int n, char **fn) // begin pileup while ( (ret=bam_mplp_auto(iter, &tid, &pos, n_plp, plp)) > 0) { if (conf->reg && (pos < beg0 || pos >= end0)) continue; // out of the region requested - if (conf->bed && tid >= 0 && !bed_overlap(conf->bed, h->target_name[tid], pos, pos+1)) continue; + if (conf->bed && tid >= 0 && !regidx_overlap(conf->bed, h->target_name[tid], pos, pos, NULL)) continue; mplp_get_ref(data[0], tid, &ref, &ref_len); //printf("tid=%d len=%d ref=%p/%s\n", tid, ref_len, ref, ref); if (conf->flag & MPLP_BCF) { @@ -696,7 +689,7 @@ int read_file_list(const char *file_list,int *n,char **argv[]) return 1; } - files = calloc(nfiles,sizeof(char*)); + files = (char**) calloc(nfiles,sizeof(char*)); nfiles = 0; while ( fgets(buf,MAX_PATH_LEN,fh) ) { @@ -721,7 +714,7 @@ int read_file_list(const char *file_list,int *n,char **argv[]) } nfiles++; - files = realloc(files,nfiles*sizeof(char*)); + files = (char**) realloc(files,nfiles*sizeof(char*)); files[nfiles-1] = strdup(buf); } fclose(fh); @@ -776,7 +769,7 @@ static void print_usage(FILE *fp, const mplp_conf_t *mplp) fprintf(fp, "\n" -"Usage: samtools mpileup [options] in1.bam [in2.bam [...]]\n" +"Usage: bcftools mpileup [options] in1.bam [in2.bam [...]]\n" "\n" "Input options:\n" " -6, --illumina1.3+ quality is in the Illumina-1.3+ encoding\n" @@ -832,9 +825,7 @@ static void print_usage(FILE *fp, const mplp_conf_t *mplp) " -o, --open-prob INT Phred-scaled gap open seq error probability [%d]\n", mplp->openQ); fprintf(fp, " -p, --per-sample-mF apply -m and -F per-sample for increased sensitivity\n" -" -P, --platforms STR comma separated list of platforms for indels [all]\n"); - sam_global_opt_help(fp, "-.--."); - fprintf(fp, +" -P, --platforms STR comma separated list of platforms for indels [all]\n" "\n" "Notes: Assuming diploid individuals.\n"); @@ -859,11 +850,9 @@ int bam_mpileup(int argc, char *argv[]) mplp.argc = argc; mplp.argv = argv; mplp.rflag_filter = BAM_FUNMAP | BAM_FSECONDARY | BAM_FQCFAIL | BAM_FDUP; mplp.output_fname = NULL; - sam_global_args_init(&mplp.ga); static const struct option lopts[] = { - SAM_OPT_GLOBAL_OPTIONS('-', 0, '-', '-', 0), {"rf", required_argument, NULL, 1}, // require flag {"ff", required_argument, NULL, 2}, // filter flag {"incl-flags", required_argument, NULL, 1}, @@ -937,8 +926,8 @@ int bam_mpileup(int argc, char *argv[]) // In the original version the whole BAM was streamed which is inefficient // with few BED intervals and big BAMs. Todo: devise a heuristic to determine // best strategy, that is streaming or jumping. - mplp.bed = bed_read(optarg); - if (!mplp.bed) { print_error_errno("mpileup", "Could not read file \"%s\"", optarg); return 1; } + mplp.bed = regidx_init(optarg,NULL,NULL,0,NULL); + if (!mplp.bed) { fprintf(stderr, "bcftools mpileup: Could not read file \"%s\"", optarg); return 1; } break; case 'P': mplp.pl_list = strdup(optarg); break; case 'p': mplp.flag |= MPLP_PER_SAMPLE; break; @@ -946,9 +935,9 @@ int bam_mpileup(int argc, char *argv[]) case 'v': mplp.flag |= MPLP_BCF | MPLP_VCF; break; case 'u': mplp.flag |= MPLP_NO_COMP | MPLP_BCF; break; case 'B': mplp.flag &= ~MPLP_REALN; break; - case 'D': mplp.fmt_flag |= B2B_FMT_DP; fprintf(stderr, "[warning] samtools mpileup option `-D` is functional, but deprecated. Please switch to `-t DP` in future.\n"); break; - case 'S': mplp.fmt_flag |= B2B_FMT_SP; fprintf(stderr, "[warning] samtools mpileup option `-S` is functional, but deprecated. Please switch to `-t SP` in future.\n"); break; - case 'V': mplp.fmt_flag |= B2B_FMT_DV; fprintf(stderr, "[warning] samtools mpileup option `-V` is functional, but deprecated. Please switch to `-t DV` in future.\n"); break; + case 'D': mplp.fmt_flag |= B2B_FMT_DP; fprintf(stderr, "[warning] bcftools mpileup option `-D` is functional, but deprecated. Please switch to `-t DP` in future.\n"); break; + case 'S': mplp.fmt_flag |= B2B_FMT_SP; fprintf(stderr, "[warning] bcftools mpileup option `-S` is functional, but deprecated. Please switch to `-t SP` in future.\n"); break; + case 'V': mplp.fmt_flag |= B2B_FMT_DV; fprintf(stderr, "[warning] bcftools mpileup option `-V` is functional, but deprecated. Please switch to `-t DV` in future.\n"); break; case 'I': mplp.flag |= MPLP_NO_INDEL; break; case 'E': mplp.flag |= MPLP_REDO_BAQ; break; case '6': mplp.flag |= MPLP_ILLUMINA13; break; @@ -986,18 +975,10 @@ int bam_mpileup(int argc, char *argv[]) break; case 't': mplp.fmt_flag |= parse_format_flag(optarg); break; default: - if (parse_sam_global_opt(c, optarg, lopts, &mplp.ga) == 0) break; - /* else fall-through */ - case '?': - print_usage(stderr, &mplp); + fprintf(stderr,"Invalid option: '%c'\n", c); return 1; } } - if (!mplp.fai && mplp.ga.reference) { - mplp.fai_fname = mplp.ga.reference; - mplp.fai = fai_load(mplp.fai_fname); - if (mplp.fai == NULL) return 1; - } if ( !(mplp.flag&MPLP_REALN) && mplp.flag&MPLP_REDO_BAQ ) { @@ -1022,6 +1003,6 @@ int bam_mpileup(int argc, char *argv[]) if (mplp.rghash) khash_str2int_destroy_free(mplp.rghash); free(mplp.reg); free(mplp.pl_list); if (mplp.fai) fai_destroy(mplp.fai); - if (mplp.bed) bed_destroy(mplp.bed); + if (mplp.bed) regidx_destroy(mplp.bed); return ret; } diff --git a/sample.c b/sample.c index 4cc89ce9b..e48cf3a39 100644 --- a/sample.c +++ b/sample.c @@ -34,7 +34,7 @@ KHASH_MAP_INIT_STR(sm, int) bam_sample_t *bam_smpl_init(void) { bam_sample_t *s; - s = calloc(1, sizeof(bam_sample_t)); + s = (bam_sample_t*) calloc(1, sizeof(bam_sample_t)); s->rg2smid = kh_init(sm); s->sm2id = kh_init(sm); return s; @@ -50,8 +50,8 @@ void bam_smpl_destroy(bam_sample_t *sm) free(sm->smpl); for (k = kh_begin(rg2smid); k != kh_end(rg2smid); ++k) if (kh_exist(rg2smid, k)) free((char*)kh_key(rg2smid, k)); - kh_destroy(sm, sm->rg2smid); - kh_destroy(sm, sm->sm2id); + kh_destroy(sm, (khash_t(sm)*) sm->rg2smid); + kh_destroy(sm, (khash_t(sm)*) sm->sm2id); free(sm); } @@ -67,7 +67,7 @@ static void add_pair(bam_sample_t *sm, khash_t(sm) *sm2id, const char *key, cons if (k_sm == kh_end(sm2id)) { // absent if (sm->n == sm->m) { sm->m = sm->m? sm->m<<1 : 1; - sm->smpl = realloc(sm->smpl, sizeof(char*) * sm->m); + sm->smpl = (char**) realloc(sm->smpl, sizeof(char*) * sm->m); } sm->smpl[sm->n] = strdup(val); k_sm = kh_put(sm, sm2id, sm->smpl[sm->n], &ret); @@ -95,15 +95,15 @@ int bam_smpl_add(bam_sample_t *sm, const char *fn, const char *txt) if ((r = strstr(p, "\tSM:")) != 0) r += 4; if (r && q) { char *u, *v; - int oq, or; + int ioq, ior; for (u = (char*)q; *u && *u != '\t' && *u != '\n'; ++u); for (v = (char*)r; *v && *v != '\t' && *v != '\n'; ++v); - oq = *u; or = *v; *u = *v = '\0'; + ioq = *u; ior = *v; *u = *v = '\0'; buf.l = 0; kputs(fn, &buf); kputc('/', &buf); kputs(q, &buf); add_pair(sm, sm2id, buf.s, r); if ( !first_sm.s ) kputs(r,&first_sm); - *u = oq; *v = or; + *u = ioq; *v = ior; } else break; p = q > r? q : r; ++n; From b5c2093d822a1b47a862e710c0570c7008d7d840 Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Tue, 26 Apr 2016 12:31:08 +0100 Subject: [PATCH 192/211] remove mpileup text output * deprecate `-g -v -u` options (still functional, but with warning) * exit with message to use `samtools mpileup` if `-s/--output-MQ` used * `-O` option was `--output-BP` and is not `--output-type` for consistency with other bcftools commands. If `[buzv]` not given as an option will warn These catches for old text output options are probably not necessary as users may not expect text output from `bcftools mpileup`. --- mpileup.c | 416 ++++++++++++++++++++---------------------------------- 1 file changed, 156 insertions(+), 260 deletions(-) diff --git a/mpileup.c b/mpileup.c index 8bcca34ce..4e0883fc0 100644 --- a/mpileup.c +++ b/mpileup.c @@ -55,43 +55,6 @@ static inline int printw(int c, FILE *fp) return 0; } -static inline void pileup_seq(FILE *fp, const bam_pileup1_t *p, int pos, int ref_len, const char *ref) -{ - int j; - if (p->is_head) { - putc('^', fp); - putc(p->b->core.qual > 93? 126 : p->b->core.qual + 33, fp); - } - if (!p->is_del) { - int c = p->qpos < p->b->core.l_qseq - ? seq_nt16_str[bam_seqi(bam_get_seq(p->b), p->qpos)] - : 'N'; - if (ref) { - int rb = pos < ref_len? ref[pos] : 'N'; - if (c == '=' || seq_nt16_table[c] == seq_nt16_table[rb]) c = bam_is_rev(p->b)? ',' : '.'; - else c = bam_is_rev(p->b)? tolower(c) : toupper(c); - } else { - if (c == '=') c = bam_is_rev(p->b)? ',' : '.'; - else c = bam_is_rev(p->b)? tolower(c) : toupper(c); - } - putc(c, fp); - } else putc(p->is_refskip? (bam_is_rev(p->b)? '<' : '>') : '*', fp); - if (p->indel > 0) { - putc('+', fp); printw(p->indel, fp); - for (j = 1; j <= p->indel; ++j) { - int c = seq_nt16_str[bam_seqi(bam_get_seq(p->b), p->qpos + j)]; - putc(bam_is_rev(p->b)? tolower(c) : toupper(c), fp); - } - } else if (p->indel < 0) { - printw(p->indel, fp); - for (j = 1; j <= -p->indel; ++j) { - int c = (ref && (int)pos+j < ref_len)? ref[pos+j] : 'N'; - putc(bam_is_rev(p->b)? tolower(c) : toupper(c), fp); - } - } - if (p->is_tail) putc('$', fp); -} - #include #include "bam2bcf.h" #include "sample.h" @@ -112,7 +75,7 @@ static inline void pileup_seq(FILE *fp, const bam_pileup1_t *p, int pos, int ref typedef struct { int min_mq, flag, min_baseQ, capQ_thres, max_depth, max_indel_depth, fmt_flag; - int rflag_require, rflag_filter; + int rflag_require, rflag_filter, output_type; int openQ, extQ, tandemQ, min_support; // for indels double min_frac; // for indels char *reg, *pl_list, *fai_fname, *output_fname; @@ -305,7 +268,6 @@ static int mpileup(mplp_conf_t *conf, int n, char **fn) bam_hdr_t *h = NULL; /* header of first file in input list */ char *ref; void *rghash = NULL; - FILE *pileup_fp = NULL; bcf_callaux_t *bca = NULL; bcf_callret1_t *bcr = NULL; @@ -393,139 +355,122 @@ static int mpileup(mplp_conf_t *conf, int n, char **fn) fprintf(stderr, "[%s] %d samples in %d input files\n", __func__, sm->n, n); // write the VCF header - if (conf->flag & MPLP_BCF) - { - const char *mode; - if ( conf->flag & MPLP_VCF ) - mode = (conf->flag&MPLP_NO_COMP)? "wu" : "wz"; // uncompressed VCF or compressed VCF - else - mode = (conf->flag&MPLP_NO_COMP)? "wub" : "wb"; // uncompressed BCF or compressed BCF + bcf_fp = hts_open(conf->output_fname?conf->output_fname:"-", hts_bcf_wmode(conf->output_type)); + if (bcf_fp == NULL) { + fprintf(stderr, "[%s] failed to write to %s: %s\n", __func__, conf->output_fname? conf->output_fname : "standard output", strerror(errno)); + exit(EXIT_FAILURE); + } - bcf_fp = bcf_open(conf->output_fname? conf->output_fname : "-", mode); - if (bcf_fp == NULL) { - fprintf(stderr, "[%s] failed to write to %s: %s\n", __func__, conf->output_fname? conf->output_fname : "standard output", strerror(errno)); - exit(EXIT_FAILURE); - } + // BCF header creation + bcf_hdr = bcf_hdr_init("w"); + kstring_t str = {0,0,NULL}; - // BCF header creation - bcf_hdr = bcf_hdr_init("w"); - kstring_t str = {0,0,NULL}; + ksprintf(&str, "##bcftoolsVersion=%s+htslib-%s\n",bcftools_version(),hts_version()); + bcf_hdr_append(bcf_hdr, str.s); - ksprintf(&str, "##bcftoolsVersion=%s+htslib-%s\n",bcftools_version(),hts_version()); - bcf_hdr_append(bcf_hdr, str.s); + str.l = 0; + ksprintf(&str, "##bcftoolsCommand=mpileup"); + for (i=1; iargc; i++) ksprintf(&str, " %s", conf->argv[i]); + kputc('\n', &str); + bcf_hdr_append(bcf_hdr, str.s); + if (conf->fai_fname) + { str.l = 0; - ksprintf(&str, "##bcftoolsCommand=mpileup"); - for (i=1; iargc; i++) ksprintf(&str, " %s", conf->argv[i]); - kputc('\n', &str); + ksprintf(&str, "##reference=file://%s\n", conf->fai_fname); bcf_hdr_append(bcf_hdr, str.s); + } - if (conf->fai_fname) - { - str.l = 0; - ksprintf(&str, "##reference=file://%s\n", conf->fai_fname); - bcf_hdr_append(bcf_hdr, str.s); - } - - // Translate BAM @SQ tags to BCF ##contig tags - // todo: use/write new BAM header manipulation routines, fill also UR, M5 - for (i=0; in_targets; i++) - { - str.l = 0; - ksprintf(&str, "##contig=", h->target_name[i], h->target_len[i]); - bcf_hdr_append(bcf_hdr, str.s); - } - free(str.s); - bcf_hdr_append(bcf_hdr,"##ALT="); - bcf_hdr_append(bcf_hdr,"##INFO="); - bcf_hdr_append(bcf_hdr,"##INFO="); - bcf_hdr_append(bcf_hdr,"##INFO="); - bcf_hdr_append(bcf_hdr,"##INFO="); - bcf_hdr_append(bcf_hdr,"##INFO="); - bcf_hdr_append(bcf_hdr,"##INFO="); - bcf_hdr_append(bcf_hdr,"##INFO="); - bcf_hdr_append(bcf_hdr,"##INFO="); - bcf_hdr_append(bcf_hdr,"##INFO="); + // Translate BAM @SQ tags to BCF ##contig tags + // todo: use/write new BAM header manipulation routines, fill also UR, M5 + for (i=0; in_targets; i++) + { + str.l = 0; + ksprintf(&str, "##contig=", h->target_name[i], h->target_len[i]); + bcf_hdr_append(bcf_hdr, str.s); + } + free(str.s); + bcf_hdr_append(bcf_hdr,"##ALT="); + bcf_hdr_append(bcf_hdr,"##INFO="); + bcf_hdr_append(bcf_hdr,"##INFO="); + bcf_hdr_append(bcf_hdr,"##INFO="); + bcf_hdr_append(bcf_hdr,"##INFO="); + bcf_hdr_append(bcf_hdr,"##INFO="); + bcf_hdr_append(bcf_hdr,"##INFO="); + bcf_hdr_append(bcf_hdr,"##INFO="); + bcf_hdr_append(bcf_hdr,"##INFO="); + bcf_hdr_append(bcf_hdr,"##INFO="); #if CDF_MWU_TESTS - bcf_hdr_append(bcf_hdr,"##INFO="); - bcf_hdr_append(bcf_hdr,"##INFO="); - bcf_hdr_append(bcf_hdr,"##INFO="); - bcf_hdr_append(bcf_hdr,"##INFO="); + bcf_hdr_append(bcf_hdr,"##INFO="); + bcf_hdr_append(bcf_hdr,"##INFO="); + bcf_hdr_append(bcf_hdr,"##INFO="); + bcf_hdr_append(bcf_hdr,"##INFO="); #endif - bcf_hdr_append(bcf_hdr,"##INFO="); - bcf_hdr_append(bcf_hdr,"##INFO="); - bcf_hdr_append(bcf_hdr,"##INFO="); - bcf_hdr_append(bcf_hdr,"##INFO="); - bcf_hdr_append(bcf_hdr,"##FORMAT="); - if ( conf->fmt_flag&B2B_FMT_DP ) - bcf_hdr_append(bcf_hdr,"##FORMAT="); - if ( conf->fmt_flag&B2B_FMT_DV ) - bcf_hdr_append(bcf_hdr,"##FORMAT="); - if ( conf->fmt_flag&B2B_FMT_DPR ) - bcf_hdr_append(bcf_hdr,"##FORMAT="); - if ( conf->fmt_flag&B2B_INFO_DPR ) - bcf_hdr_append(bcf_hdr,"##INFO="); - if ( conf->fmt_flag&B2B_FMT_DP4 ) - bcf_hdr_append(bcf_hdr,"##FORMAT="); - if ( conf->fmt_flag&B2B_FMT_SP ) - bcf_hdr_append(bcf_hdr,"##FORMAT="); - if ( conf->fmt_flag&B2B_FMT_AD ) - bcf_hdr_append(bcf_hdr,"##FORMAT="); - if ( conf->fmt_flag&B2B_FMT_ADF ) - bcf_hdr_append(bcf_hdr,"##FORMAT="); - if ( conf->fmt_flag&B2B_FMT_ADR ) - bcf_hdr_append(bcf_hdr,"##FORMAT="); - if ( conf->fmt_flag&B2B_INFO_AD ) - bcf_hdr_append(bcf_hdr,"##INFO="); - if ( conf->fmt_flag&B2B_INFO_ADF ) - bcf_hdr_append(bcf_hdr,"##INFO="); - if ( conf->fmt_flag&B2B_INFO_ADR ) - bcf_hdr_append(bcf_hdr,"##INFO="); - - for (i=0; in; i++) - bcf_hdr_add_sample(bcf_hdr, sm->smpl[i]); - bcf_hdr_add_sample(bcf_hdr, NULL); - bcf_hdr_write(bcf_fp, bcf_hdr); - // End of BCF header creation - - // Initialise the calling algorithm - bca = bcf_call_init(-1., conf->min_baseQ); - bcr = (bcf_callret1_t*) calloc(sm->n, sizeof(bcf_callret1_t)); - bca->rghash = rghash; - bca->openQ = conf->openQ, bca->extQ = conf->extQ, bca->tandemQ = conf->tandemQ; - bca->min_frac = conf->min_frac; - bca->min_support = conf->min_support; - bca->per_sample_flt = conf->flag & MPLP_PER_SAMPLE; - - bc.bcf_hdr = bcf_hdr; - bc.n = sm->n; - bc.PL = (int32_t*) malloc(15 * sm->n * sizeof(*bc.PL)); - if (conf->fmt_flag) + bcf_hdr_append(bcf_hdr,"##INFO="); + bcf_hdr_append(bcf_hdr,"##INFO="); + bcf_hdr_append(bcf_hdr,"##INFO="); + bcf_hdr_append(bcf_hdr,"##INFO="); + bcf_hdr_append(bcf_hdr,"##FORMAT="); + if ( conf->fmt_flag&B2B_FMT_DP ) + bcf_hdr_append(bcf_hdr,"##FORMAT="); + if ( conf->fmt_flag&B2B_FMT_DV ) + bcf_hdr_append(bcf_hdr,"##FORMAT="); + if ( conf->fmt_flag&B2B_FMT_DPR ) + bcf_hdr_append(bcf_hdr,"##FORMAT="); + if ( conf->fmt_flag&B2B_INFO_DPR ) + bcf_hdr_append(bcf_hdr,"##INFO="); + if ( conf->fmt_flag&B2B_FMT_DP4 ) + bcf_hdr_append(bcf_hdr,"##FORMAT="); + if ( conf->fmt_flag&B2B_FMT_SP ) + bcf_hdr_append(bcf_hdr,"##FORMAT="); + if ( conf->fmt_flag&B2B_FMT_AD ) + bcf_hdr_append(bcf_hdr,"##FORMAT="); + if ( conf->fmt_flag&B2B_FMT_ADF ) + bcf_hdr_append(bcf_hdr,"##FORMAT="); + if ( conf->fmt_flag&B2B_FMT_ADR ) + bcf_hdr_append(bcf_hdr,"##FORMAT="); + if ( conf->fmt_flag&B2B_INFO_AD ) + bcf_hdr_append(bcf_hdr,"##INFO="); + if ( conf->fmt_flag&B2B_INFO_ADF ) + bcf_hdr_append(bcf_hdr,"##INFO="); + if ( conf->fmt_flag&B2B_INFO_ADR ) + bcf_hdr_append(bcf_hdr,"##INFO="); + + for (i=0; in; i++) + bcf_hdr_add_sample(bcf_hdr, sm->smpl[i]); + bcf_hdr_add_sample(bcf_hdr, NULL); + bcf_hdr_write(bcf_fp, bcf_hdr); + // End of BCF header creation + + // Initialise the calling algorithm + bca = bcf_call_init(-1., conf->min_baseQ); + bcr = (bcf_callret1_t*) calloc(sm->n, sizeof(bcf_callret1_t)); + bca->rghash = rghash; + bca->openQ = conf->openQ, bca->extQ = conf->extQ, bca->tandemQ = conf->tandemQ; + bca->min_frac = conf->min_frac; + bca->min_support = conf->min_support; + bca->per_sample_flt = conf->flag & MPLP_PER_SAMPLE; + + bc.bcf_hdr = bcf_hdr; + bc.n = sm->n; + bc.PL = (int32_t*) malloc(15 * sm->n * sizeof(*bc.PL)); + if (conf->fmt_flag) + { + assert( sizeof(float)==sizeof(int32_t) ); + bc.DP4 = (int32_t*) malloc(sm->n * sizeof(int32_t) * 4); + bc.fmt_arr = (uint8_t*) malloc(sm->n * sizeof(float)); // all fmt_flag fields + if ( conf->fmt_flag&(B2B_INFO_DPR|B2B_FMT_DPR|B2B_INFO_AD|B2B_INFO_ADF|B2B_INFO_ADR|B2B_FMT_AD|B2B_FMT_ADF|B2B_FMT_ADR) ) { - assert( sizeof(float)==sizeof(int32_t) ); - bc.DP4 = (int32_t*) malloc(sm->n * sizeof(int32_t) * 4); - bc.fmt_arr = (uint8_t*) malloc(sm->n * sizeof(float)); // all fmt_flag fields - if ( conf->fmt_flag&(B2B_INFO_DPR|B2B_FMT_DPR|B2B_INFO_AD|B2B_INFO_ADF|B2B_INFO_ADR|B2B_FMT_AD|B2B_FMT_ADF|B2B_FMT_ADR) ) + // first B2B_MAX_ALLELES fields for total numbers, the rest per-sample + bc.ADR = (int32_t*) malloc((sm->n+1)*B2B_MAX_ALLELES*sizeof(int32_t)); + bc.ADF = (int32_t*) malloc((sm->n+1)*B2B_MAX_ALLELES*sizeof(int32_t)); + for (i=0; in; i++) { - // first B2B_MAX_ALLELES fields for total numbers, the rest per-sample - bc.ADR = (int32_t*) malloc((sm->n+1)*B2B_MAX_ALLELES*sizeof(int32_t)); - bc.ADF = (int32_t*) malloc((sm->n+1)*B2B_MAX_ALLELES*sizeof(int32_t)); - for (i=0; in; i++) - { - bcr[i].ADR = bc.ADR + (i+1)*B2B_MAX_ALLELES; - bcr[i].ADF = bc.ADF + (i+1)*B2B_MAX_ALLELES; - } + bcr[i].ADR = bc.ADR + (i+1)*B2B_MAX_ALLELES; + bcr[i].ADF = bc.ADF + (i+1)*B2B_MAX_ALLELES; } } } - else { - pileup_fp = conf->output_fname? fopen(conf->output_fname, "w") : stdout; - - if (pileup_fp == NULL) { - fprintf(stderr, "[%s] failed to write to %s: %s\n", __func__, conf->output_fname, strerror(errno)); - exit(EXIT_FAILURE); - } - } // init pileup iter = bam_mplp_init(n, mplp_func, (void**)data); @@ -547,94 +492,30 @@ static int mpileup(mplp_conf_t *conf, int n, char **fn) if (conf->bed && tid >= 0 && !regidx_overlap(conf->bed, h->target_name[tid], pos, pos, NULL)) continue; mplp_get_ref(data[0], tid, &ref, &ref_len); //printf("tid=%d len=%d ref=%p/%s\n", tid, ref_len, ref, ref); - if (conf->flag & MPLP_BCF) { - int total_depth, _ref0, ref16; - for (i = total_depth = 0; i < n; ++i) total_depth += n_plp[i]; - group_smpl(&gplp, sm, &buf, n, fn, n_plp, plp, conf->flag & MPLP_IGNORE_RG); - _ref0 = (ref && pos < ref_len)? ref[pos] : 'N'; - ref16 = seq_nt16_table[_ref0]; + int total_depth, _ref0, ref16; + for (i = total_depth = 0; i < n; ++i) total_depth += n_plp[i]; + group_smpl(&gplp, sm, &buf, n, fn, n_plp, plp, conf->flag & MPLP_IGNORE_RG); + _ref0 = (ref && pos < ref_len)? ref[pos] : 'N'; + ref16 = seq_nt16_table[_ref0]; + bcf_callaux_clean(bca, &bc); + for (i = 0; i < gplp.n; ++i) + bcf_call_glfgen(gplp.n_plp[i], gplp.plp[i], ref16, bca, bcr + i); + bc.tid = tid; bc.pos = pos; + bcf_call_combine(gplp.n, bcr, bca, ref16, &bc); + bcf_clear1(bcf_rec); + bcf_call2bcf(&bc, bcf_rec, bcr, conf->fmt_flag, 0, 0); + bcf_write1(bcf_fp, bcf_hdr, bcf_rec); + // call indels; todo: subsampling with total_depth>max_indel_depth instead of ignoring? + if (!(conf->flag&MPLP_NO_INDEL) && total_depth < max_indel_depth && bcf_call_gap_prep(gplp.n, gplp.n_plp, gplp.plp, pos, bca, ref, rghash) >= 0) + { bcf_callaux_clean(bca, &bc); for (i = 0; i < gplp.n; ++i) - bcf_call_glfgen(gplp.n_plp[i], gplp.plp[i], ref16, bca, bcr + i); - bc.tid = tid; bc.pos = pos; - bcf_call_combine(gplp.n, bcr, bca, ref16, &bc); - bcf_clear1(bcf_rec); - bcf_call2bcf(&bc, bcf_rec, bcr, conf->fmt_flag, 0, 0); - bcf_write1(bcf_fp, bcf_hdr, bcf_rec); - // call indels; todo: subsampling with total_depth>max_indel_depth instead of ignoring? - if (!(conf->flag&MPLP_NO_INDEL) && total_depth < max_indel_depth && bcf_call_gap_prep(gplp.n, gplp.n_plp, gplp.plp, pos, bca, ref, rghash) >= 0) - { - bcf_callaux_clean(bca, &bc); - for (i = 0; i < gplp.n; ++i) - bcf_call_glfgen(gplp.n_plp[i], gplp.plp[i], -1, bca, bcr + i); - if (bcf_call_combine(gplp.n, bcr, bca, -1, &bc) >= 0) { - bcf_clear1(bcf_rec); - bcf_call2bcf(&bc, bcf_rec, bcr, conf->fmt_flag, bca, ref); - bcf_write1(bcf_fp, bcf_hdr, bcf_rec); - } + bcf_call_glfgen(gplp.n_plp[i], gplp.plp[i], -1, bca, bcr + i); + if (bcf_call_combine(gplp.n, bcr, bca, -1, &bc) >= 0) { + bcf_clear1(bcf_rec); + bcf_call2bcf(&bc, bcf_rec, bcr, conf->fmt_flag, bca, ref); + bcf_write1(bcf_fp, bcf_hdr, bcf_rec); } - } else { - fprintf(pileup_fp, "%s\t%d\t%c", h->target_name[tid], pos + 1, (ref && pos < ref_len)? ref[pos] : 'N'); - for (i = 0; i < n; ++i) { - int j, cnt; - for (j = cnt = 0; j < n_plp[i]; ++j) { - const bam_pileup1_t *p = plp[i] + j; - int c = p->qpos < p->b->core.l_qseq - ? bam_get_qual(p->b)[p->qpos] - : 0; - if (c >= conf->min_baseQ) ++cnt; - } - fprintf(pileup_fp, "\t%d\t", cnt); - if (n_plp[i] == 0) { - fputs("*\t*", pileup_fp); - if (conf->flag & MPLP_PRINT_MAPQ) fputs("\t*", pileup_fp); - if (conf->flag & MPLP_PRINT_POS) fputs("\t*", pileup_fp); - } else { - for (j = 0; j < n_plp[i]; ++j) { - const bam_pileup1_t *p = plp[i] + j; - int c = p->qpos < p->b->core.l_qseq - ? bam_get_qual(p->b)[p->qpos] - : 0; - if (c >= conf->min_baseQ) - pileup_seq(pileup_fp, plp[i] + j, pos, ref_len, ref); - } - putc('\t', pileup_fp); - for (j = 0; j < n_plp[i]; ++j) { - const bam_pileup1_t *p = plp[i] + j; - int c = p->qpos < p->b->core.l_qseq - ? bam_get_qual(p->b)[p->qpos] - : 0; - if (c >= conf->min_baseQ) { - c = c + 33 < 126? c + 33 : 126; - putc(c, pileup_fp); - } - } - if (conf->flag & MPLP_PRINT_MAPQ) { - putc('\t', pileup_fp); - for (j = 0; j < n_plp[i]; ++j) { - const bam_pileup1_t *p = plp[i] + j; - int c = bam_get_qual(p->b)[p->qpos]; - if ( c < conf->min_baseQ ) continue; - c = plp[i][j].b->core.qual + 33; - if (c > 126) c = 126; - putc(c, pileup_fp); - } - } - if (conf->flag & MPLP_PRINT_POS) { - putc('\t', pileup_fp); - int last = 0; - for (j = 0; j < n_plp[i]; ++j) { - const bam_pileup1_t *p = plp[i] + j; - int c = bam_get_qual(p->b)[p->qpos]; - if ( c < conf->min_baseQ ) continue; - - if (last++) putc(',', pileup_fp); - fprintf(pileup_fp, "%d", plp[i][j].qpos + 1); // FIXME: printf() is very slow... - } - } - } - } - putc('\n', pileup_fp); } } @@ -653,7 +534,6 @@ static int mpileup(mplp_conf_t *conf, int n, char **fn) free(bc.fmt_arr); free(bcr); } - if (pileup_fp && conf->output_fname) fclose(pileup_fp); bam_smpl_destroy(sm); free(buf.s); for (i = 0; i < gplp.n; ++i) free(gplp.plp[i]); free(gplp.plp); free(gplp.n_plp); free(gplp.m_plp); @@ -798,19 +678,12 @@ static void print_usage(FILE *fp, const mplp_conf_t *mplp) "\n" "Output options:\n" " -o, --output FILE write output to FILE [standard output]\n" -" -g, --BCF generate genotype likelihoods in BCF format\n" -" -v, --VCF generate genotype likelihoods in VCF format\n" -"\n" -"Output options for mpileup format (without -g/-v):\n" -" -O, --output-BP output base positions on reads\n" -" -s, --output-MQ output mapping quality\n" -"\n" -"Output options for genotype likelihoods (when -g/-v is used):\n" +" -O, --output-type TYPE 'b' compressed BCF; 'u' uncompressed BCF;\n" +" 'z' compressed VCF; 'v' uncompressed VCF [v]\n" " -t, --output-tags LIST optional tags to output:\n" " DP,AD,ADF,ADR,SP,INFO/AD,INFO/ADF,INFO/ADR []\n" -" -u, --uncompressed generate uncompressed VCF/BCF output\n" "\n" -"SNP/INDEL genotype likelihoods options (effective with -g/-v):\n" +"SNP/INDEL genotype likelihoods options:\n" " -e, --ext-prob INT Phred-scaled gap extension seq error probability [%d]\n", mplp->extQ); fprintf(fp, " -F, --gap-frac FLOAT minimum fraction of gapped reads [%g]\n", mplp->min_frac); @@ -850,6 +723,7 @@ int bam_mpileup(int argc, char *argv[]) mplp.argc = argc; mplp.argv = argv; mplp.rflag_filter = BAM_FUNMAP | BAM_FSECONDARY | BAM_FQCFAIL | BAM_FDUP; mplp.output_fname = NULL; + mplp.output_type = FT_VCF; static const struct option lopts[] = { @@ -885,6 +759,7 @@ int bam_mpileup(int argc, char *argv[]) {"bcf", no_argument, NULL, 'g'}, {"VCF", no_argument, NULL, 'v'}, {"vcf", no_argument, NULL, 'v'}, + {"output-type", required_argument, NULL, 'O'}, {"output-BP", no_argument, NULL, 'O'}, {"output-bp", no_argument, NULL, 'O'}, {"output-MQ", no_argument, NULL, 's'}, @@ -902,7 +777,7 @@ int bam_mpileup(int argc, char *argv[]) {"platforms", required_argument, NULL, 'P'}, {NULL, 0, NULL, 0} }; - while ((c = getopt_long(argc, argv, "Agf:r:l:q:Q:uRC:BDSd:L:b:P:po:e:h:Im:F:EG:6OsVvxt:",lopts,NULL)) >= 0) { + while ((c = getopt_long(argc, argv, "Agf:r:l:q:Q:uRC:BDSd:L:b:P:po:e:h:Im:F:EG:6O:sVvxt:",lopts,NULL)) >= 0) { switch (c) { case 'x': mplp.flag &= ~MPLP_SMART_OVERLAPS; break; case 1 : @@ -931,9 +806,9 @@ int bam_mpileup(int argc, char *argv[]) break; case 'P': mplp.pl_list = strdup(optarg); break; case 'p': mplp.flag |= MPLP_PER_SAMPLE; break; - case 'g': mplp.flag |= MPLP_BCF; break; - case 'v': mplp.flag |= MPLP_BCF | MPLP_VCF; break; - case 'u': mplp.flag |= MPLP_NO_COMP | MPLP_BCF; break; + case 'g': fprintf(stderr,"[warning] bcftools mpileup `-g` is functional, but deprecated. Please swith to -O in future.\n"); mplp.flag |= MPLP_BCF; break; + case 'v': fprintf(stderr,"[warning] bcftools mpileup `-v` is functional, but deprecated. Please swith to -O in future.\n"); mplp.flag |= MPLP_BCF | MPLP_VCF; break; + case 'u': fprintf(stderr,"[warning] bcftools mpileup `-u` is functional, but deprecated. Please swith to -O in future.\n"); mplp.flag |= MPLP_NO_COMP | MPLP_BCF; break; case 'B': mplp.flag &= ~MPLP_REALN; break; case 'D': mplp.fmt_flag |= B2B_FMT_DP; fprintf(stderr, "[warning] bcftools mpileup option `-D` is functional, but deprecated. Please switch to `-t DP` in future.\n"); break; case 'S': mplp.fmt_flag |= B2B_FMT_SP; fprintf(stderr, "[warning] bcftools mpileup option `-S` is functional, but deprecated. Please switch to `-t SP` in future.\n"); break; @@ -942,8 +817,16 @@ int bam_mpileup(int argc, char *argv[]) case 'E': mplp.flag |= MPLP_REDO_BAQ; break; case '6': mplp.flag |= MPLP_ILLUMINA13; break; case 'R': mplp.flag |= MPLP_IGNORE_RG; break; - case 's': mplp.flag |= MPLP_PRINT_MAPQ; break; - case 'O': mplp.flag |= MPLP_PRINT_POS; break; + case 's': error("The -s option is for text based mpileup output. Please use \"samtools mpileup -s\" instead.\n"); break; + case 'O': + switch (optarg[0]) { + case 'b': mplp.output_type = FT_BCF_GZ; break; + case 'u': mplp.output_type = FT_BCF; break; + case 'z': mplp.output_type = FT_VCF_GZ; break; + case 'v': mplp.output_type = FT_VCF; break; + default: error("[error] The option \"-O\" changed meaning when mpileup moved to bcftools. Did you mean: \"bcftools mpileup --output-type\" or \"samtools mpileup --output-BP\"?\n", optarg); + } + break; case 'C': mplp.capQ_thres = atoi(optarg); break; case 'q': mplp.min_mq = atoi(optarg); break; case 'Q': mplp.min_baseQ = atoi(optarg); break; @@ -980,6 +863,19 @@ int bam_mpileup(int argc, char *argv[]) } } + if ( mplp.flag&(MPLP_BCF|MPLP_VCF|MPLP_NO_COMP) ) + { + if ( mplp.flag&MPLP_VCF ) + { + if ( mplp.flag&MPLP_NO_COMP ) mplp.output_type = FT_VCF; + else mplp.output_type = FT_VCF_GZ; + } + else if ( mplp.flag&MPLP_BCF ) + { + if ( mplp.flag&MPLP_NO_COMP ) mplp.output_type = FT_BCF; + else mplp.output_type = FT_BCF_GZ; + } + } if ( !(mplp.flag&MPLP_REALN) && mplp.flag&MPLP_REDO_BAQ ) { fprintf(stderr,"Error: The -B option cannot be combined with -E\n"); From 303cc365e2d450119a3453c2e0f11255d0e52817 Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Tue, 26 Apr 2016 13:59:05 +0100 Subject: [PATCH 193/211] import mpileup tests from samtools * mpileup.1.out, mpileup.2.out, mpileup.3.out and mpileup.4.out are from samtools with mpileup.1.out and mpileup.3.out converted from the text output * mpileup.5.out a new test with the newer AD, etc annotations * sam/bam/cram test files all stored. perhaps there is some way to store one version and convert within the test ala the vcf-miniview in samtools? --- test/mpileup/mpileup.1.bam | Bin 0 -> 67789 bytes test/mpileup/mpileup.1.bam.bai | Bin 0 -> 96 bytes test/mpileup/mpileup.1.cram | Bin 0 -> 49113 bytes test/mpileup/mpileup.1.cram.crai | Bin 0 -> 42 bytes test/mpileup/mpileup.1.out | 70 ++ test/mpileup/mpileup.1.sam | 1016 ++++++++++++++++++++++++++++++ test/mpileup/mpileup.2.bam | Bin 0 -> 27928 bytes test/mpileup/mpileup.2.bam.bai | Bin 0 -> 96 bytes test/mpileup/mpileup.2.cram | Bin 0 -> 20072 bytes test/mpileup/mpileup.2.cram.crai | Bin 0 -> 45 bytes test/mpileup/mpileup.2.out | 523 +++++++++++++++ test/mpileup/mpileup.2.sam | 248 ++++++++ test/mpileup/mpileup.3.bam | Bin 0 -> 27569 bytes test/mpileup/mpileup.3.bam.bai | Bin 0 -> 96 bytes test/mpileup/mpileup.3.cram | Bin 0 -> 19643 bytes test/mpileup/mpileup.3.cram.crai | Bin 0 -> 43 bytes test/mpileup/mpileup.3.out | 30 + test/mpileup/mpileup.3.sam | 250 ++++++++ test/mpileup/mpileup.4.out | 527 ++++++++++++++++ test/mpileup/mpileup.5.out | 529 ++++++++++++++++ test/mpileup/mpileup.ref.fa | 71 +++ test/mpileup/mpileup.ref.fa.fai | 1 + test/test.pl | 19 + 23 files changed, 3284 insertions(+) create mode 100644 test/mpileup/mpileup.1.bam create mode 100644 test/mpileup/mpileup.1.bam.bai create mode 100644 test/mpileup/mpileup.1.cram create mode 100644 test/mpileup/mpileup.1.cram.crai create mode 100644 test/mpileup/mpileup.1.out create mode 100644 test/mpileup/mpileup.1.sam create mode 100644 test/mpileup/mpileup.2.bam create mode 100644 test/mpileup/mpileup.2.bam.bai create mode 100644 test/mpileup/mpileup.2.cram create mode 100644 test/mpileup/mpileup.2.cram.crai create mode 100644 test/mpileup/mpileup.2.out create mode 100644 test/mpileup/mpileup.2.sam create mode 100644 test/mpileup/mpileup.3.bam create mode 100644 test/mpileup/mpileup.3.bam.bai create mode 100644 test/mpileup/mpileup.3.cram create mode 100644 test/mpileup/mpileup.3.cram.crai create mode 100644 test/mpileup/mpileup.3.out create mode 100644 test/mpileup/mpileup.3.sam create mode 100644 test/mpileup/mpileup.4.out create mode 100644 test/mpileup/mpileup.5.out create mode 100644 test/mpileup/mpileup.ref.fa create mode 100644 test/mpileup/mpileup.ref.fa.fai diff --git a/test/mpileup/mpileup.1.bam b/test/mpileup/mpileup.1.bam new file mode 100644 index 0000000000000000000000000000000000000000..e95bc3a6825eac324fa406f24c037728b2858010 GIT binary patch literal 67789 zcma&M18}5U6z`j4VtZoSHYT=h+qP|^lZkCx6Wg{mv7Nk}bMC$M-o3A0y{_(W?X`aY zwf6d|x~hBc{ozMJf&%^X`T_?M6aoQ)gt^e^bzB!k-oyda{1H%*fR|@r1{FtC(Mm0f zsfrY)%x7EutqufLW}cKQBdDmI;?28M(lDCMd14}l3Xvr1z&hh>@d6G6o;gPq@i4EVrQO|Y!_{Ys> z9PpgVZ4mwNdbx1OOJ^I1z5CeavhN%#8nk<}t~7fVO$Tvxh3|&wm{N9SwiCM_x(RjF6&4e8OiOC)LmeAv zww4ohw7Xo7FcU01QZX(f33b`Ub-D?RV$pj65L0gV0bjut{jhxmK0& zKr#~?Tgb^6)Fi*=nFF3+#iMs=1tJ(H?11)!I2c2p5Yf^98K{c;S6RSbVG_^`gxMRy zIzdtSLRuMyJ|oIT8zB4tXXM`zmtMJ6(XaA7QZdd73{qEi%q2t&3mBwzrWyLr_aw>( zFtQ6Jqjz~{ZN}-|xl;Vh>Dh+@A^dovig)p|#tmMDG~H|AFNBu0>js82JSSH=dl`I) z-NTm=hI*+wq0|gmpoZB$xgK-YZjWb=_Kvf<#>dH@;xXlX`x*GLC)g&i_w_HPhu9lD zp7+RxdWX)B220qr-=fS~UdO>!FA|^ppy$=oYiawnN!i@V1?DJev9-P&iWubO_v`=kFHre=%OEOC;uD#v1&G2K0wkoT@FEV zpR9%l9W`BY96&SG0mJf0t`y=i>f2bO&gE5dV%1 zvN`2wL#I!>dzfl#%9AjzVc0eDP*vo#;5o zqW|@37C1roS`&FXowu4=N4i5okH`}z;)2QZduKJ}+2k5B(5z*bAgDy@`n;Ln_<99& z+Ll=qJWlA_4K=>Lhs@p-O@Ynk>up$POX}T6=2<1nR{p68D&Jf}0T!O@6mR1o2~2c> zW6WKx=r7I-u?k*`N-#Gq(2P$D7LMv1Zxbg4OazB(-0|>@MIbcp{J-(6z|uIuceZnU zlj;c2USVNS<-8CyBIPN86;A?)uq4;Wt9~I+LLz*9GY;jif3TGJe^@i|U+h`>A5NwF z5BE#|huxEaNyH@}G`_M>2^8l9mf-*C(K+6Q{JTd|T;s{a?&bDrMllgq!Rh7gF*XqSK(l~r_$`~EJtY|JE)yE zGAVO|)sEJ0Z~NLJat-2ZiyfYCgMKLDrOCkeT5ZV5DeP3_Zmkvi(UT5TCyEw%+7 z<7jbQ9+?8(HM_b6H66d;P{otAVsqZEH?a`AIU19!swzgn2}qN-d<}cBd;p0qgh90PF+k_t&XyQ zrj({u3H2ITaYnrb>NB|bfMyriy@v%>L3To2U0vgja*w9Atk(H|DE_`ivJ2=rxcCfa z=GL^fckju}s0r%mMSQ2_Ro4ik+^5JdtK~zzN}5|ku?grwx%iM~zi$h}s;I-TvF z!ejHMPc%fK^mCnK9T@^T_1}3qpKUm>^kAob*(XLFZ!FNNmqSg`kDQwygFIT>ZjO2o zGelaj2#($OQtqXYW-@*qTUI8j(t>EBoM=0!&5?@!vI5DfppwE`fHarMbvm?`u)_ha zf^x2orL!0(&SedlLc1o#4FGK z*9-ZS8k`bJa$BtDhLVO;WL4S(VWkq~v&=TbS*j<7&-JXcl^R$ONuJsNBZ#EX8UIH> zmCqvG@-3(jpR3qpD!tR{ALkl_veYRxSS6AS^IXpbwARceaHgfj?{-&-#)LJ#+x-^wTf+r;Cgx(3 z`)$2d0Pw@wlpLWO3H-f&dpiB*Ebzai`u%*DGv{ae6M=nsNQwUuf&A=Ej6|$qVTbtl z*?m~g%x~<$MpTW?BQ2DCth0* zo)_H9kKwmX?w(J&kT1S0_ut)8h_A_m^s8 z1Q&%%+i5AZ3x))x0z?rVdzVTcJn<;$-`s`6;&G}41CmK$+~oF+NlmoB49(UNT=tUL z9d8xMNk-NnC?5K^%6CS|Gk0iCS&OoMX>4SjL3T1r(%sjH&KitPDR5TPq ztN-Srp(iui{gc~Nj8(U|Y}fVQy3jCVtvvtM4FNL&%K5i$Um(+*+`n}V z1UO0j|3}R694G;Tl>Q6!M-jZ+|0*a(jQCIUD(dp^S_HR$4pgvV^P$Hp64lE30v!oJ z|3~G+aH#(|TOQi~?7)a2{GYr1?h3*R(IfJ}M({US#lh|K-O`DBmL@Gv=l-Ao{vu|F ztQ>mVSSNs%nA3uar;CS)6z2A{jFP*VB`#_7N9FSh>?k2NsOD+_TH-z}WMh2+5ebA8 zqPa;Ji+HRv!OU2!SUgVguiO+|X#&n6|6kPH$iE!@fdW+7qUkX=$!Erfc1VTpKs8T+ zJOkIhfHSJgje)*^fbjpfKf>+c7nzfC#A1kpxQD{BFDOTU44(9BI>sJX#DxX)kb}+1l>M~FH9yr%UcYdtfqiq!F zHQi1JdbGl6H5?3D#p?DPv$C%WjSY+5?L2Tx*|G3--DfmR{$-3!9I*15Jn~L3mb}H+ zsyv?6i+cEw>(R}+h>?Y_pWfo3cK4L++3o6Z^vv_NIZSDZ_D!4CsS>BLTT2s#u2N0OS3Z#te0cs> zepA*|_`5}4POMKE{m+k+Kvy)+q#sA~wy;^vse5Hsl;f}dWe7B9LdATIl{Nhf%XO7C z;|t48l{Lc)%MF#&W`FN!&(4@19%#?786M!QzkF<+zJ9gXP#Y5uunD35BpPEALH$WQ z#wLdPlVprd0`({97@HL8PqHyK8PuQTV{CG$KPkr86i|OsjWV8lJD`lv;dvb z44cybCV`RG5V`S5KK0a|=yUI`u-r;T^AMXC(P4B-;59_9uD2x})dI{u|26e&oxh`e zIoH{ezMH z2$5kK=feVUgC=5O0Xjhw)vy5Gpowf)K(|0Ky^!fPK?A+e(H{aQ0wGfc%lGx|r)I=F zQA8-h1g1Q3D1!v1UU8_r1g2easNDo6U#`-mewaif&72!{tcTGp+FO&WQ+t0js%l2Nnp;iw#LSEE-x8Lu@3$)k*AOLw>>+nOWl$?(? z!a(L>r|<$?!3dMf^2sZx4BQ^9yU6D+34+^IAB|ss;i-qRYCamT;RefFj(^V-gs5r%J(C-vpbed8eR;c&+Q9PnjPQaKN8dAU3P8$q zpO4-@NKLxMmlOZ!=m&lHHwpgd$iG&W_&*y<|DT=W9?7Vb*J<+bcC+0ph;u-tH=ioH%ij&j4H@l z_?^(C{ZGQbX!c)JsBjTfefBwH&f+WmMcH#RJRLK%jhq>ed=>wH{&d~SOmO74lrKBZ!RBwN99~-xv`7*+908$!s8rlgg%$hn3n=&>}0o@a8`Xtmeqp78e zn&s-jLczWx;1NLM;50B0(8ggA48ieG#)t+q#C@Q_LIFX8po#P&BL;%Hv{!c~s=DP3 z?G;0RtEaNdtH;Krr<}IDdycz!uiScAnLASo+{Ri=w{l)?cb>koy5Uc6T6!+l+1Ogx z-PkVeu54{Ct?edx^1Ze@c$t;TaGWkz=Ns_uxXe-=yu2;BeFvYWxO_8Tczsr5o5LQIGDikWPj3SuVfrA^yLZ)ui26x2;lxTl$@3-fbgSjY;FqogGP z5}9WcSk+Dij-)dCr4Q;O18l+SHQQBcA{ahOPu%d2rrj62Zm?hErfb{Is6Kb> zxRc(IpP$8cypeowwr`nS+po9?#ar2YKKJ*l`z6!ad~esQV)(o-JB&VGbMqx~TYmSz zAMekz`@?cMJRY~7^I~y$ygv5_t6|^%=Umt{p5OI(kXX*g-p_5n+pYPhZ@-Mb^XsG| z+xzn4iT?o*mh*D|mh&|QcpB2zbF2NDm?-GI>Jio}M|eBB+}e6v`k1Wxh{+P_>+*`i z%gh9vHm#@FX6pR#EmkZ_X}m9rPEb7nu)!;0l6h3Ke%NX#G%9Z)FU`3Sn42h|w$&G# zROb0b@+fVTPMDUV8JId2o$Be|{>~IN6qZ)Mx`3^{?72HL;Pvpj9gO39y@iIe^L*@08rJiDKVba0n{6n;_ddOW_`WfptI@X{zt`tg2>iJw_xJPFG(5k{ z4!oYP5WrQ2;o33A@=4uQ=AUPKJ0mBjFa4vhbkcdUbXwpQ8#lR+ec2)>(oQf9GD0)Q z%vB=xkh->s7>h#@*_|V2>f6AX&(j8al({Rv?WS_<+LpwXr zNmh(z;M?FBUg^3^GkV_*ljC>4-&Jyi)gu_-^Ze?6+F>4H_P&1(qUZIw-D)s95Y6WC zc^9car04T_zx^OHZ^qB`MCQf;S4T49!=24Lw#`o9OGPUTJ~HzOyZ&e4YvT^Gj}vE zPtBt)<}D-g3zVK=PZN->M_G^QVnwRkZZ?!POOTnBea2j{Xh|kEco0{izXsK;1M*tPhF$7zi_`f#%_In^qrQQ9W&!Y~? za(F$yMvVloR@1ipUhjhtMj81(=k`nDApZ`_@xNb>79cn@W%GF6ZW%f5;degOOmy=5 zuk}meLj9Z4sGpD1aUJn&tF?54cj06J#U^Ew{gVWaOG|u zcPGvJ5otkNsTk<(kbp^0&=hc1%Y@7U%M7B1^c&=QA6i{@D`+E<;XI|SsB+!u^j6!j+Gsd|u8 zckKZT!xa>n;nU~t)X~=EZgv05VXQ!^24LpuR<}gjw}Utw$^04`yyVwP!fYZ! zaSn85|5G1jQcf{MBzo=Sh|YYLus|@4CeY$h;OEW(wX!b8(wIxaqN7Z8Fk?|;dZg3W z<~G3;f+-)y&Urtz-XG4A;m;G$DJ|n^t*}gN_!FyrZ?fdVIQCUy51?N%g@L(6{nH?O z=-o-jO;xG=owW>4onX|(9k6*84e9HGTG~+UAS#aYA{C~m5%&w}Nl9^fAkO=u{+B!$ zcz(dJn!qRgd;XuVJE6m(!`pPTtwA3)VRud5qAiAUW7N^%wX+UX5#PH+MZl&96mx|; zRB|e0OoX(|iRL0pOfDiAnTs06ZC`bclJhU;Tx$xUfL18Oa#o*R0H2B2XUN760iwSBPJtKCr>`3VF4!^ zf~}hQ_QIRt4NZR!)Jg0x4ei^}m~Qb744K4^SXT5?RueE91 zQT!1C{On+#Z-JgEmty+8az-}UG@wEn5ctq91)&AdYbfDKbn_^0ml#84h5aa-b0Hl2 zG2mzJmU`|6nClc1F$lM<1a_R4{F(hA}u}nwrWPGP24X@Qu2ynGwG= zCM{te(5m|#(^njsQMu3^nnmRxJ&>R8%SJ#;qzISW#2Y|+h8fwT$FCK`TORE;B*v*Z zPIZ{}V?HLcy7)$xpYRAhK=+0YjA=tCgpZllkugL3GPE0Hq*FPV!GB0FEr~njB&|a4 zCy2#oC>&HNMPgGn?{*5;3{8eAI+z3#5SRGr?i9M&!5%ninw89O6`ppR1uofK5~;P! zyP+?;%~0N$IhJuPLte$V16kA#Oh$r4Ky6aps*Y#5izKZ2LZ&PI5nJ{T$D6|){79ul z{g9&Blz}M8TbUu44Qow^)%YyFJ$AC18kX(1SmF_%O6XtNUOR=LS{`cae=m|0%5bjM zZfGy03b3R}PnXcLIRYHSEZ9{JCzgQCdr!(Wre!vTLVIkQ#rTIyq@M|UT40S392+o~ z*C1O|t2$FG3qmUi4-AmLd!+NVBUycJ0gv?9ogZXMay~Y@wNM;wZF3g3zz;dN!i9NH zP|tDaF?=|GJiczcI@*V2nkz(k%EJYkb}5#5N(^8tv^A=hD+hjWok})!dwW@Qcgw?6 zNck$cFDeeWD8?k2F9tsh)P_Q%+D;}vheVSoB$I@LMx}LeKoO_D?z{7EY+xMb+0QbTr8;>3*@`8$7V z&H)yS>h^>pb+8zLC`m-JW=V1uzG^~Nm)Iv5!;))EBT0XVfq&$^Vz%Wz%j=A zh06OFWhVn3x<0_k_B#8-io|E3hOsLZohD1WF6V?OHDnPskpMcjMAQ){t+-n+&PL6| zg?ajiM3dH~_|>Ee-Eo07va3qrQbX}T5oL`?RSgbS@5*5X6J#^1kJ~pE?=3|lmmR)^ z0`iJGnmWthrpKC_uLbR@RVRR71Xb*prkYm$YFD4;!7j<*f=GoufcrH8X!4TtXqF0y zACq-c-ZqcE9eT%o$>cShWUhhImmOr*=hO)3BLYI~LM`SV@x(3%>o!{C&Ch2IwYj-C}= z;Qcl9`SG!NvDuFcarZ!QROyCAT$blkB!fGsmNaLkqcBkEl31p0KCo~fqb-r4Aa09N zmEr`Mm~C>R5ZPjaOv)5@;__R!Fqqa!g4{qdFOuYU2?X^AyI)Xj0ry?OkM!+KOtiLX zFPQEaytk={tw366{U>&WCsReiujxr7cFx1jag&z*j?Jl6sJl+4+RJAXS#_sN51-1m z;dtD=*7bcCJD)DqHs+4=N&1cU4o|Dt?#pVr>Dipcwx&hTuI^@6H&=@~Z#M%66B7$t z+d8fmd#foeO&u-j$?3^SPba5}25P5<`^KWS!J@gWkd(Hy&9?Q17Q0PAR#q3QnBV0T z-4yLq&%)QW5#Q|| z==SGP@04^L-QbUQ)M4kOP1`HaDR0}y%kzuXkU=dcrxwZJ&EGBFW*4p=1}?5Hu5GHi zRj)Cc>KS*EhmtsH9`ZJ9?o}@=(hB zARf*y*csB(y~IuhkM7tr);|}c7#f^k6yEH-k6lUlA)EbO9~WIZKQFb%HyJ!r_h}|M zVk2~z#r_DA+f-DA=-xWur)nXXUGzkNDh1~ zf#oXdh}g0bX<<{0sl?yMR8T7SKaW##iVM~!5a9oO5eNAn4-WM-G_$B3Zs`fuT9Nv2Js&|~FEkTw_lAN^5M`MHt#H)g&hN=((uHFQYHw+{i zl39La59D3%FUXBO6rz$)cjDP+If^R8$20OFN1l*Sb+5%g8SOWJ)#M8pckt3w%jt$- z!*EVh_wX~^c^^Jm-LI%kdttb;H@jWhUE1KC<33^@urO`iaYehes!^tKZ;|uQ|YtBs&mPU$Rf!m5-tg(56Dw2K}NxDBHRiEhff*3qRBC` zDVh5-&CNNCqwU`&qWrx21ee#x0YJ|Zo%^(=vSa%*O5d3t;sI4buY?3D{pB#*H~ z-sDgnr$_?qRd5bI9!RpZCBp(2LMCX0oMK6+V=rqLoO)vX6g@my$jgPs6a`fSC}V0P z1S(h+MT^OPc%&oPjug0sB0lND-Vk`z%f!Cd>S^|{_3e>K)%YvHdXF*~O9E0ApHs2pt1Q<@23f7s4#2cv? zRGpp)dj+Z}|Mu!EQ?=wOPuP7WGZx5QPA)(5&`qhV*UchVMP@29CJnzdM`Ksl#EN5n zV#l||g=HM-$l-X`b)($nS$@Tz?riM#s`c?p;&>X$Jv@MVc`M&%o#@SxAVlV@Hw!HU~Yf1m!C3%h7zY ziGrnpa*HN;Gk(?q!JY&8E~PX_<`;>_oiQPIfoD6TwT)3Iqq~DW)XU$1tIN4xQewVE z>iN4rn-yYiF3vC5B+sR;yF|IcxyKn!E;9vh1xvE1n)zf=* z`Up}O)?&~RM4hl~R~>KgHhz+~KSc3Q`zJ0`g4#f&CtxAajz2WN&%m45q-P@1kaWNU zDnikUc0>a^79TvDMiuEHhuemBbu+c^ia=jk-{O01lEXfV1h@{X0CI2_I4xfnZatq5 zl*~V-Z1iT^HP+AO9!|5Hz|ur5B5`0eP!lFe>cR*79rV!)%qawB^DBQWOh5`WOYgSz zf#u>$=V_4%_2>=NdyXF^kipboc}f&pq0`VS(9>>cTSNF>ggo{z4(4s-1>Nxf#+h2# zEG~V@%?axw8-oQ<=TW>8T%8*_6@(*b-4`X=I7x%v`;8v(&d-5Ms4Xj6%$fq4M(kR9 zVGmlgP)AEEi-5ShI9P>iMl~oMOcI~k<%Z3E)d*@wOwb^M*!gr%04VBR4cj%YPw@H&O4Re+Mo!Gu)^$;V{H1#-GV zvJQT-21jHe%ytmzNXl%w)09#)4Wk_c>*2GJf)gu3+p*3*CL#-NZd6&pFMf?8^c1sB z|MW2&qELhDxfq9X5Y62{=k~HVbGag$>CrT&jZ@;QdDpeLR?qJC&RE0Vj`&M4`|~UB6=`*TcwWDBn4vvK4yx*HnNDH zM!Lto2s(CBm<4)YzEBGNxy#f1@|x}4b_croV%^zjNL$=$f!ASP`=o;=y_$U39NW%U z(^~{Y*TO3rE|ckFXe~_1Aztm9N3##5P*>%NDQEZ9{1C@UH6Fa?01&7NCvfE!AFn{( zF{jthtM2Ug7A*vp+&H%cenp(VbgAVSX1$mLJ=jg$-+AuC;}{%Fcd-V0hV^AuZ3^Yr zF=PKIMKbPQD3yDS1*KJ4GBYFBjfW;x>{DuEQ+DhMRmh!;AsCkKjkPOJtwlrS{9As* zl!e(pVj?xK&m&@tq5x#s+T>ttsj>>&HbbaO7$Rfxn~A>-_HS0^-OeTiLfF6oJ5p26 zNPX7b$~x}`XSxK0ewuAe!*zv5)A1lx1Z;Y6ZtL*hWE#Z+ZwUbsGQoM(>d_IfHbcr; zCyC=?XA?}vl~5c62T`KSv0`Tk0HdZXLyvxNV!DAojSOAgnZwUpuDhj8Iq$vQnd-0a zkC-y{ywul)zonck)g)~07SO`7NP8zbbyi|pEhASQ%;23ms%eTK0oOBybqj5XC%1r_ zeriOgt3UvSf-o09qp2A~MA{9Ghpi+3fodU4dieUx3nl1rq)d=!J)R%&#KA_jpBKjJ z`+%_VT~2f_FPrF^okYj2hd4&gTDD20XmMn>-fiuOP(|t)E@5^Sqv0IWolR7@OE$21 z`!=L=hayj$1)0Q6*9_`$$4fX+K&0u~6`(FZ$U>NSP%+7JPY8sN6?gp#!^p?gVBvgry>o}ii3xBLWn0$kH!%)C9)~Weh5nx}Wbb}nBpVd99hvSrooD`Q@FjQoel@cKU zk&aRjPdX_`93E#JzT3;pB;YNquPZSG^+65f1OAlcA7ReYPR8WXdop*=G)aA>eC8Z> z81&MjyHXBk8F|~=JJq{u+mq{MAu(%5k?%#WC_DVcagANgq`_AGr72}1*oa=?-{}}Xi!vJVy`p0k`r%dsFpdx`fvU5q^2pF;3ZLjEIH0?Z>{sW98(dL}oage^K>0ZJO z`zzpOixLW@(Ql<{L~erm!1!yAAvqK0}mx%0Pz{#WVx>ZxrQ2kpt5ZOg$?M~_bP$oB+wF9N< zR^|$T(jpmy(E^wg%=xm%*EzlyGCUjZZfc6Mbhd-6rJ2yk4q&XLU);o_(th>)DLA#mHgW3E0_afq^{zm1NN( zQT8F>f~jNqV0AFiKMC1DLPDeq_M!mFk&9sEEaKgUzku%tSlz59_F5I@sp9}!%D=XJ z&R$lr%;UTG%g%(g@9oWca!P#L<_Vl0-*s!eUH`hRMz{&~<_JfE(5#V4WvQY&&QyC( zF`NM(5(+P)I?mHKAEJ)wKOXd*N+7~8MrR8_n0}vA$_K*B)q4!K>C?lF*j0*r;+)vI zpS>vV$05#qeIASqZ{gi^#P|k{q`CP|lDG5CuGPi{B~a+1-%mYZO5fJ1Aw%`^0GV~hqUBOwW&ShsN%Ib`?@z*niFlNxc6 zh-7pY0>2f{$p~G4tpL4G!%>cwIvkjdjD6h-?~ed`TvWvf+`TPUy`3LaYTs}jCN-zc zI28YhLJ}g*7Ij6%60xU~9cSp@NOT&%UXqPu8b&(xbpu6g@VSTMy}@7^$%6s|(9znz zpn^^X%l|arLCf6MTfTUHcIP+))#R9A!#>LOO|AWcv5T4J!o|B(U|6E(&>dc*r9(o2 zR6x}z7VYMOm}E#i=M0f!1Su%)o1veBbKziZll~Jwn``;{BQ-nyc6+=EkHEbXSPWFcdb6O;+snAWyT;PD)(z>C~z zw;vC4nN4#;PY3sjLr*rs4fiKwRLCq%2&*MLEm3lRQPHo>U{>4{#9fncMVN*FG!G0` z;lIh@`7HA^GfeqT3d;43bV6t&EVju)o-XZ|X%mT(%2{$XxjoN+yx&-1r(qE$uJAy3 z|DyMz&a06jOx#2iSs855dTlw>oaL~15RK8akB`2h8X<`tm!)h)mJlEOp_9@1t?k!$w*Kar_Ul1 z8%#1@w>-r?vTrrYjw9*4bTgXy!hgwaU{OIJ>}-?o^KV>PC3(YkT&YsQMf&cgJ56$s zB`#px7bA2LlX>_N;FVGSqR-tAIe^wdiHwYg`*k1`fDC*E9{@Wlie_-DGZZZ)OL&oK z{dzIAE(Gx)M>gRJ%Azewjm<}*a5#S;&4=gCDPpNAhv8hm=KK+ay z9NP!;E`Xb{n59G$Ca!Fx~kPsgE-2;jRW z>D8w=4-F(vV3Gra8v!wfDMyO^c?AiC1pZ%SQa_{jWE_7oIq7hooGF<5SrW{YEbl7q zz+yL)V=C4$nB3B7>j}b=uZPq3y>o?@hdsVu$&AAJro0dNc?yKu8eQ4DwIJNP7|?l9 zdg4diAbli(dVoP8<`KV+EL($f4I3E|qmc-+DpDq*4+;e^twlwQs24Adl5UR|J~qZi zjHsOnjAUx8M9ZK{HKq-mW>N~dIrA9r@Uw;l7=a$s%P?F=IAmJ6M<;DjIv7p|VRa^R zw94Oz6d|dI1#g)<6UBxZ6s2aahS(6tfruu~*I+aW#6m}CnN6csqP(i^k#ks?`{PRke{GEAaXjeHS;bXI>EOSs3)U%i{Mu*-W)inInR~II*(DeY zb3&*@$Zxscr;|uAgY8gc5|`Os3jFB?eJtCGUq%P|AWAYXwq(cg<1?bA#{u$wT80xZ zkE4kj>b|vo;h{1!%Y{mNP`bQmg#;`CCJT*e-y;Tfm8cCgZX<75>1Y zuJ6yJAew9<$&~$2zJI6-#270Ny~5 zsi(1^0Av_qXP6X3Myz?ej|=K9<7!arEOV^SgDIyD9`@uVhP=pk{6T=T1`D_ii3Wc# zGYcqa#*lcDpm}77UG=&xzd3#k$Bv%g*^3O`w#-hA96Fub6Vw~kxbKIZD>at&!hxJ40F}Ee|URD7BKfa8&mF>=+HaGj$wl?;Lfcu4s zl-lZOBO5vFgd9q5yb|Pw#BvWE z=Fz!8yUd2qwY7}Mchj~uJ~;@(4_oaxY{l@_QS|4H+OmfRF|jLd!T`4x*EOwuC$@gR zKUzO!-q9XGe8<`S_B#;xn2&nChETsY2`9cTg*&^Q?A_hzNbPyu9G7m!gqIqr$Nm(3 zpS~y_p?l3Jga7s7HVT<_U?nat>;_Rz8GSV%$R<>5QIp5PcN>FQ2&i2P9mm~xr$dm-pQQL%9GhDn> zlHr6VJ;oeE7gd7&tPMj29hu4GwuQZ*vg(N%kdQ7=3##<5G({5ik9v!E)40=y5^BJX z@0@PcN)B56LKr^#3Q5)o856UDKBpqA+%1mkn2ZwFm8RwLMSq9V$n3YK7G@YCO#uj) zFveL7WGF|PK-`y7%uX+ogD0!FP6cPG_yB@>9%$5&K@WuO!ISX{8x^}bgX$r`=eL%_*pib z%~W%}__99)^r1u1Nj<-sq1yTuOsc|@51!)*oWw7KcF&c?Q*&*t<4KRLRRl}N>jPxw+}M)5YbbNYS&qeQQ|v)V(bJAF#zLW!c!V{TxJO5RM6 zVj6_Mp&M>YV=|Px-g&Y~L*Gdf6eJ6+1ZM8+}MRZi7;L|53y;d& zUHxt*OX%-pbVpwz>iYGqbt^kO8`~E45)eK&6z2m31fZ`HrCWJ(HcB6#`Yf-?I?&jH z^Ee!_k}Hl_dahWdoEg*Xi-%`P^(d?IA+P+Z(zz z#*elI$cNq6-rMOMyH$z9{l8MFCna;Oth0(dX-hFwtt@GiBh^{^NJfM|c51s;x4xG~ zwmlth-t13sguW~b7SCo%Q$zk7BXQEG$S2wx>l}JHPlj@vzIfOBk=AUANJuVP)p-i# z8m!W(Y1YL`U6Lhxo#<@}tVgU3#W%Sj3i)zln;e?zX4Zre(DY0JRDW4(@=+4#M=J$q zOS-*=)0-4YS@US(O4Og&;zYeX?L7ay?#5sG*qq3S4#CMR=__M(g|J)mGbB0m38mv{{bPB~a*AdivY z+WhaPEv#%qIjk0zWowm8As=bIw(qv^Y!*q#rD#SY}kZ35Z#UlJ-F0Euum0H-JS|9?Q zmYpyUrhFoELts8>B$>g3X4}qU=wGqd8l~6`=K3EPAkDJ@MEkZ%;_w#H6A~A#kw08t z+KZ8*XhUFU^OetI=qESY9(Y#Yz@kgGvEZulH?}u6$ssoBC$-mqdpQtsqEqI1VbJ|t z<+yEBeX<*~Fi46qlU;=6;%=kbkmm{sFKy?B6TPsEB1^z}vvOuegRZ)ngNl*fHf9!S zd3o6L=84wzzY~dtsO!1PP?pE}`PjiX13R2T-O;GXvZqe2Uz`BrvUw#!M&NUV<#duu zU7uRoM_tnRRNETH8y5d*^LG9x;XvnYiK@mQ+50TzJU2T zfU%81$#`!vRUJqxk~op=d?H&z4Ti2rk#bC-M#(Oat8P%Iw5D%B`A1bFS{eY=#f>mQxI}2nnUfybM?`?F< z=`aWi;S9SH&I7Y}cao5!P-)t1J2u|s3G5_hqG{3hvrvT%r@#|G7wYw3YqLO~ThHA( z2U8aRUdV^|ws)FJq9(H>f+M(VRM#^=?lEXD)1)UY4w^c%qm8Qu-&iW|-_2_FC3ZA7 zOLlYX)>x9AtsRdCNW4q76ELglN`Y$G$*1@5Ar&{aY!ft{JN%|^hZCRZ;_ma1mc2X_ zZ=e+4)~I6MT|Dbfxew3(L38i3Tf&4K4U$9NqnqzUJuaSLmkI+CXu2*BGmU83R2kZxuBeE(*9AqtPLrKjsE$XEzeMHjX9lN2U zqhq414NaF##Q~W8_9?|IHJwY%g11n3O+L=Vmh~+zbGyqXw^+8db**Wn9t&u=8nC-O z`#-4DAdCSy*~+)rKjB-Ot8xN^?2|#XV#%;a&c=C&)kRXb$7fhAX7Kx=siQMIvfND7F+co6v)>MH8f%zFR=kw|21pzK};hWh}Ek#11rkEokN& zo&5aX?2VH2MPH}E?pF>NVgEqrdzlPDStIB>P4@sbtHpA9))HdoH~s{u=uZAs1cx(P z`fHU}vOMN0LQl(jxVGux<#yrPPeW@U_gAyI-ulR;zP8?SnJ9`cYq2RrMaQoCC5pQD zcFc0}m71E`h0r_D!)hPq%J!0f!^iE)+^L|;rLl`U+ii^#-@NB;&c*YJ$NgTXXSkG~ zGtDY}PqCY8eYyrd_Ib1aP5r5}Z5?5O-k7^xH#2RT%DF_%!l}las)M{zjIT%gX1&`a zyHVYj00kH2Oy7b8TV^nMsFJv3pFz4jCZiI=wl+zMP?2-W3Gx0jb2Q^Lc7Yq?rHPl;*mpQmAA8T`;>Jf)a>}}dz%!&!_L(j ze2x}!dn0d}WG?aY{5ME#7bFAseo6iE9hI(FGp*5Pv3RgJ=THYMd1;k%yH8(MW_)L8 z;14m&0j$s__oXET))wE;lyPTMsy!Cx9nrPodRvu|Kba-WrX z0#nr@6_R*@xS=KD5R-V{Rjs6P!6<9OL<=Gilrqn@zw3%Z!iFww<*Cy1l@fULMSxhf zbMIEmV?k22m%a^cO7)8J7p?djE1DR$ed`Nc8{E#0wztb8Rj-DwHeOxL9_5V_7kxfh z-)wlF@sktb=|?s4*r}V(^Rso&T*XLT)q0L&rk}>0U`tTwBDR~&wdf9MIPGtof6ozr z(#gwAM<=oNIaqlBdnz_YBd+vr;4_TZsX;pRj9B^oPP%h}ZO%EC?tWXk%OW~4`+!J7 zHCZ6?=Cu>73?bE@gbNT?45^zvlm>H&oOIfAgWYHJ*dkzIW#)1tQdnUy9o?pO$CZ&Y ziieq;xepuFi^k4F`eRP8T`%Y`1+IFv1)(6Xjx$8wb>>v#X1t) zL+?oRTHe({LEZ>9PI~IkUxo^?UPSqQHnp8FjBV2GP2_atpOm}^yyb19JKGJQB*UWy zzb1q$#+|Wr(=C1Amb_W+?BMM$;bKR%jQT|55uWFhlnjp*fsfZ^YU~#Ly{nPwr>B-b z2&`XcH&f6@8uw43t$wEU4NbpKR#}I?H=!zPfsgdRxX!MPJ87ZW`XB@Q@YK(O0Be1TbjGQaJOEMmwa9` zRd2~#T2JrZxtp#A<<;fVdTS+8rHWjL8`8@-yK7gy`TCk*W`o(Z@wwbBO~|nl_{x0C|~YRc=2(S%je>n5#ANx zUA}-f{77KAp)o1AV(A;|#z%{*f9%%tL#UW=`mZP5%lI_YwQ)YSU9VhiB#{(^ zwG5O*J{C3i+&Ez=9V$+|1$!i<3CZExegz`STOr1+k?BJ4o?(P0V?|$JS7I_d>+5Z6 z&cWOTd835C@k6MO#=yULhC)+*btFwZCfEPqV`1-!W|9~wO18l>9!nyKvQbMDCV3_s z3H|Cv^(1FJR+9VphW2X{nN-;Xv%+p6lhBD~nNUqF>3599tIVzaW$BByNABFLsMH@G z$JuSh`qbPw&ZQB~V>Tb$)r?Tb84<42F9E1t%sYt?cH~G4jyj4yE%^dNUHzkiIm^tTbB_3p#kDQaqE15 zY{XjNa(;Bet(+_D{5N-qM}-PwMfeykbd;PBw!V35qZrc0+gLo5s0F{fBF}H5-DuN zb&>IcOd2gykhoNIMDkp<1UgT!@y0;5%Z&v~nK_+fh&iN?J2KF7#85Z(s^SEV-}n>s zJlOx)QLsPs>^NON^Sk2>5@YI@S2yi4J8RPi!iys=W5PL8jX1(22Q>R7;mj;54p4JI zc?aFBR^`%Zs<8|og?>Mkfyx(RR7;^xf=O=ds(^W;(oB%2FW6CWgAEc#Z;$$3e|8ER zzX0wyoYrEQ2uLwfl&&qrN{m}=&$C>&+=@;J27r8IXlx^50_=_D0-+@XWh9&- ziK#?FxTlaSajnYeTG21W`3BW5f%Ca5`K!0icPNbN$!2b5=1)%4lehQxxAzXVoGZBo zz~#zu`?z~XXKXh~xk9t6(L9SGB9C&i62!YP!6zB=DMqT47+-`1}4gtZ8AVg@L{R z#Hb)Dn7f_j*3Dr`m8g#salZXJ_E($^aQ>Ak2`$VD|Jh05(et_B@1cjk1E=#YlEAH;??{D@sFki$?ShrW{9rt*z+hN^y`RugUJ!U6# z*!c~?AsRygzDAIawKusS8lv2(Ns)c1pfHu`9J72mR*APvft}0N#N@mKiZVl_9Tf29C;mTws@GyC-sJs&ccU!x1~ z?UTLt6q6qA9}M*DUIc!78u)Z5#=IUjv<>chVxFVP-Y2h76>AGRSzlRLr-;|BstuqY;42|(7vUBc4G>GG63bQ0w zEP@mk7PsUU+YzDTX#K(|ZuFN16y)RSBSEKt7w9~ds+CZ1gq$LVr-(I9^wJ(ahxP7F znD{q*<2M|C@^hbgcZl^@r!)ycRq#_6*0@Y42wn^53%2%?{e7(qRG4-D); zTq@6P(ZuM;`a1f>lN`k#icIS~ZxKBwmkk+A;ywjx6!^t7b4Z?bRzhBG0!m&v|ociU{)05s=n|?_J7ts52 zqJL0$aE*wd9|ZzQ(}Iu}s>WFUg#Ig}Y>WI}-a_A%oAZGPec`m&TF9%Ak+*WEACqB% zias{uSZ~6vx84x2+npiUzcHl_go*h-GpS`aF&%$Bt3K@=HyGKTjWelhH4zh-b*yyH zP(#D;19aDH&MDX_3W(fk3Yl7}RY4>3Ib$LCmG}bpxR|(_b}5G;t!Oa^TL% z?WrF7M*4%!`S@>6Nsf2uzJD@NU>DKXUH2$>DUn;9ONap)vzFgVG3PIjT7eF>??VT35ZYhSqR*^7?pt&>#)d;p98KyZ zfF3s{+J&G%K5|<{On_~3A%*j$9NR##3K(lWEjEI>-7G3IIfE#-7Ldim@K2L-;)g_W zV$)=o^h@;L{LN*oI_=@1_&Za~86prrG2uJL1s|^NGP-m@Sfz|Zv7v0tQ}VPZQpVEM zg19NLXiH^u+J&_i`3IH94GK2vk{ovxDjL?I;!fMiwf(tys^ThL(~^!yO8NWQ>3OKcIw{&D=qGp8`)<~8}m z{->RN!g^XO_s#eV!ld@c7w;LsyF6i~3q4G3iyq*BSb<0JvBr{*Fb8A## zFoDuc4MTuwTUwAacRLpH636}*vxn{(e<%)$C6o)@IN=0}ix)o5~vQ8r7-G>OGwoo#^yB1)(}7ev&P6OC3a z1D07?wn0MKoV(}=p z-TL~(l<|0B?Mg;|dcr-=I|KNgUQ9MDW1YH9tJVn?XNJr?w<$+)0WPF~aCeS`Ahv;m zRMT~^obYwY!3-nxs9e&Ofj%QtjEy8;q$EWD)p)uD(apjB)Y{q&U_MeP=*&KUYC^zK zOpw5FQOv7a_gTeuJ3c+JgIu0vag?FMFkhfBUh=Sk6@F0L&WU@Ver8)xHUZRR<`9{7 zVwq~b11ziZ;M;{`xSg#;1m7}`(8s>Si_|vn`hml)E0v}w^>e<`g-8tXh z{8Ah4G8j7}cYlKGKu4y;kb^7JSP00Zz$w5oGej+s$z%%cbAq)fIKU?VozUrt!Jmvn z6AZ1KnCU@DzL1#k#_9_wP!ltxfA#bV&x=L>yRSj`YiQ7)pF&O0ojf;2O-9PP{WR1S zY}oJE;|g62>z|e@Yf&7srInTS+bh19XJNX$EVW+?ZL=v$x9>C>wbe$LEH|U_Vuf+y z8lhnoTU}OFt@*;DSS?8%F0Xit$!dIOK3-elNhBA-Gzq;}meZucE>SR^RMWlD_T(?j zJ}+(Z!(`BBlleY6Teb$-)oa7tbAm6%@jbUv#kxIOf;@%Wb!$wk<(lWg3PJpk4J2v} zO@A&6taVbzoZvw$1HdXoY{qSo&%sI-uJ|SU`fhrO#n=?jd$XgI$T=IqWY4fY`S~fH zYvXL&-Cj3kG0O016orDqJ>t+TW`?H}n@8wLCWpfNEyfw4tBJFazh*kg`noYZgHQn@ zq#-?u>OH(Tz;}+C?lK7!=*jnAkcD{Trg%oDP3lU{Rive6LZpTWgi@-8HXbR7mxRU{aRU*%FC*0A4KEa@poi;J z=8%oh+`6p_=zPGMOZqENMm5t!i;pu;|FHAQb0njw*B_j6I{tZbCSSRbWZgg9-x~CP zU(u?)cF*=IoOLT_42zhMC{e1Ptm{khpdyBS3IYmBxpJGE3TzK{%UQH(VG!2jsdN&V zMJp>}lnmVJ+d>vf*n&Z2DV2s_qRoBt-sHUh;dFN9xkbW1JvWpLJnw%vq{wD#$2pU0 zqg?6qn4iRu@PW)%f4PEo6okIPLle_5sFb98rx`$Xk zOQE~eK-)N%QNVPXRvUuHX|VXFw^E%OIrP;AS~J6fq|;#=Y5GiR+r0$y?gh--os+1} z*y{R9e1}QnuiQaR%P*|*lQ{~{?>5rqwKNN5SWB14ohM<_>R>H5)kLk&8{g_>x#Tr; zNj5c4m1QQ?ysD6!0)@fq(4{1u2x_+5+oO!hi^T0-%Yv=hv>hszom@zHyMUyaNs{UUdv**zSJ-RZlhHcO9NnY+Td)7@j zwx4382`<3iYoTj3lW1qf1_kMOA@RDFtCkVa6slm?C$#LGTvG1RhdOiX6O9uAOQAuS zE3_D@OV=Mxj?CZ04)`Gl`GqMFI&|3n(btABU(mL@2Ee@6X5~tSDIy*zwvS`~4L~J3 zL~A$D%Ciud!j9pC$vZ=;5i42<#Ed)ZhdjNF>8_;EX#AE=v@~;@xrnroGk<{;*iCBN zjokBJnZiMW+kL(_R(ssvKiD`Jh$meiXJ+ckS51L6Zz^c4)7dAIQmxWZezPjQHLIfe zklAQHt*g|QRFWsYvZXZ2e9p^gi;{KD<_Xs#jTS||#^iER&w_?s@N1lFQCoXM_d9)J z2=w2alHNm={lAz@XirqsuLQ1F<~?HHM84Y|a~;42Qs$~Cu)q^d@C6d2c_u7k#1<;* z_!3#(GDV)}ww1e?vsT_}p%C1n`-lk=jYd|)?U!=_5IUtq`hr32nyNf`NwVGk}$<06!*zIe9 zJ?Aay6}wVhVpUU5=I0w>-IgP@u$HEx%3}Jpy1K%2C9Z@;By_b1gX(&gRjplaHYtja zY$Rn(h)SJTcq_)pO_3M@urZb<$M+q6_UPzK;CM%e)4R>4bXmS)me={@%(DUFkkTk! z6q_f+H%I;Q6Y?7EPPx)PKJmKt*z3{x*gorYnC+C$dL7#>d#v3dpzX1>1a!q=-C#*$ zMfj50N_pvSsUgcv8Q0c>)#ZhS6}GZgPs37qKC^0hZ4I?sZB)6sx>lNRM$tlfQHBwV z*uwJNq_j{ntEE`W#l^+7#ieq&vBsB|LYDgDMVXzWgQNYUox}Fl!B}a1q^xlx6|s}^ zUe?*?JBrcY`coH1>KsD5ikcZid!vywd5SD@{izvvC;37dnbJH{P@v z`J<5}>{qAoK*%Z0juP7!q?5X~bD6Pwlg93O<3@#ED2_RE#yUZs7?1Xlt&B-%o52UJAM zfRF^cgFF=x>|7w2>liIoUe7iF3M*T){J-%1zvDI)NE`kyN5;BS$2>3H&N~u zbm_5mxrL{-@X&oMV@9Qycy?3%vcSgFzv&$ZF#p2zv0&-Eu& zM+SYkbGWm4(03d!I0QY*Y}fbOe*1)V&)Qx8xBQdSp2t!$XSW0a{e0T3ctTbqN2$dE zEF@d4xo4g1KLs-_+sCp1uLdt4PC#Y4#f>Q>w5w)pKg%M;@_1BpaB#G_In|;slE3aN zUlQ`*lOwhNx#vX$|1^2%-yVqwqAIg_AKbd*_DGeXw_zN+dmBcB{MO;Al#PUKKk^GXzD0*lI$kn2mf zD!jNV(|+Y5^xe_Yn|Nf=!?5O%aQ?x!CblXNYueu08c4)k1zW#!)-AJk@9eDYC#lBv z55iMJAyelVC++XAaRZd@A#4kwlM;_npeSJW64^cMTy~-`s1W1nIm41fqcWbQ(n^WZ zD1I5vFUmZ<`W=T4y3=r;xdi7OFuVOt)HgmJ&S?Uj5%LxeW%AYV*trwc=_~6XpXyM= zP%t4VvFL(M%EZai;X)Xf)C11kJ<;{!X#~XXa4vAXAJt5 zYc5P5N%0Va{(*@w=6v|~UAh8LLT+~`>}Yp7mCCW~P#n{1A9qi=yB#0*x}Nmg+A|XSTYqO3{nJJmkY2`m_671QQKL!(O>o z$x-L%=GZkp0xlB{C2D^OO!r`UN`r#+vdHd~Gg1NgreE8s#qm`*> zE4!HXL;Kk;UT7E|Yc;#77dh*-&(6-+$=Ml{{S@4?5vGO3)|j<6Iwo&{VRwnlpE5;@ zwa^rdeUg~PMm?9J7LYurfr%I=F|I+!LZ{JrD2(pWVViuMwBM_CCv^V4Jp}q+ntQ%t z@T+v+|2H$a%X9C5qL{(R!Bq|U)F-e{e0!EK?7M<0pi}V5AlhKDhRD%7gNj&;rNF6C zh6NNHwkSv`gzc~IEKEZ)q8h2Wn+lr-=y=kG;!V{w30ZlNE?p)s^^%G9hp*6{9n$Sl zNd9n&gwhgj1A7v3IsH=1K5E%aMacL4X`{Ut7$%q6Ew#4b_7?7#UpBJ=UBbI;e!F}!p* zN~%r{DqRajWv+&kU^N`MZkYwb zl_)LL08z_@e69j-G@|At?Xc$Xa{qjjgGyrs-7ij|dr!!kpG^dcJBMg*9|Ve5#@FYT z+_>kZk(A7JODm2lNNbXUu?w+i6%@P_dEqL*Ii?FV@*+9fDIp)}-T1s#E5*obu;#}t7lI*(bu!xud^ zH53Y)qV1a14{z?iDDPYtLDQ%t#Eb$}f%?b1>**Kl9{6$*am$y2-`UriLtp3W} z^KWy2#L+kZMy{mf<{v1X01rSc%^iQWwQN zZ2R?*0Q3ba>QI!bx%Nr7{S*2aQIgt1aEnie(t)ghoMiPo$H%W)z36D@On!Rqd8t42 ztbYGwh(6YzdR6yf&)S`1);mSlWZMr!!eo;xa^NW!OzI#?ShAMJ7`+JmkjKP2bdWSd z@&-IgQ^p!e5EFCZEDnR5J@9c@JUGws*sWk`pqX+4WhkB2WEec}#&MLG5(S`{_K_4@|z;fKK;^ z!K_RAqa{*E5WyT18&D>W3tqIGrX_aQ(gDhxPL~!wMxN>{WqfUgnToEyiM-@N=fOFYULeRc^6iGeAXpeM zbaZm#WGno>R=ko?h?+r`5;Y`>k_eu<<}~InHdQ55DT@{Js^vzl+H6GC$e&*dBIXCR z>g>XN=*5+&-l(lEEPA)cs_EZ}>cRHA2k*XtW2Wa${m)OylVA|xdoT2%jSU@K-_azJ zJ06JX7{juRr>N2xeb0~s!CaEtR!bpe3llP~`3%91K~I{cD6)Xj8{#q&jZ%fo3}khz za05}0)1^<;8`&Q9V6^@7=chQ9dxYk%kLoqshxa$PVeWm$avg-p$h&7}A+I(hu?rnH zQHOEG168p)HWB^GGttzs&^{fGay>~i$d9C&{I#gqrK$-lS!%L%nQ@bQ-Mf3dt03VA81ONa4009360763o0AWnky?t9ET;b0o#~S zddn(Qc(O6pkl|4ogx*gTrOAP5GN3C%D9}^reasvgx$^iobFb4 zk6Lr3TXnDG*?VU+t)5xk=e&B~=ly!#Z+UB}{PDL}mX>zE{448kE&brqH;-Og`W^Jz z`j@`+rH_2g*L08fPfzw=bWe{@yJsgSOK-0&E!BL^YEtsrE00}qd)4b-u;JxkXoo%j z;%YFsx*GUbbY@rKhL!;>r+T0qUwbOwR@)LV6-}*%N<?*JrQXM0s*iu{<`S7-@oKnLr-4%7xJQi zHK+}*hJ%Z%Veje{>(htz{$-61U-8S@EBe)!Tqvce{%uO zpCOz-w=~81=*3a@wA(#8EOEYz1^czS?Ok2fYBjurabuX)%2?%uFwPaqIdU2u0zP+I zYXPYITnnaBMTj%kU^W$w-r;y^owa#h=*;HiIp|Lm^ylbLMTxd5Z;3X~(&%=aj~)u= zkGymKk!zfP>l){;y~g=V%S%gt;fr$~`skD#$H<=VX2VynYBi5u9`vqwDy2vX8EXl% zoM3~U7CAlwg1K=kaTav=%QW^lxZ}A%s?VsOS z`t%s*4e}AS*Zjs$5t?gHO24sxxPNwh@Zz9*baXs&8}|X&v zx~%(f%e6tz?_c@DexDrjqGup7#mjGX0-WbY<%Cv;;vE62iM{b$P=L!hmxdxGeNGoP zmo^jD6nWw3!6<~#4ndwLR!dXJl>TpZp_PC|D=yjrfqeMxVfThH$At1*gmO$M$At37 z-Z#o0|LT9^>puC3Pu}s}*Q_pFy-A;cj-Wi9cg`m#r+cTz`=vR*G2jh|huB)5_ZgSH z9_v$pgQVPp zJc}R)PCqiE$S;5a+JfGh$7Js0xQTBoop~Y)vXJk_&9)E;SD}b)n`I(RSvnsQPsgB- z{!<u(#1I{24vO_=RxuCen6({1C!;6dD&xoI7L`8^;FhZHq9+z5rG{m%tf(Vxj zW%HVKijs0of2q(d#ga!zsVOv0?fL8)=dWFv;G7WEyBvA#{llZZgVPt?E`2NRkDT_s zVYVX6VoqGbC~_WxvJ|Cq`jFdLgQ3tF`L(3+c|_+T@O+6=dJ5H|g`iW1IE5H@yPBj>u}C;*xb zdKN0|NW06t=OWRma@NzVnfQq-B9%U?Zu)9RhL6!b(~qUgG0wkd%=MlS&J(VOF!){b zTyO7)IQ7xN(jI;4KcTnW-I(jcOFrydaxp`%&6yMdF$+elAxkMo6qI*ZuE8F(lVzou zyaBO^Sag^WER~ef=!_gZVkxmj!wjR`P%@ba$>TIi+nS|*^%zLsw=Qtr-$>5;&&<_B4$sa`PsjC;dl@=CnBmoSTBBg+ zbW0kSI6~R-9m)hH3$u_oUYn?fBMK5(LChkc;7K0E7EE^xv$@F0=8?%087JyTNjs&I zL}TdbDWvO0l9NhqsqZ~-J*3yaP9gu@>&#~ARlb4H{KQcPS(VfTXzNZHLU8^@cU7sa1fB#&V>>eK+9_}5C4Ein}+m1bUeQ?nmco`$VE4Woe zBV5V)h+^lIxo{n!ZcP9e!YbF{L`if*)3dO;Foi~P(@Ax)>m(&SMcyHrO`eAcVay9k z&kgx-vTQ}3{(S)ba`3?;eQnTxY(cvC(}d>tPttNq1okP7IXFH&8PV%|0L%tG*7F7# z<%0wcT!tz+u@M4o0bXd8p`0qnDv2^Hf>WbgfD$R;S>i3p8RO~DpCgKBGbbZT*>#3j zjm?OuXQ__)?P<)zdFcKO@B97*jssoB-<&J*&2|*;%|X7LT+8^Y+s39pn513mnI96PmyLS|mI<+TYt70eweXmayeMxBZJgOQTrvorp^n z>yY^Q7UeM9YEHi>N+XT$cDNsh+fh(A+q&s@VzCqD+byolbJk`=(DhEMz1o!Z+~*rD zCrpjk+Rx0>)$R3oduN^LU@1_F(EbE&+BLl4~Xp4MxEzRZJyIV@;;0Ipu&-#L}hYrG?9gYbWGE;>4|^pvTIp zM@2m)+VVvEZX0fe>^Pz9F*7@=ReNUqjQOo-mfszpy?d~@74r~``WomzHEzYsrsrtS zgkPFv($}q+vgdU_?;(er>^W+owMbbvW)H|I$ikr_r{OC^?mFZb=o3+)(Q(Y^71vQ^ zT~7(Ac`mfgZ63IsySzqG)qz4=16r+9reu1H1DWf_EX{OdJ{+L?(-!UzE(nOfMQHvH z(}1{th`JtG^e92UPbe%cnx}0kQ2IyzkYX8Sg2KvJN}&>R1*nEl45W-CB}z>$BbEZq zaUILhNs6G>ulb?Qq?CDv=;`a!5&5&>Ga`3N_*u$D>(+p{fB0~Yx<4fzKXi@r56-p9 zpHAvc`)7v-FS>_kdwa)YKYc%AwtdSoLRKe+s0A8G%tL;KvYwy}FG*T&3Ho*?zwE4vtt|`@XGbY? zz|iX|=#`wcrIivbE*)eYPi5p#hz_be%~{zUQ-(;0$`#RPWjGQYa`kgKci%ldU6_Qw z?xH{PAtZ-Ozh{i}k1XipVq)*_d~x1I&rIjt#c9YX&Ww3mvEa=(t{C|=+p0H>$$ShL zWQp0%s@b+`CC@!dyq&L{x7()Rm=m+uh^^m_l!(GG-&7_@6SiEWX%;?9Sp8YtvL@1I zW2Y)r8WV|}r5^je{gXRE{lNo0lePTR0w?`f2+wbs8-zTAj~>^R?rh71G3Udc*W)SE z3hh7&bZ`blhYL&LuWSam0%d0xb#ijoDmL`KyhESv7Stga-Lt@Zj=b0v7PR$FOBySueoEoe4Y zyy|+TwzK82opvZG>?P^0zuT^GKMay6YiCi^%91FJc^bw%Yw#>g+RacTLSVEe(^uLkoX0ln) z&z=daXXNR|R>Ualug8@)Ojh3-AwL9qJ#Cx+(zQ#O*7d%dtodWp2)ReD`)I#=eDpqH z_64I%Lj@rvFrf=AWg;%pRwo6a~O?si1U^CbCWod3xeuFd(Z`{KBJbV7zvW-xcR z<6)20uP*vQil#Vl5t!tqY>_kkmcf<@s+I&TG3D^TEtf8|BYs^DSC`L369X?N^~iuN z+Aid5kY*D4(qT;d)+rEt@eeu$GJ*MjUO+^8MEHJbO85>>UL2kto}6{ZYcKainI{A) zCE6-QZws_okmIm^rU=V&ScZHBIT1`S5wen7g~b+@OX;NIT z4Lv7e62`>s^XrEv4_afI)IR>#1;aMqMlk==Da>bQXl@;x?2npTH&AA8M%lNqY7%`D zCQymWl&G{qCfY$l8Ax+SvmmX-t7$>`y44<~*%(h~C0${@j8Agr|h`AD`nJU9?>e$K3i} z*6dr#a>`8%fq4#ctsMTfpnotj-KJpI(H&&mWU`chTi0=>z`y})nBLbZ2U3folOs2$ zw^0amxl79JE?4?@#ROa2M||-9)<>4UcMSCZeLdGS<<>t=4*EOhx%CPCI6dtyeU8ZW zuPrYv^)D`l18;yIo47eP;S4>>pSXtRzUS3{#@?_=7`jaQi%THF8H=jIPS*}!{ zwfy?Cl_%Be@^Xzn^VVv0v(<>hB#y!`Ny*6z&XlB#Q51z@31(4=MH@kA)5ijll(HUB zmK)^yUqu^c|M8LQ?;JmaFU+`=$usy0GWMUE%$6M=9HFGTcZMNatP#A4cG%&NvrA%y zoL|<-EXy2@z`qCfmt*YtWt)*Hd%nk#Fp83dXEDnn#&=VnMIn!NSu>5JB&)P} zELoIhER9=H+>$|(rLq}t6|gi4gmGJTzW#QfPEUfK1>;`* zir0H=U@7ih4j300nszF{&Zx;v;ZT0Xk~CID!ACHgZF0W=>nl1bCLM}S2YrO1p!^c0 zLNwTN(+P;nS&<9V0jtbBt+HEI3?91rI;Ahc+RfI@-y&cCJEytj!O@E@eT$wQ zjo5ezGQTs(SFA65^4hV8YHXFDZrB~MlMw??ZCw&bMsF%ykK-lK;ow0N!j+B-d)O?!@Rqc87#@Id#LzIBZB z^94x%*Mu~iHY1T<9w4TUswH;NA9;_fMV|YT+>7kjEwXoFlvljZ`juGhtoqza5HNCzSw%2%dy;j+-RhlB_A>~_|Q zYuaq=ru6O6WNbH7BH3X~MYBjBk{5Y-I!nr@Ddv-h?A`3GEtr5O_wg5}sr>%I3!+?m z`{Ult9Zi{$&0kzf?#U}k<)sjk6Elxhq_M$OQ5pThOhW08Bs?kMF&wkmDz%i;Fa}?N zPLEQ`Ms`z!)e9!K11mDwwwjrCRdJQpceXPT@%3AC%>4&k-X)wTO!3{d2~+&R>qv!M&Y!E739)YCGGOSzXy$raQJ{ z6Il<`u468BS~8xuh_Nf9U5e?HNXam>l4*Z-YG;4HcXF~YF?!IJ@V6{*E5EcpGq-cF zcZ3Sz$=T7k68lDjz6o>P_Q)u);crk0fyxC&E43S`R9NhcA3 z=$zR?qM?k66&5AwABhqz{sLpm5)Gxda_3gJa`dnj!U-w)jaL}tsR*{TtyJunCe7allo>mgAS7fyQ$DrE%73TbDCJkVvvq1%~=^nRg69EW=#qPPcQ) zV=xXST|udg-!a_qg0dF+6GcZreaIykM=>_dY&nqvSpgj}^?p_jK5(Glp7GG1T|lzY z*ZD^?>CAi&=l(eRX%MN@U~49oWRn8xqsDSfx)(5VL#bh|G6-d9lVdTu;}m2@uoWgK zrF5v5mpVG-_$!2nptwcf24$;^soUD`58lI>5WlOnnj>%gH1 z1I-+n3o`7EgI-Q<$!QeyffCLVzMZ594VX)TDoNo`7PsiK(fjdsP4B|aI~@39^(hmA z{g)OvZ?xopah_n$&N*D;+P?)?_KI7w@IHDHbv|UZw%{^Ljh`FtJeOEkYv+lzQBm3H zqzO?D>)Yp2vox!RjA$KHNQzFqO~kvvyr7kqo>eZ%54nimX!FdV4NvZg2}2+AbPnj# zm#5vwLa+zdaq_3uZcaKthwK0S!gY;gUUTa`Ty?MS6W#vUJ? zw)U|#MhS>%>%v+VDd<8OCYqWjVJidwAd*sziLuyS!6O1#hoT|e_Id)@7UyD0;-kdZ z4b?&qJ`G#5C6bea-v069S@oDO?7yD!M`uDJ+#-$_Il<2gFR1 zLMUf`)1&+HjuYFx4}5xOX4m7V7a)y=$p2tQ!)1Q?@y#CjhUe&Wn=qBhl(KM@;hUWi zwcy|r!iq2l@1O{mVGzfHcUv8od(-p@AWXp!!#gq$%cXQdG=%t`mKu-73Qm7*7OOXC zxIAnjdxG=NF2EUjP_1cs^)>CM`=Z<%uwAK?^i*b>N$$DK7=>Zt%t4nA93sguH%xTG zhkZJI<6uKhH{`R5kYK)yI_ zOqTNkgmd@w;N)mDNPKUYc@iaLyJ<>@Dkxi6jFJd&V*<&p~73Wa`4qZ9M0#1ML4g#0q3KWlas^4_lt8X z$d)nwE*XbkwMexwSf-5t!{B)eVr(R|pq%p^7863uL<#zbfX7@E*mDHwIR{@4PG@zJ zC_`Mkr53LrJT%T1zw^2R@^cF+AfKOa6&#(tI6d3nJAJ?AoT3#@7?wJ-*y+GLf`aC( zD_0L7v4x3AETxxYlL~AaVGhp&D`W&Ro)6Ui6m*Idc2Bj-G%6|y7i#g!<3pG9E~a7d zudm%4uKYEE`FrQLX-P~0C@Rf;5^Ax{^r`vVYJ^Ood5Lv zfWqR9M6 zK)2no0#BzXOsCut%Oz1j?A)YE>cwNM4{gvd-@a~}|FZ>?Ab**FPUolo_V$hrj>ZJ~ zjhK=%;aC0PrPpH@gG)Q0-wyia5^ovgSgFurvl33SP?SE4CM6%_Kq8IlCZ1y{y{qw_xM*Vu*{DVwYzNY`L zy*(HVrbhkG7o^`%U-+^w&ZXZ|rGC|`ffY)Ij<7bJZbpGR*30^&1zlxM2bU` zWim=d(2&rhUb>y2*uL)cN8R_;E(z;$31@^{UYIp)?L?+mlOhB@Ok<*7uQoF{~K z?s$Z~g0dB8;Fm1&Q%ir%QiY~SVd zpw~T~t#jOJ&>sTOQ`NHHUQmsOkKTW6++#+3=&l}m;yHMKhsQoo+c8;mM;5j!i}tgI zm2nZXxV~1CI~4u63m~!eJQuoMF{DIf*nar#k+}UH`5%lHo6>n!k3NmQaEQtORK1AAb zUbqm=@8?bvv9qp|+Ps5dRB{}uQxM@6GB0c)vA|1y##!7s!59cs-YwK6$%|)LQ&Nxh zph@pK7*^MBrYzsRv9$C*&F|e2>p0u*jtSm-6AhR#JqCVpQMa}ihLP56x1wagvY5W* zn|WL9X4Yn`ytL7_6w$0<8K-1A%|sYOyJc01_J$4pj8!Xv-Lb4ep1vK|1B!_mrGwT_ z{hf+el~Sk4Trk}09h@!f+J5-8=o!J<`ub#PdS)hTmJU~z zmZo6yYp`oQHn;|x`-36p{A$SAphn*T{mcHPZ1Ffv;wT7qgLtB{QL%G&bNjb(3neR*wV<>~6q%J#~Rx3My-SL-l6w)gJ--on1^g9_G8Do)Az z&BZ*}`+qyN_q~%B`;<6#Psa)Y@8Pbec8=aIV;50*`N5>pateAWVjZzRWmEds=DTFR zxgY};g&Co4o4LUk|DgW+ z_l;q81ar0a+I_W+8QHjlz3$PA!|wjL9q?Y>dcX)mdPim`LgsrTm>ut&E=_YGOExnO7yjs3nSxFkJYpbCZ+}9PYSGjVc zTJc-L-+2~_K&?O9T=!*lo?&<2?H<0nciug?-rX4eX8`aT0lrFr*9h?1LnJlF>o=)3 zD%Qn}AMd{C5(hjTPe;Co(;gdh-(C*w5Fzzym_XFbNGN$i0}AqS<=_l>oGLe!Fl?3? zW}&!@a2ivdgQ~xCfx1p*MAGMsa{G)6=|iHQ z(sV&l(`JHR7X&}oGU4gJ1Y_5qo_PkZCp^&D@u#(tc|DywIqq3o_cA5ZglnU5G_Yo$ ziCrT_ni|n$LQBbFP1!tm*27f@BV$5QmERwbvW#S|wZLAU;<{7~pig44J+w+;Jc=`^ zZj~*XmD71pv4AgI5G?-%dGX}Q)Qg|JIHE*&e3|3kDA&j=2`4A5mI#w&3(GQQN+~Fl zf=*LdG{mok%T0pph{aa6;NhtE!=L=j1MalkEpXiId>h-)@o!d)4;m~y9 zg4{9$SGj2TvDBC{Xvb;BO;bR8l?lNECZZ&0idYG*l2Bxlb1R}OuBR*Xi55$}q?LGn zntAl0sQXE~?Pp0`U0Htm?1{fU8#}v4y|cyJz7I+X|L_d_lY#dM{MZ2gx`{)-vF+P` zU+6E#L8aMj1YuSW$s>C_2&14059~MEDv^y$5z2{7nIENr%CaO$lZ^fk=yA~RF#Q1k z5<{oi!zhU>%PnO5g1&14<;ce<&Q&^Z^4K<=#ea6=_aXMguJNCEncf0t4*iVd8KKZQ zt&I1Knm53&;dCj6eYH~tiyNk+3zcbdDm=-xU%>TfUh47VRv7UTKXU~rj4g+G(DcRF zC63mVvrsq)1f>m&>tRB&$X`UKmagP=tf9A_2;^&4rCoio!9+oQne0Kv#Cp#+^#oaL1JO+H#sTMdK{TtTv9B zmJ$vKy4dm~s`5BXD$}a>Cl-`cev^Ry?dk9c_6_#-4kwaPcZPRx<=1^m|NCi7wwxg_ z8r-30eT^aK9tFAISXM+E#mUcL~DeB?zR<5 z=-Z|m@YO#c&VvOwPYwE#aQ+kXDbLB?(dp^&`@}g(g;pX1bt|XLGAQnpRcl*rh2bhJ zW=HZ;5KZFjt}SyL$W$tbSwbMg307__IEjmq=vNR0Cu1h6_@?QRgNGbCn|2pIxqh?T z{yBQ>pDfLu>exRxgzD}7Sk35eA#r%|>J@wC)jgsl=!${5K?{I91~gPrTt)9Z$CNeH zSKV_QoGEN4FFGBJz87Vey)d?8I~ndEmrAUKrq4qh1}2Ut#mUgs<2-5An>vn9uHT$G zy9xBs@!rw#>CyYdnPp^&85lA+v*Kux!37t26F94)yr@}L!E@BS$wRA7QC7z*o+7W3 zc0~HzlL3KSw({y1@-AsnAtkk)K%l95l3OP_RKoE)6)k410q?KW5@ zMV1;|w-dN&BFjZ1J-Rmtmw}f+Qw{%X{AC1zBR@T4uO+ zoJ03Qz9D-&dDvmq&x~RIw(ElTl-EJ9t2X6zGvZv5KAS;Fhq1Q zr_Ge(sOaumC2mw24Y`u+q=6p?UOU-tRU004NW-_%%G0gd#%@v-dRO!C znS|H{k;J-V4fAY;Q)bVCrhfXgsZw68ZSKs}M!sppsgHZz-pT3gNab}h`5*^7CdU2y z7Z`VqjC*xz+(%g7J?x&1M*Z&SI6SX5=v|=8aFJm&$}%YC<2obsouIB&D(aJIA}_~o zhB68=mH2&TeFRbH&1w3;=Xj~eT;ht1OdcM`kPlJ533XHGgzw%yiTyZs9lvA!=9V;s zFFrNhb$m_a;=U*kSR`=D1P(!D7+@#%Ad7Oy5)$LkO2i;)kUL2fJC!CvdXj^rD4a)^ zp-za&Y4R1SJXTnq@r6LBDi1QLM9JI9#{-L8Ow9Rv*KbY;|2mPpzcD3w5GX(1-#;9c zpzi22yupwj29sC)VahS~D9U0sZs|IXF*I_x2FG}D8d^Due9TE1iLBHQr}JX1qivbG7B^DyBo9?PiZSYBbZu3}qC)H>ihc2{p=6v<;vy?y zW7k)qZs@QoL_jgI5{bBpKZ5yAF@sJ@*3zLT@VL9PC(b@vhdTr!2&IDl`nhq+^SN=#+f^+3AN(}-#dYWLM;Bx*uK``|B%!MGzL8ELk*G(D zM-tmF2!q(I1A)$Up$rxkt-`f#45vXT7-c$?JaAJC#Zur+eq1={;7TbV3XlsYg+)(H zyaDO6TTQzE!E0o{bG-}wW9v7k&!E*;oxeXbtIPKWcES4fi=pkai&ym1)fHm{Hmv!B zdP7i}!68v$?P#=57e$lIGsy$Wv=fW$ySxrtX;WgDN#C(Uwta^BrvI8pf^P2LIZ_=yFyW1U#^e?N0b;`GJI+3DeUzu?X= z%Mr|;p9tb<+UJ}r5Ds+K!RJclPmX3Gu1yO|eAr1<(Z2qtF`q$pt06uOOH|KaGZ`C*(W!%PRUPTe+7tdwwk; zr^SOp`eD?$j5=W0i)Hj!-IR?=q73&^HjD)T@}oQp<*qnv!; zxpquj&b2_&lk&OR|7rKUdpZ*iPfs4jDE5E3fOq^u^3p#xfAwy^ySINb-k7}4Gf9(i9jG{r!=`P;Sl-PkYa!DvIHs-} zEU=lS{F3Eq=xKT!LeL`-x1WK1$g6j6f8^Rn|K$Zf8e25KK0mlRyD@X0K-lZOs@K?d zoTj+(!#Y?s&$m$?HCbVcLJ=b_3`1#2#i*20YEDi!w-`DrfZ0-uy(Jn*(5bD?+ z;u@I4#Oyq>dD~WV!XPKd=lcf>sq};T=$~1?dCCBiTHiRcbUr7abuVMCd%b?I!K7kX zhCy#IC$E5GVWktm;x2Ir%Te>sRWh1yryK?plP5iXYkraLjnrR{@6G#H+Z2# zNwoVmwV?-<&w6{tbNs>rAN}Vy<}b}0z1Z&_pH7Bt-fYN&8ABd;vM$M2XITG|IPs;O zR*(WFW0bt$ic;?a62P|HTI>|WFOK{0GBIhHQlgFJN9hWaQdG={ z_K90k@Q1ES_j?O)o>r8wQ2G<|2c&0~NAHibmD{^msU{ny&(g<4_aue@jm{qF#QW5qe{lh|`wg<^|9EBs z_~6CK(b3WVI1t{)V{m#9{eYl6Kc{19^NWO@<>qnJtT_pn8V*1Vr*N zoZwlcjS8I57{#unCChQ((G?LrFLFIGCGqI_Qi}g5mvm=H^e-)N91u%AotC0s6GpuQ z#hAg^lkzeZ9M>3iB5|0990yB~fuo%b@dRSXrL+QBdTKcoQ_JzBNq=%K6dsnQ4 zXu~mg&mF@Nm0Y2pPR^a>n9644pw(a+ z<7)JM4Z2=WM4C#IVtEwfrkI+;sVS4fTya`SC*?Xi`RG#c0~RiGA|%?BY#AeAoG4-2 zm;mZ}xa?z$Y^QDRCpgX&XZ|eE`{zd|3-gr+%?p2Z{pK<>)=7VUuBJ4*qI-wa_v^bV5;dm?-_4jYl-)oSRz zlM2kO&kZXb9G@Q_Jf70sWSsXOfOo_gJNWeVIPY(hlOE0=km(*Co$j6NE&b@~(vqZ4 z-Nic(N|WZ7eahtcfJk9Ir34W_q|+1@Re4djjEXtNzZ9xO7Oh$=i;harSz(Hd*oiB9 z2k^#mT-~hJTAcCrPW4%|T3xPguB|Vxulco=93 zvAV_{ax$a+`_5)52UUUzRkH~1o>V|i6*w=RM4YEuc z+#Z4Cm4URZgW@`o4P90;$kYp5W^`pnZgrtEdO5|DDKK=C$6zSTF$bU8!zrCANyxxu{qL)~W3L}tkI%66^l z2y8+ZJ5U&-OC`elznJr+uage|x-RH$)!3Tjw|EDVPbALW8%y+tQ~Ucjg+qlw5@o?x^;mu*TC4P%-)=@OSP3WAgn3X_^d)1T5Kp)(QlOvn^^dniX` z0@ooV{oRjKvU4%cD{sJgMzZt%I9JkyH#M<0nX1rX7loeLL@)c<+nykcFY+4n&A8ZC%&ECescHG;XHL4SU&%|Ge;ig z7tP;?J##Ko@Hfgv7=6oQ+|iMHFyuBI^f@Vk%yG=ik%Pc~OHLfFoc+hLXa;3NK9&i_lSY?z z1w}Rqtw{RuJkL9M;tJUzO45-XEei;A7TDVtol;1$d?&WI9GWrCQl4%(y&R#?=O_VH z^6^gOP2yl<<7PkLhv~I{yfi!dcyPRTd^TQgxkKc;VEx|J1yV`de`Q-jFi)tqj1p!7 zoePzFEZNYRYNV#dZIR?EaIxcc+0uqQ$@Xr|?lK*!nrQpGO1307PN{517?Xt7V=a-1 zq#ium$Yg9}GvnKj73PUO`x`gg0iU6?@E2c`k~}*)!nHa8eOD_6#jX!+{nCQifpOpf zmnpBFlM!knW-8<45SpA4!3I(0f*aFFtgfecgG%$XjRQ!grBiYt)m+MyYp<2=V0MY} z`jn@h<0>O(5*=6Wf>VG>NPYWu%LBH> z&%f&0o|BE6c?zbeH@`IRpJyhf?+f$bDnkdws@!-{0=e(FR6s2XR5>Uou^sZx8hddV zY0RxaA*YgM0 z#O{a5p8x)|Uwe#Ai^Ki>$?4X+duBcyTwGmZU5gAlG$6jXZvlIZQcaZ2CqpgDgF9rI zTqnXL&+<|M-!iadmAZCJ#7%Mn_F2X=vi=Bt0F|@UnCkYnYDGb_A#U4f!B_t%{DxQ* z2XElKe|S8ZTY5h*Q+7(yu8v-REW$ZPXxdv&F?!rLn0%0yaGazcik zDaBb3=}=}|i3qnU(dJ6CM2J@GCEF<@*A5HU^qqjFE+_m2nlKs5qL~f3f4!VZI9YtX z>p>+yCO+jWHg3)|eRgyHz5`n3d)>X0QBr;<`@XEz`DLxw9}egR3Xt-s11fLA&!I7br7|sN1&97Zci2; zE=XQ{^ySibjd4ETxT$ROeT4IWHLq;5cW}@>=^m8YD)++pg4M4$K4=ThvxIYBNkM73 zO;ZlhS&TXnCuD-qx55@tOvzs?xM0czX(kxsL6nJ%M-gZAn`#hb3FC31M9fqhhQG7h zjM^C^8XhF6FZgQ#^K_w+KbT0?M+O(yM*i`Qo4P7k*7&E>ipcy1%o}|PqdbLqo*ne* zh0B`7Y286sYKd{mOmOlNL)4Dg1}+$pC&z|4{ew-=vhFwHXKpk8J7o) zz)41jN{GOs1}37koV&?$c5ps>&g&t21B0nP!pApmR-RtN`LzX@`vVEF{Sh# zI$4fEcmj)WI6Z92IS;7{9KA&5Q=+Z4a!M*q@zx1b0zKAjw&nRGdKFAw$u|Ri`~J&^ z3iLN^++0%pPsyA7(0mHHe{^!z9WT$_1z(8|YW3luU%T*`j3m;OvWJVIQj|iREvx=T zJ{s|bGy>*t^76n#;h;uAKX>vDD0YVoUZW&cR#Ec2z}0~kzk7k>hHhqgwB%v`p)7Rn@?2#PQ@;{t*@i@9mrn2D6}XqULlEY62# z=SPbV7T;K0{4kNe+_>2@fO^w+%=Zjtl$!2`vOgHwRJ1{}xgzq1kurSyWAX;u8D)2t z(#gV%CWUhdtB@p4iZv?HL?)&yP+Qb`5UK zO}_KNLw$|(_bo_lK1U()7v|)xiEN)8AD)djMDOUUYr~8FD|#a%nw=_~ipN5tfe;z} znsABJC6-7DM6S?zq1=b?=A+YVIRs}>2z0uDcA;>N%ZNB0ePbA&lAFmal6veP$+@MN zgZ=a4lZD>nLB`C!ZHzS3tVashQ||%Q>o1$y^qj&qjJaMKGq1xn6CLS~jQOfG=K8EL z!|MIikDFqh((cvmtXi$^>};>^uC<@Z-Ds!zbbI6J8oBVGvQd@cGZ}_aeY3jER@V5A zc;-xOs?T;eqv}@N5+MsWH(ROZTYPJ4b1T&K+S8}adKijI8(iAP-?sw#I;m!SaSH2NsMfFg7-#)R=2vI76d&3PD?=QV6x+&E<4F zxe&>3yU6$^E!vkK{8Y%a+WO}gxN2-B&EDId-}ZV>u5oS9gJJ)wU$++;zCgh{k45u} z=MER>D47AZ#4Hw7E_EoGS7&);Orm~Kin$da(?>e z@ci^>VJ`C^lY5gA)Q`{f9VfZW-zUHE6Z7N1L_NBv6vUCs+|gZ3aP~Rt*RO^t;ep&F zMisA=s73(<770HBw}Sb0tlX8^OMyLf!d61W8ak4&cc(0vbzxjy>R)3mEJoLnGnV*% zB#HC!W+i^iC8)P&to&ye3^8CY?5F03`DS;(?&d;jm)v9aYS0_-UP^3Q3n4J^M{<`SSGi`igu#>x^o)WlMX0%cc*qk^`)pXmw-4^2-5HC0_cIH+Er`mKnVh)29$ zFmc;|Z9y)BZKa=_bKA3CWK%D+_Rjq|>Ko zSl_&S(|cKO|JA_jU0z)EF6cG-rN@&Ri=GCORd!S6qPFn2cPo(%LXr70Ztwa{S*=CR zWP#tVRAQG^Ya#P0+6xllucd;^yiGr)JW6)5Fl!0LWTlm{(A1TT6-%okXx~mlZk>L5 z=k4acVDWpfg)R9SY`jIB&ZFec1mMvXzqSo+Z z-7x76<$Vpx{*p+LVFy80d#2MsyJpfdfuZ~cqo_iq@lz9JLYQ_WRgkD4#TmjxV(q__ z&G&CFfjqG6+r*sz!N$#9jsJy$qh5XZBoWQqRLq3 z!p;}Hj*>O;<&H6(1V^BAk8P5dw$E`0+F@GCB1~eTUq`M(^d!rytI=PW<}F7aJ6wOP z1=R`8|8RlZfFjE`%%2>cQD3<)%CBStotRR)BTX>|nOZ4V!?Z2QbY(!GtC}tc)EzTT zo2tlC%54H>RHjo*gAm9j^a_*@LlT2hPx@~Ckfz?-DUb~IoSl~9W z@Bf*Z%IVy0|J}W^hnoX_eZaUvO``?HV-?}*3vp;73cNgJiONO?b&yifx50C*ao-&G zjBUusr{GEw>K{4Q`tbomAVegIY-CO-A(Q0xnfAShone@m^Z&WPZES2UE&b8CT%5lD z4!UFU(|e;_%X}tc6!bC^Xi7n}(1NLi2e=oiG)rWb#feP<(-K)o$&07(wjfJd+C&BU z5F9v4n2bFh)q0#pL3n+f_Lq@G#7I|0}O?{>=q$19j7txeo5^C4qZ+ zjDD@gnc!RmOkt7(?ZOmyGLXDT+~q={0~cK_Djk?7gYjmzT;#{dZ(hEjr7g!3FoOmi zaAMj*WW=9w<|t!tQmTF&g5dvRLBj>NkN)>BOj+IBoum7Ld|@exkdk5Ij(CB9{DHHQ zllP@yMwv^HVmMD>29=_tAP0^*6EZ{29jc@z7bZqNQfgROg<5xpg$)6IN2V{-?QG+L z?;QP+$@Scg(Pl2Z^CT6=w(cLEznnJN%q`oBwL z(U7w&C1yvN4{r;pc!tt95yynFEXwE&$t;sTec3&Jd3y8GQ9Qo1Gg;03aMSVLG#y{t zyxBlMBftG;=IGx3!SPA=biA8;Ctp2_eT|}=rtDc2xHduzPH5zWom_XwSri!QLy@mT z|8&qRr}v?jPpj!G(qC&UDmc#Jy*=O6v(S6w?4NJYNR zLm(;nJ7x}Y&&fyL*^gL4xCW@1q~wJ%x^ha!k8|sx<3hf>(UzIjyOfdpZLL!mV0sc7 zwFz-P$II$9#X#xBl*AL3l3rk?jJw3-yyT_$g-BU)+b+@r%16HQk&E;5YnZn-Z~AQ< zclf`)FpZCMhaB!}%Y-t|G70Wsbkq=#uNhUCo2jo%;L7_uB1g+WE9kBpC(Av50vQL^ za1dJ2C&~^a^v#4Mzb<4(FdNLFF)1JEA&1^I%+D6U{L448ml-jZd!t+z9LC2JXwvg` ztEEC0wES$Qsye2quX#1IP?Wx*P=QRqz~)apz*s3_An zMx4E$5LYdfr7)6palSvueZq1M6 zaznUzvqk;`6a@d?G3E;uUJ!fzi@`9FDJQ3!LRE-i`LMiwt8AjUl?i>@ z;~EsR?KGz3Iu&g!(`d+0C_l_G_-jJ=6E3oHS`ys@MNS^t*Db9>rgtj0Ey%oS@%cl5 z`75u<#`6VaYg6#ogJQx4EoOaUi9mfN_v+lP(X!DVax;7eB2Qz(!9WI zf`fD+>Q0op5YZ^;7jhUW8oMHQk55k_{8%NKma7SmTxKH6f74QRxlIP_-Fv!R48@Zr5=m0uU9R#cE1UIjb$6rD z4C?;V+4SY$-IHGTcwsm3^+Tb(58=eX^#hm~`n#Jq%T9lq9>8Ci^C(Bh^rer7o90Qz zt3DgZA)(KZyn09-9v9Ms152vJM=gsfXgWZlrzem3oJInPgwUHThiuv-ofIX z?&R1+cj$O^Ebh-0g?nB=bvB0(?Q?QOMONfF!?Y^0d-_WeQq|*BqP>_d4t)LQ&9V~& zaMav&?O6q$^Wj+$tC%zL-~Vb&zJKK<>2t- zsC#g>^u4P~O9T4U{h$VM=@0D%#uFrTZH(nO3Yy~@7wkM1jJLUrvlfqe+!QQ}aB`UK zMt;x^c^oE5oJK(^(llbJ+^#2nvlhmUv=zlkb-B{^y%ld|vl_L6%F1q7tF=~UcELVT zp3}I~gaV~@A3XfyAJ?}2%?sGz&(kybZ)T2&5=%KeJUTcU>mT0B&H;YPiML_2i~^{} zo{Y&=o{54OpOOU@Ivj3;O5A3(x>OE_xTjW_V|Tg$!-1k1SvrLRvh)t7-JPP?OHUNz zA?a0f1Ggs=zQsE|K#lO^t3zfoZk~?n=%e=tvG@tF2koTGkGmm zZ5i+w8y!l;yx@7Ty2WapU0&!&64l<8lsFcq2vb36dngKwILT_!;O&}}S+vEghVN>o z6aW3_Ec6G1{s%o=w)8z?pnu=yq{uo2`iHiz<*g@6G6%;8ho{{U?Vhj_?}Cq52_sg* zz1oGX4F)}8CH(5D-}gMq;ic_gUV65bY#I^EEoIiX*455hqY{c|a^q=pt1dR%yBjSb zp04U@Sm)~%x3OB^-qG8eE89D(+pAHnwMypwbltD6*S1&JH?}%edbQeWr5nphyzSW5 z##6;Ay8!t3-GlS);Y<9oPyg#4oFAO;_4Z%l=VOeko*&+L0;slDA3zB4+SLEO1&Plq zdIEo7KJnQ*IoaDk87a5i&&)4+{h{Otim0#>(H=?P6rb-WGxGAaTN^Wy zB7HU_n1^?UdFZeCB75q{po@0AMIe#);CbO1alswq#0XK`vq5JhrJq2JxsbTKfoFiT z+JzRVZ#VJ+O<)L{;q_A10Yw(6ve{wP!}F8#)02g6<#i7JpB#=ci=&g{!*Olu^+dfl z^4Mh_>GjBCLv&>55zv=?pV_{DNqjFAB4pg~OjV!ynbV07Nd!sdL?QmEG|@r8Oof|B z;zpoUf_@t$4Cb1&p?tt{IXYM*XLu~fcDZ=Z7Cf5=pRI_3V^1tk+` z0?dlV&F}x;7iHG>xGUQRxcS1I6VNOycam^M1JjV$H6UB=I0njRky#3jGM1WTo%A~K zbX+yirDiJTOR#Q(tFA&Tep|`pLHGYLkMsWnSPVPqIsO0uABzYC000000RIL6LPG)o zHBHsM3yh>|S{~MW=GM2W?yCN~>aVK*_T9hl|7%8FU42zBIaO0i=EiW#(+uW$dYY=gfS5kU^@+2qy3ZP{bvWq2M7D7D{m9@ob}Hw8wCAP zFc?$@)sYd zRGn8;!rDfL8%ByeG%9yW7RFVWD@t3bGJHF)3R#tfjI?HwS;cl)7IGOT+Y4~-P2e8? zDdH)rEhn7@H+{F}!%K7qNje|UV_IXUq_-`2W=VN+;rt#-LB2w>+7 znW{7G#1+!!?RKtDV+Y zsg?$B1g14XtOU6uAy{K6&f|ambvXCmfJI;WjUT@B8{fZjJlpBLSQLauFWMGsS&xDLOYoL4I6VK8DnRtfrc)KU#=nKW@u?{?XAX-uKe6@?`?VG;Jof6zB_V;F@% zt0^AZqD}En7~O7bZRkJk2w6i9M;HaS;o8PJb&`cWmo>3`>E{h(T@4ERNl zv*CFv8HGfi3Z3$FS8*eykjz9ZmXdRF0F3h#-c}RBN*6L$^sBP;HM|=nIT&R#Ngw1W zygfS$2QA3g0C}U8G@3K1UhyLLkcCXm{5NJ^`_jz+6oEgOd6T{4XGH%_j}9g@jhXk~B+|ciiS&~ z4m;L`X>$-1hu16O+=lqKOBDTL$T6u%L|TeDr1$rF$EQ<=;{W}3=1}_22bU4@_bwyk z%ys{1vgxNYo9>)GJJ~xp>W)qNX70lyJPg>d!uvuJy-?&F$cs3Fog9X1gMJWME|d`D zIbGYGy+H>3Z3_tuxsIc5X9DysQ9kdT%Zw|97)Qudi82$pvy?%S(GtT>T+Zk- zgJjUQP1||v%~alYdHboM-?Ss0Q!IT-G1b_(pj@YooX5iIH9e7p$j#>aVAe0558fGk z!0zLcS+A~Nr6Rvc_I$oz&-4%Oc234Pzn4c2?8SgvM&z$5Z4g$^xXhB4kVLDIZb-zj zm?tWZMA}qLu@-9)2O;#Mtg$Oou|s}1A+DEIh|VdIup~2elkBE?hf;T|DZN(>9;PW5 z+HfvgOh)njH0bA-extlT^&2yT{vk5xe>OH~{7X+e&rS|0f!X&k-x6bT0U6?$R9a}t zQ^+kCLq7>g2FVqD-Xc$+Ew}|)DCL6`|AYg#qp(OxyJ|Yh&BP}VMO z!sxjfPW0qjm`^)*2=j|ezY#3)8;)T9V{?Av@Y(*+{=xC#-WcdxqI_Y8f(f_{^1s#x zH-{i+TyENwWRnx14^F=nM5BpvBLKGHKniK{f@pTp&fA4@1(*tJQy?Tl;y67Hm&5Up z*Vn1I-ftYbsGu z6B(}Ry2_1=vL^kZ`fjVaZB0918;xcd*P=$+dSrKsCQr(l3tb+&iZFSW2OFjmMjO%A zh71!^(z(;JR)4gyn=Qxrl5fNloMXZ{zKcNEx-{rnCGR7I^YgJgqg{U=2L0i;-}&Hyo;v7giG%()0sSA%9Q0B5 z*~#(I{?P>H+nRGV&B%a-LN-W5Ofe#I&NDNkwEx@+Nql$!zD#bkl&`D%4;BADopfr#X!JzNZ zUvETW@*Jgq%4jHdy43jMlx);h^IDv{cT1qBIG?Ux%?Q6pU)xyl8$_SG-TiTi=>~p+ z4Tja~aCpIkGaK|qg3>o+&K86>r|?I)oGyHfBi~RMM|{{8NxLBE=|7^x6#5GKi4j#c zZR_J5x#Ge$iW)s2)TRnuAeGdXOT|U@n#%OGZsUz)-k+bt`PCM{W6BY~b)l5E-#t3+ zoE#p#PoOyq6{{E%6OpS)GS(I<(!?JMMqsyzR)E>%K%AV1l!Shp6U(3%6=sYw8M1Ao z%%^P&%p)fsLS{~XPMU^VtmWOSUdz;=|G*N*@xA0Y{?nP`Kr!jCL;2vCaNHJU)=yH3 zWbn{Nqv}S?HznU;67sSF^&-0)8}baASa!-BdRbZ;!3zy1;uCT*TqSZr?+59KTx-0D z(m)kEDHAQYT#oZ%Dd|o#?{}9l=r0h?e{G?Z)Y(7ioE)8wGs4?IJPHP9ea=u1CDc4( z6v*I2Y>u1-Z7ItQ*{sTmOsh0+3*yl9zk)2aok!?j$u=e7))e@Hn=QJe`Nh?Y5Jq&IsV*2X}Yt2dUDV`KJcaKTjOl)IS(HvNmy@i zk+N0`jg%;4QOt!+IakeCke{W@Q6wo7#7QX8%UBZA1Hu=H6mp8A84(x7Sjy=^q1I%_ zY%xPyi_${JC?m>Zo~7Y^FHKLa{43_bpIZ4h68Jy4=(hKdPY+H`Iuo~jJ>y_xv_pCZ z=Yy~xpd~iqe0Z^&l)~DY)}pc5sBdra1a;+{5&v_sLFuVw`HpC3SzA#U%qcgg2q^Mu zn>dE4(WhCC^f8x(&KXieTPW>2>*QoKs(IOK^2EFB-1aYN^(U6l>R%#v^50F}_WtQ{ zhj_?ox4Sn^$8Uphl^lGSWRj?_%#0C^QW(Qf_Ou{-l)#W5CVnDNC8e(=mMoa!r*J5b zn4Cw2;B5g4h=~t@vbGk8ji_F$%#f4P^!B)}af^TaoqFwWn85sX1oQSQ(eb|}nE!_b zT7BF(oD}hHDw4$%9?6q8TAJK%o!mKnjZzgw zz!Pl-r51#!Hfe4|#+lY(L`hB)DW_s4YbKNrHI~nN%t&?Pu27yD^XJyDj@A5KLirbG z#(Y3IA{oW$ICr^?8C!z;f{dAoL?D+#IbTYY;?RVRd_NW}1fQUSN70ix6ht{?hZ?Ob zhsa3SbIN73?_m+>LQ|y7@FzI^dCEJJ^jc#+xXbo<|I#^s+mf2cFA~f@yIAw+?jIa< zPsT;OTNpC8=NCgtu3^i>-Xz+Ej__s9GRg^U;S2c0Jscx6Ghz=Mt{>83Ov>U*vk-gX2TAv-}vs z?NC1J4Jy3>4})m45;rPwT3O#=v5XlLLS%vxn?@u;u3MRih|L*hV$poul2*4F@i@h; zq->p8axpC<&>t_dT+l<~63HUH5qxVG<-v@|pOor;bG@?}*E?Tg<$svK|Gq^l-#b3u z+dm%r?OWr{Bcg0%j=5Gu(j-inJOUZJ@l}1K>SW>+EZbW7d_`sjr7vwmz>`1GIr`@AyB{#YBjYsqqKwY$AX?#ts`mU{f#`V5u3D^5o^4ouVAv|_F`+JjN$lHQEI?I^! z1v@Pcv=AN-DL5V8G8 zMp>qGqGZ^rmaPC=W)vukpoy+mqZ}8`h{Tyxt#Ma3X^DJuOs{E3SJW%4zHMs>%M#hF zo4Dy3l+LG>Cq|f3jhA<7rJZ{AWWBz;ggP_lJIDD8>sQB@TI4s(tTldkN=|$K@MJP{ zdK*jTVJ{f;E99NQ%1k1B#-d$@M5O5mRu_Y%pv6d$6SH`jhP1Jw^wCP=RPNnFij;;z zqe9J;dSRUw@}=V~X<+E*U|1NjQIM!9O1!QD~WriQN`udm&PS zMWQH2{46IILCk{48#=axJBFfBEOnEb^fQ9c*|gpERFHrz$b%QCRQpOQ@f6HAIn30+ z4=M60oZVCR+`DwoKeQx!`O?jmm5sM9bHvW+vxAeplkVZT^KuJ^Q5g(~fhUOuxeyA` zjFN9bQPHO_xtENav4xU1%X8!L`=)UBbfr5Kh zj4!Wv-1(%(+biEXf%(saZp4dj;}4NJ|GSGz0o|kS!AWOKs^@UNxWt*g2IoL+)RJvc za(Qgh`j&86wUqA`?qLm?VLiwMg+Nx%>(#BTC%d~@rt@aY>8xl)0Z}~HDw-`Fl`&$C zdMbVFTEQ@y+9Kyti<=F(kiG18pLb55A0Az)FQGsF)+_z-4?cr=d*(d;`jTMykc|4L zr<~((?|_{2A!Uk_w!qCSIS8tQL6y@}2{`5B#5*v&i)lKC?G}`eh<8Zor^g&h9jQf+ zkX}W;f-4Y=oN`ADrjqfuGl#BL2A`vq49Mhb1i6lz6lGf?<=0p>{`Gff)%~+eoPTCX zF#H@@^@nG{uuCNR;NY-(IKlb#9+~xea?qo%1ie0&0qX~tFJc*Ha&?Q+I@C7+riOzc z5QQHSqo|hIoEw!GN(pm34}#GN469r1c!Ez-|0HY%$3wX%{YqpHHNy1z!N>01W{T5f z)*mcH%9wUP)5QS$4A6WOzvA>RT?R*9b{e zhHN}$lpoH=!h>$_(s7Lc`FFY*Fg55eE@2&L=Kl6#Ryfxne-G<@1?BK;5JZBtluk{q zGEpd$K(-~BE`>It5TR(h!Vn{gP<<{?PqISN&%{WurU8}*PLgAL3*XHxIiMWOPN7^) z(U8+$^?q2#2S4yJ8<_r$C9LCjC|miig}&|a$;rWFj`tcT%zJ%;Sq{(6EaPlIzw|1s zHyZT@!$fHg7A>vvH3~GfDHC^?^`Jb)qE~|b07?fP(PNduE$1oH$e6oSpp=Ti4-{Lo zmgUO22&~2GP&T<@PFAm2c?zdoV7U-pqv0tQ?Gj z{@K8?p5z+EXl@&hs{9-8n%Lj~_Q4$BiZ#FGg!zE5TH*AWu+h+XVI0%ru;z_E40}7$@mdDSTCg7&yvH z!V*8p{nmyNY+-Y&cY2lAEpyLrbll^~##LVT9mMPY(cC!R@w3ieckkd}T;#Y7#B9(z z8}KBRNlSWWm%&j;Who$PowQoSmMbk8S=H3Kq3SZKgp8;fs|BoPvdu=crou{+=~j7* zukD2KZp2KD-126uL!pAC)Lg4&TS*jMKaY2<-{^nv15C4C3zjNgEskRO;s+PAmH9=B z+rrG)4kxORklod}6FKHK9CHTK=ag~h89D8C;RmJLl$|5`wViS{cWtuPwnlTnnSx>^ zYNrMEpRq-U$;bqci*rgW@9hfnG%XA^t~Rwc$e=&D;Gp;S_V-UtPL3w72S}WD-Zkuv)m+f-FnkJ|fkMhRq6K%KI&Q`!mo7=V3IiQdBDJ^{2IbMqP zTX#C1zHyb^{nlI(esv-4bx6xgq(@Vv&+G-}OEYCskO!h@uuTeyj(A!-rwFMnMwZB` z3r+Fysp0V4n2wa0#n8XsM>M`uP)Oq|OZ0xAKh1rrD2c?dYsNe7c!-JE-PC=!CGG<| z7#9mHdSTz<2L7Ty9PrWbVpIwGOpdBp9-?q)l#%GAFme;VNt;_}8?;SYAgZ;aHc{q+ zqF&x^W7eQ3c)?wh5H0+)V?oH~elmo}2(d%%D^n_!6aemN@ou(1)ZVz-TloocAOB<) z4?Bls&__qd<80-|X56a`c=fEuM+rv?=c{!}$K+x&ZMmO|0Y6SQrN2Nh z|MkV`$L@aj=;)}kvWIX;FS!xE^tFK?B0X>AJjC!Rn5ECGJH ze4X}A>GX?@t7(fSy!$h=KI}Z}oE~?lE8;is7nZ&z`=fqvM$DV_Vej`J7Try4=wuX`8A^3!aQP(?;6z-88$44 z%w;;)+lfF}%VVx>T{n#|%r%&!jNCzwB3nyQnoF5#G?d!LU=0`|2Ai;wh?xTvLKe##w#4}Obi2K2`_u8vQCkqr7@Ebd)&kGuPw?wID?4&=dL$S}Ww@qhxgXSA|x z+hSme;$Q=_|IBY$BpF&TmM9>74V|i%#!h15_cOd_DUcv;+g84oG>X9Ku(6HNN471q z*Jv-@t*8F%9MG>W;$w&F8yBQ%=JvI24|9dmY@G^jGTDThO70t3hM=T~m>ceA&Ozho zDNyd%LJVZs1fZnFN^T07KnMXHM2sgusRj$>xt}&wMiIYT&O7dbRL$l5?h@Yd(`3)T zFzc^SKqRX;nU?);8UbxT7@Tp+a1x?-QgTIaaK&=r#%mOYytHFjvlT=$WJY|%D3KU1 znIf!)K!>GAkU=EKQWn_a!V>CQ$_C}^(loTu*s9fx-2S!gm3tBgKer?f{vCq(XXao& zp)~w>e>&4~8-%O$O4iSmv|jZD&23{dH+)_eLS+_|k z;oih}f!b{#LejG#S0OkN7^!3I*YR*CyJiq?{I9>$d}S(>@-0iU@V~gZI6Fh;d~k5G zcX&FL#=DWTpj;iV40u(tOh7sY)nqJ+=V%gYZY1+Cql)T3Iul1e=%=m~v9|XPr#o6GToeegLzhOiMLMUW`2?e!=_1#$rxK(t+K+M3acqH^C zluWg7s9{S5u@8%=2y4f*zZU?qek;!SQELnw#Me*H-0{BFG`6 zT2{xJd^dS+h)BLB5Z>uR?ej}w_k|^u4(!T(^+H8yVK45rUc#Oc{=Gq9N29Z9FzT@Z zxBXpW!En09Cwvagz-E{i6ybE?WocpzO^bFLyPmo7dJ+z8#Gf851;b+GeBNJ4=>vBiAD)dVEg^PLPuZOr^rBMAZ7jLZN1XLC#WLA~+G}cR zHVq>34i;($Mkj))%r62dxn(K95r{-NOos6Sfe47v0*>mO@`H9VAw$+o3;KeNSgcJJ zk>j|2(BL&nDQ`mRaca+hdE=^p$EQjwE9q<+>;RIQ`=b75R;4HJdsJvr377r z#sLup&lemm4Od{YV@&)@F=Br~Jh61kgX3gZ`s{ z{=@IQ`{IMdpFURp@I3Ud#70a{f9v98>D;6=oHHlqd@%Fjx|ebGHN!%a!J-H0LEr5 zuWGleDlLIcIX@Mmktmv`m29Etanjp+as0A#^z!t@;o;Jm=|_Zkr!orQc2fkLxjp^iDu1elhT)l(P>36S60ntlj}q) z-mIB)O{grg>*VJh3Lk}E?T0Qk1U3CKE(S+(DBdXgt))!;I@Wi`tB5mu{`*VvMMe4I z&#f%vi-(5?`-ey4H0IVg511fg;kQpPhD4lrE7!SfVW$&$xWsB4BBWFGdNm;)ht)Zk z%7)8%1i=+uv<*~K3WGSBizda^7Nwq|E=5ww^mRL*_nzSqJz=Umt7?sX)N$%Kih9aK8 z{+okD6Xo{SkM|N01iR5nGPat`ulw?(vvg(rYC!y; zKc2sH*--q|C3cNHxeqV+>A9UavgaYCiq(Mg0n*0noW^-j#pt>n^w+bUl4cukt*t(J z7}d9ul6aJuV0$NPZLjUDmgP>xDQ1IR2*E=4(XY=L2B~B6$W?79$x&p*!gysdUjRgv zL_uK!0+52w+x0Oaee{BU^p2M=$Gv&H=gJ|!wq$PXACklV>V*dG!QNr_=y>W#Zo)aH z#yuPjC=n5`S7R~RLAKiVBam&%#cg3xR7Hcf?MHbXdM!_j+&;A!zbo8RP5HW@mtvCF z;v2|`C|2Sx$aCxs7@~albnxTDm;U@n*wBcbC4<5EGMPPI&0P* zJd&%G2T59Ps!~1PSWl}~W=+d7)R6=v-k|7#N|SA(-;!A{Im>d55{j>acm?F#iX1|4 zdb}6FFu*>aKK4%Uk%Ik{=>7AJtMk)cGU&g$GOtV6IU)}-8B>2P*OsAoc3;F?9sm=_fJse7O#wqv-9pwtjK4iFry)+r8AP2pF=u6-k_y&Ly zI2PsmW6GHfa^Cn$6f#4+0~9upuCG?VZe6SQ!KdM~aj_?xSG~sHEUm1RXVtxK=h@NW z-tkn!?LB-k8;q)a)C-69j9!3(D=MW%m_#VcxW#c6p$z33P>_!Nb|vui7cR5z`;gxTiPET)MEq7qh z_pdI>h|Lf6dYJn+hk3wu*S84VrV+{Nfu&d+wc_-k&%)l~CE)oDJ4Y zB~-qKEc#E5iQQB}WpD4abJ7{h<=w`b2kfF(v4e~AN+Xd_!c&|=qUXZ~X05d5Xyt0J z%Hg1~>0}}>2%=nDxVDTX&rC*d3c;Dkax8~x1$DhNqbwZCzmMa%#VQq6YVkxgqTN?k z#_yYi%8Rp0wx^cZIZ7jM|NerVFO)%UgL#GgdbKG%@P6FD5OpKZEGZrmgJz%@1&i8k z=2cY`Zudd$k+%^h+sJ29s0S%KQC?|75Yl(R{2?PRG-*uKy02xBX?)b1S7|k7B>%HH z&56Z%$oC9~XM=t?s#Hg37nMp#?**PJO87LF&TZq?O~!FVhpbl1w8;|bjB9c76~wM} zBO+7w?RAq$NRFwbVG^4ORf9^Zk#Wp(%~WD!Dp|@^Ob$tk*L2PAcph?!^WNswH1WsD zoBYZvV|w(S2Mmja6xjquK{ASg1T*RwS#Ddcz`7>66IN9bramx$0AXKV zsDeq}BJ6h~D@~2Df}<-I5$391k3|KFy+O7^@CVi9^VIjKOx@kQN~@94eDe1f5BFVW zFSqa)?0mon{i+n?Y6axbQ{16!8*Bz~)RPphnIWZ7n&+Nm80EOXib#x(d#y)eCL;Hv zc_7gWV>-mDrN-e5a`}mbB+&agDECH&ZKm>%e_->f{NsO5=Daead;7=F4vvo}ONqAv z7<)$5IDu3nML{eC=nS&y$nq3+YLS6pKR@?(5^+w1aAq1Ub?ch|ME<-q0+wEMhO<$W zR$6>9!D7BJoC0Ndod&}E%J`kM%%{furAv$%qAI`rd-Jz)<^)u3<185FQ_0v^lNg+V zXd^&0l6iq-ua2%;D9ROn2^8swc2HFz>qd#xKwd?Fr!bw91#{eoro2<)Cfu=W>uXz&^NmJ%b@g$HZEWhTo$YLGwVYOqCy`y- z-QL_;UE5i$$a?-{wO%T=;+-OKN*q<9{}{k+Hb4e~ot@ormPn`Ne1u^x5Ey z{tKBM1!rs!qzMyID|`^eo3))syj3(~o7R+-b;`X18IuhQmAksxYB}BDqHbiQwyg+F zLt}!>>*7%&NY4umc4eRq(sURHjEaGoaP7n@gCjGmD>uPxq2JUQCi zJMK)znr@2k1q-UIZwFj5C|TiF`1qD5<>7wV6csv5@oKC(bM(CmjYIGF#2*+Y6E7-- z%b7py>Gkv44ywMAeya+vVedCe)$*me*C*p2ymC!%2J{z}R6VdD`mx24-{~@_C)Tg= z5yR?5Z!ipcXTwU5zBTHzYB(6hIHdsAmP45^(LhY=+NHVIHxu8)QK%`<|KSpg{t>e1Z(ZEV*gqtj zKHi_SUv2|(rHV0B?w4FrC_H+JZ%jK$&z!v&=5V0}n+d_FdU(fxS z#lmIKo)tFBVAJ;%=xHqck;_>4qYp37s+KPI$T2X1x<_a4`0#Ll+JL!*F%QpeCCw;N z#KIeS4_vu0W3@~{ZbTzXgl4@!(GF6{Hm8)Ea>6{41qN$0Mh!6ji1&i_ecyI2eZ8A< z`h-%WM5^SvlpO#1yTiG6c1i7iWC^vqigT9|^26@?g&CC~P+;7E%YA2X46~WQoO_sk zKNe+?94fQ9(qowYxD5q9TyjCViIVbMcsdT4rB#WL+5Lq1`Aq%sCzg~;KTR+<7ji{P z6Fd7y<2KhVL9T>VNPGJVDGU==E)d*uFVg1k%MreX*F?8%Vix&Rr=B*97e#PwRd|(; zb~{gC%JgPPHC7D@^4DIKT`Q*eHFdmuP%fRv`PFGLD1Y#|Ys?EOAC+PMmM{k?kJswT z?zZx(kUYhyEYZL)OoQBOtm;jbH?h)5C^oiuE41Wtv5i4bLE(y-Z|A0pLng$fJZtK- zL13rS3eGv>DVvA+;Q8s{e2MAsUJTXz^b(x0>HH@XKO0n$y}Lv-MBq_0~7A|!wD_1)r$f74Czk*Tg1N{Go=0soJH=8(deRG2nR)a zfQeH8023n#bN{qf0dVz*h4udI1GE3qdDf|SbGzvn}xByHD3zcsvhO2yNGD;kE z(PO1vE2?!RL?-0&y!+0V$7hb?i?VU`zhZ9roy=uzA6;tjFdZVCX z8EcXqK8Y#c78@$A?5q)BJ57+bYBRM$RFgyt<#saFEa%%SZ>+LiUC~O0c}0hHt2SH$ zrG%)WZJ3ufTVdU}e5++Pw_Dk2t(GPW$8nBdcK2T%oGwNCPEui9#1BAI7SIU!H@7WCGT+W!3u8t-ABt3)QSuE-8pX_(08v@t(kN!okYAI!BJ$ca&M)Y;c zEBnm$6Pd|GD?haksSXVpS*#sG?i&?V6zfdRP}>m53PJo(hO+)l5ha$6(eLO1T35GG zq_Cwy(K3Z3q>f{H9@phEcUx+j^C{0tS3@N_UjNUcAoYBA>*fGghhQ)L%BIBlhD$|` zxlzn0InCR;kX99;b`7i(Wwz~${jP8lQ>caT7a8agFlg)%9Ve%hW8NK&E<6V>AOwXi zdNk~w3R3qjrLc}mS3~8e%9jJx)9%*6;ql4A(WDo!+-aPR*jbOh9x}3LB&+aMwaESQ z;oiw~diuRhnDzX4^_eBYf)Dg-wIH4>oUe8iC^R|El&?S=zYB*el(r2$S^70^L<8qZN%%0-3 z9LigcJApQuN@WU>o5NnGck*)o#nH=7uk+%#*Lk_W-|Nm_Gn$DEt-t9>vbX0dfM~|N zS^-2e;eT03Fy|XIH}@YY}j6vwKRm|az8rJcrh8aUI^yIhsjPL3;S zc^xAlG0w4a##Ejqxo&0+C$re^(OKUv!>tFjaB|dXLB!wB#q2i#^NZOi*%A`?!}PVk zFe^+Q9X}%mczimZ*n5owsSZcO;TYl&BTyHk{srq@Bs{}Nv@psqD>}a(hb0Vu_f~sO z2QgWTGXc1iSa61(q#sv6a+kky?hD*ra=qmXZ^x;r^4E+w-EG71-z<2;hKq4K=7qgZMp6YT`6n`=#5SuZsyM7GM09@U>b*jcS+YY+6cYzFCus+Fpf zA>gB<=bh*K&yVTH!OPC`!{_@;Cx2Jpu)qHB#|ig8GKV|-^@BNojiUF1*}&cx_5B0wATHvgPwf;8}Z*~ z|LxCw{nvfnOk|{ii4VZ*$J4{4P1~|LQ~Y%Sc2-4)(fx zE8qRr*tUO}epKkkXI93)|H{el!7B0l|6pb8dX{e1R(Tv~H$+d5X;$=cd(X?6QySwASZ9T4{OvFM#>wwK_wMu0emSK_U;XO*<^aF% zf9>4+;m^!s?B$5s&(mZ2^RF~BkGjW46AAt6x#7&)u%LH-elFz**q<@%BpK;175HgN z*U*?&6-GKv87h=4BFxT@n{V8t5+V#3gl!7v>WzegbF)cLE|NQ~Ou_#!R;Lg+VlYkkd1N zuOK7V$O_FAE);8WIfYXG%xEq+`5g09v~*T?8AiW_S8|C&q#APfzT!MJ=)bUpG=7nA z{!bR?;tvn@PLKC5mwIpF*DDt+7*6r*ncNmQK$GCl3MAq++0_9p#;;CdtMy$b4 z!1J-?B>fL!IK=#4cY5P4lc499>a~Aq!p-M7B9`{vS!^0l7xX?e37Ba9jLs)`zqf-9 zdlWN+$~xzpYhfMJWlfttX;213UZLT(ce8rDT5;8!S1E%pOe-x~E>^qSdY3#(!fjJz zTw3DvddG>(;_QYKEQYiWvy3;G7nD+>v2b*BHWs+Z%3nPuKSAa5-}FtN|KvA+>iNr0 zf9=`V{A)(MxAMoQ)5N8#8Y6#?JjfRo+HCv#``vE$V5~86Tf_FH+Vcj-;VC($)cC;I zgTW>>8K*3eSlYq}A^p6u%h8pWkRWPn?cWSGE;x<{8kG=fmr$bQN;c__ry0h){lpJf ziCU0iI6Z#R*}H#*!*72D{QY2z zH!-nDHgKN1#%ft)ZNQ_H9K6i@@;b#z!vzJ*U74AjrB-t;849*UUnm%W-ayP&a!7Ec z9FxnEX_?NIY!{EO-L)T|jc5Lq($y(g>`H!SQE7j+7kOKtD-|9zBc5fH?a_ zI`@h!-cje!)z=hJBiwn#tcfM#Hy8?}M2Y-KY@yMhaoii@gecNt$Inj^(NoCM`Dx?R zqZi#dM}B%I3DH-6{9}Lc>p%1LpT5NT$CngmAwXhZnf{rHjoi+s0O+lZ3rZ?Oas!k^ z=8D`fw(n5BdWuV#(pK0mhSe3~q&WNKvtkyS+=qwH$a|bj8ppSD+A#1W zrMG`31;b36-qm`O_yy;6dh^SS*fQ1^c-GQRW-Wi=K&LJhzA4O|6_&!HP&Sly*T`5k z8B;{WcZjM;9#a_2YDrd`S9|Zg=$y>;=nwC9e0~b_-&{ffp*Z({%sM=a>T)-C7?o=1 z9{{9+w=oKV5Q+R91#l_7mPJ$BEE9&j04{R~lW7q%o8d5pKb; znUtFBuBYT$5^+fs!94dI4>B%%Nqe9`8C~HeLgBj^lvXcr2i_0DfV)lU@Q8yTZsa zp{~OPG%kggUKF@RjZv&QtoM4SH#F*ZKk%FLy-V-$GfUhwjQU^9-F!WL*6AD_PG$yg z<)ImIj`K9l6eoTFvH*1)U&kJgbepjdhR~cSL}pXug9NxENA2}O9duu?p^omFXXx19 z@$!~L(Gxr!nS%e#+jQr}{(Qyz@bo&M-+AYQ->bef=wDb;cuEN9pIz`C2S*eT_b1y5 zH#cQ=7V>j@2Dj?3m4H-u5dhpJZTqRroU-vkQX+%02+pFLr%=nrrDGJFh=0)M^bPuh zpmwO9V0{63y=yBzJ`thy{oJbVy?r@J^=`)(%_<_dI0%w}cH?b z#Za(>Tq%(QlOm~B8MY0e-Hvi8&z01ak3jnxjWHQp-=~*?(s}DB#qkq>wPp{EAdjlUUe{6#CZ_N3PX&I!lby=|9>l}3t_c3jJbU@4>Rghaj z+++RGP>wFbW`k1%_2aQV`|H-AX_CU=jkbZk)^^cRO}BqGfDLbEq)z zl-v*!MAT+eleT2Tij+u7ltxn06Ik4MnklW~|H-|WGM@U9-@L^B# z&CjH7;;-zc7jHvQAXQcJ*2PMhkCI9~g z(EoDDL^n1^eqgcuF~22p8!u8h4~Nz=MoFDf(0a!Lu(WMBXbey>ZrU2Mlm!M{9qvK+ z-T|6o0-xbT)wmrjFbtdfjt;l}XavR}kUSFidw<%|e7W0a;h?zKer9NFF?@TupA9SFMK}yEE-D!@H41N- z^oD>7nzNLZpuebymEh1W=2-nwE0jRVKbyi!vf@mK%ElX*8D>n#*)$$VXyAz_C)GK;kMF{p)XP`B2?p%{n?+Hs`Cqjb8Ajl= zaqe>)h0W{2`guV5jmXD-!}ndRaczqQ5v+z_xdcADuwKy5&vetXxK6_8^~3ZZ^ySQX zpra)~V=nWbF1qdc8O)pdkBf`*>IFMLt1`wFqZEc=K18z?*(zl`GTzZoL5685(w+mQD}m2e#>SCGp(t!%$mm;XRf_Y-kJ;CAdPFz zMx~h2nffD@t97ec%~YIiA*R-a+s2MU@+6Y6s;Ma9D#$A9^Hk*I;Cbh8X{LS$RHSz~ zxuDBe<)VI+p#C4{GWA2qkslvSu65kXm@jO#nxd|RihoAF*h&f4jOtT@6KlBXLs&|O z0YJ=YLp9sqlPD-l)EM>y%`4!PC5EDKdXP+=-V;L7`-0P3MTzTo`0mLhPQJu-V7m1q zi>_l{C*!s-S4WAEGBO+r*iiFh^b;|RqR1_zUqtS5cna&cX_RYA2sB{9X?z^a-zSA* zMuzD%lw0u?14=eDWdc{Z2t-Iea0>Wnu&lxsx8c`H; zm2L}bb|TGXr3f4KER<}g+^C~|4W%zr<+*GXakJJUOD`f(N>k&iyHS*j3^NJ^d1Lb3 zT-ean3#h(ljl4l`2gX~$YtED2Ezr}F$d{I{mPAlW{m4Q|zj?dhilE~D^pO>#Ls$Ohe>cLMLAN_ym9PE$X z_6;pNJmY*=>0fX@%E;jwV$2wGS5|weP>Wi_2d)c>FWNhPtJeLRQ{fqug)nzA?9S^H0-<@%erTD=U8lVfjcUBlsK7V-V*l>tTYM4 z3Mgm9q+co`{hA|qcd7={zhogFUcy4!WYF&}7&Jx3&dFqc^45NY37$$y_Y^wlSPMow zCbzj74@zoa2Fxvlc5HzZ#k75vlH&|bL76y|ri#g_i2`aGgnt`%J5V_hB5mAHbDm}7 zUs1l={wfj7e1TV=o*bN>o=)aLZiO))u_}f>lwa2HH4P}aLo&eMm}&bghFD$RHf;w< zGz{6GztwJYi>vcMl`NPN8AA7IJ5SqiB7oYr#gHy?@tU!lyTtj$Db=Q{KXI*UtX<*wmK}A#I`QgAE(szKR z8=I^3ri~gKjcsO&t&(fnUD>WYE|<+ts~+2OZA)*L?B>>1P(;oKsfy!@l$9ivLDooK z8QVKPe6inMYT9?IU-?b&AZpRHe~nE0AJ2+S$EVNsPxnqH4afI_xjzTCQl37;@rP5W$AE6A9rsH$z4|E^ctY-qFT=1LvDLI8O>wXE^GJw4H*hqm+~004Sp< zVk{zCZrS61JYZg#v+O5t(z2%o)o&|bod^C01oJ;wY=rF}9(OQ-4cd2Gm$W2p-OE9oLUjH4hF8Sj$jzC1q%&+_s#Srxjy-5s6X@5K-b17x! zHjkW1kTgr#5Q&?rzwkoHC7d^EGQ=_hW13e2LHgt*wQ%$Zm)1`Sf&h zOX8Nse8$cbmZEopRRW|lM);K%V|bn#GV&Bzca$(5$&^caRgMY(3cdHNUJC){>&3I$GRc%ldsBD)jI}fWHS-Lg9OR(4L z9AD`-26M2V-bGd9dnfS!S!6fsi}3#=g8%y#;O`zD?(b84^yiQ-ftT~Za{}HD`X2Zp z0e^7`JgdlIzuZb|TTjYyb!&I~Q5MuTpS)FiSgDpacH(qvn}q?3<7%s1+iujda@=^U z{3xR|e4Uk>4<9Mcw%1iPZSAtv&5cIw;cED}&RXkRqE-z;mDbXoFi9W8WmbJsF0Ym_ z!?5>a|LEn>i-VV)&Wq#ccm}=B^Me=rSDwWBM001Ip2Yea)ZDpz64N~M2g+B+|3Z2a z|Le;9e(y2nETH82T@@et^|RaI4@R*KG+sCEOC&+@Aq1-PhxSSsVIDI32AP6 zn^4lJ3Y5I_b{lnaC$NmI+SYSO+lE3n=1#6rlfMTw*l7U$!SdC)VYR)o@_)|Vg*<(B z&^x3ieIKvPy;wLWWNr66$XcO6U1tSYCY|=I@RQ4QX0?b%) z+r_f!>P!_8r!d=gZ6WeST+S5lM*7ypGlCdl14qW8PDH{##4RfL}xQyf!=9 z3%_xAvVSt3W4Hyr13MfJ`xhCPTzTznzY*%Qa*NpoBYnvg;;!h48K#||c#sA5ZOEDn ziDN6dHRK>N`kXRMji-e{DrBJ;=FujS>iTNyUAm3l4CbFKUtLy$mh0oiiOQL7>#b1^ zqBzSa!J$kL*VAn-u;6F_sV3VtIOO5m1%hGbOc9J6>0_b2_$V$!$_xWMIyHXe%xdU3 zIE7V5l{m-PwYNU*T(|W*Couo*OSkdvB_F}pR#p~vr@IFyd*~j3ki19ClcT<*XD}S~ zFCeRW-Vg2QV#w1Z#YUZBvG!NfS)MCFsEHhRJ2b9JC>7!O67Gd5@&rO8L`ftLo92+* z@iHUWALVf>dAg~iU9nz&5+*9yVNon&ovAEcZH8|xfPUP&x;uTz!ta6#{_k@z@2sEz z`#m>-evkai4?OgH)5FS;4?}Cu&#UZWI2hUs+2`l1&-lgJMOeKUoCj52tuiZl#nR)d z4tagOmIU!u*jU{tKdf(WJlLqU)|1us?e(?w)s5=IV14zihfj9c!v~KZKYUzXOE*^6 z9zJ}u@$gA`>*4032M^XBY;HWLu9Y5^A2c35ST8+Td-!O*v{8EakY4k!_GGiP`FLY{ zZTI1$2cLNUTr40yjZr^88!)(>l7`I6H@`AqFsEH}i?=fy(*Jv2+0qoFe6e!Z=DL)a zEQwXawd;lCj+~-tLq~`ec|DJ0W4Dz{or_pxm*g~$LQ`aTzb!$!2AD9 zr0Y9hNv1pd`$W6E_q?s+WWgCH?d|VQzXs_T#oTPOgh!}G^A&v~4RH!;*0u@tBDW!6_{fb671`&{e?*BY%#6z_6HDPg+XBIa9*f~`2LK8iMX>bqgJmDcHRtG3oQqAaMlc6O>k zrTlR9aryCshZ_$b)VAh2rW^3Z8|9jrMj^yGZcVDu!bmqA*QtYcy=^wksirUDt^i zMlBb$$)cO>4O7_6)OF5WR^+^rXOcXAEW+@;=wUDi_?s+7ul#?STOk|e{Qv+TiwFb& z00000{{{d;LjnL{57k=BZzS7Y?zvaT1PL}QvV~o?hz0)xi%7YAr(f=#>B-oU zn7(*CV|P_~)c(#_-{W`c<9ns~$NwCaO4ZMQSi4vHxb)4%q0;l?Qt5{{|HY3!>JJCK zVR1Sb_lDzf=?f1^rP}2MyEK=V=E7WEU7cOm>DBe+HLG4+8Aj>lWu3mH?4_yIuFTbS z{ld&XNe?5YIz&cXXv0m%vIdn@P-EqBQ;3w1Ry7uaC?RE7k6Bhb=5@wWs~JCvRke{? zr3I5lG*wJltW;=>sq(aXa`d3A;>P24<$3S?-t+vt^z7nA-s_b2p8%^wZ@#?H8wc ze?06BdUKrbit;sUcalg-EtwS3P?c$sIGP15ZKX6?NnsPMQ=0lkFj^=lRiXr5XobZv ziYc86tBm8s0&@Q|S_-X{rbfpfeMoZqhi=Q*AKevR{YLFa#8 z(YZe@rl)y6?oIl`InH;(xOP@E2~%82%{35HMw<@6WWY~Zz$g?*F3kL|b-)e4bIYX@ zz|jJDYnZ(u$d%s`I?>WklHh5EfcpuR@`TN~(~yrL$*12uVX zp(gpbKPg71`DoB9rh{Tm^Si?z#q^Qkq$yd8A8~Euv9ia~At z7o}fcLS0@H{RZl!hs5MO6Ol6>W zx2v7)8kaezjd9Le+qE_`Syw^9Gvn|I-{Q2xRaWC}u*@)P6+W@(Fa#~)Eu{Oiyx2s# zzfW?PeshWRktg*lNT)#hAGVP0_ojnk0TuL6@8I+`Ue{jbG+j#y3*wkG4j)vSP+{KW z?P{e`Jv8^-Lsh-st{#Q7-ResHNYg51}Ar9A>Wz{sT3hpz%{jTR9Xc#Teu;<0gn?aU4&%9L0}3ASKztx zH-t0(8UfvR4%ZXBa$fYcKd$^aZ@gM?&d8Q$PS)z}f0KQB=IUdOecfX(x4rWK8Rb{+ zExmJ&{lr5*n9Q-im2lHd-}H+SP(X`$!}StXMhhz$J(e}x5wway$4WnQ=i6x(!d zCRB#6%5-tKi$Bc742&h-@v=bXZ^`*#<@2+UnRt3hr;{< zkp8DFg_#bA$$TFRXbHGhO- z$(CytgXsXxZ5~*D1~D;bA!Xhw1s56=gmP%LDDhANBcLxhAdLS4pgn}vGOP;?a37Fk z)*vd7CIyM%myEZJY&*dN-GSVQG{!YCPh%q5u}FeV(DT`F{F`OTQhIlApO^k{3A0;Q zpc{^V4lw`rz0Ijgj(F1R72`R}@6K?4QQ!k1crJ1CGe0m)7}W^nltUPVpIE^MwIEC> zM0ZXSK`A??K?+Vwnxg$D5q<{oQiknT+9o*8NE$~WOPgWTJgg=$iQ4UQ+B(?)eKeSj zK7(VG70bJo)hztRG{1z%^3O}t9F50={^_8X=abQ*>fepxxF}#0>DqYdg*$36TV~E? znU;ci3d1p_?PmC6L3$riGPtBO*%MqO;IueCumAG_SQlq}6LLV7T%v0IlAXyJRJ`f+2pSLzOD!ofyT5ZI|eD*kK(#4Jp?q`SJ{&bnaUz^h2GLmdSUz?d(qaHV_2TA!TY#cTYV~$8J8Izg_D<~Qy z6+*&Oqc})8g~Aif{pxXvz6n^h$!w;W_U#mll3K$oRzds870%;g#VBjwlwez^_h#eX z)BNdfNqK*tlJYmp6}a##P;5&|9C3v!2RlV?P2i%j7aDHxA2=)tWsI)+ z{rk^nFY==MWY`-OU5LxGZvOL&*VEzF>wG*}y?%YKXfod`sx5V>hBYeQ-5Sl-iSp?V zxAj|}f3)qklM!y{-s1N7DU+^OR%>-pt;Ws*;@vhCipu%G3PByJ0x?n@>k~VtP!*{h zbDBvfDH93zHxNrhpIYj1*y$v!)rwk4D$+EJBJ%igSbbOzYR&3lyBgHv_QC!4@#nDo zhC$5cjj`7u*vbSx++hMgfC(II71T*FnDqM#6S%b^t)V{@twb6GoPZ#NGbwd!33r@l zLEFwd5*8x?76s}0<}6jDCPT%omM~WICytB>yLARF7DXvWvBi~LpC{36)k2zJ3fnsv z{r;@@jLg-~XJ@5f+d#Vd3ex`yq$@WPG@5UTj{3#V2y_HHy>-uAI*WqtWSTGM?nU<(}MaqRiS05Wyd^CZ$cOsx4{TBJM~-~ZT<4r#0ADuOeT3z`aXabeo%8)tQixg8lX+4 zj8MN-Aw-O0GDX$wa2aysNL;0wnk4>#6qzWFV2Eal{L&yu`5o1YADmQK*wECZZ6;eT zZOBkGS)7DC;vFiYW_bUD@ky2J<|3$1q zu^hcDN@-q<`@Q~nQA>ZSgoxMn>->TMMgOD^a=P?0MQSy3^QhvV2f~NKr{B3SnKbiA zDU2;6y10nB%x4#Z&Z?~wn);fGTC1DXwU9-P;QAqf#lEGMw)RE$70`dYR+Sr|e-1#C zjYo$@r^R$I$rnle?F_$M-v$fR(=-7ZNa1xVX~G3m1;T;iuaArkxcDGo)DkV?hE+-U zD3&~U+}5U34k(PWf;LLZwQ|+yShJ)eg0!s;sA^R|NNMN z>)ickJ978G0O;>;=k9zs>`f+%4ba;O$*bfJI!Mp+t!LoupUE;DfkXN23BQG`HArj} zLD>Xw$Rh}V2LDQGS;`p!oLUHmRkEy2coYSlltAi3*-mJj$T$iP8b@g}My;*>f63j~ zYw&ME$~g+@^Q{?Ij^804_7_ilvRkXj>Z11={s}i^50aUa`Q{EWE;}a14+)X?GUFms z$yCItiG0p(X4)_lIA@#Te8$d_E$rqi8cuGeWk z`@cter6+&sk=`*g|F6=`%)Ecv??bw$%RRU|Gn`SFpxO1#f>6kqZRdg9#TY-y=4z>b87zZolzSF z=Q~TFzqfm(pH(;l?OaSy0kipn_&iN zQO!rGpGt03oV=Lj-^d5E@pxyU+{bKd{rt+`uAg7|c&*=G1+nW}`aRA^#k9AO?>kX? z9a~bQLBAKI42b9-n3Y!gAd*^#0HT~l908;K7M#s&=6j{coF+JyW%$=Kd@2#J9~q@)wRMZPyV-r9$J|1bNYvCpqB001A02m}BC000301^_}s R0stET0{{R300000000UHP?rDz literal 0 HcmV?d00001 diff --git a/test/mpileup/mpileup.1.bam.bai b/test/mpileup/mpileup.1.bam.bai new file mode 100644 index 0000000000000000000000000000000000000000..777d145d261b65e1fa6722b891fb962cc78cb29f GIT binary patch literal 96 zcmZ>A^kigYU|?VZVoxCk1`wNp;fNrZVmQkI;(JYk$fJu}fHVOCL=TLH>4nGv0CYA6 AasU7T literal 0 HcmV?d00001 diff --git a/test/mpileup/mpileup.1.cram b/test/mpileup/mpileup.1.cram new file mode 100644 index 0000000000000000000000000000000000000000..ab276ced0300c666e15866951decb00e16426c0b GIT binary patch literal 49113 zcmeFZWmFvN_U=pL7Tn$4JrD@cKyY_=m*5`U-CcvbyF0-hf;$8a?wnpLYw!QQ=Z<^N zINx`V9@Kn)^LgG`HM^?2Mit#aMIjjoFh;Qd_d^r^Ukn@^ES?jMu5T6q1{P1-8%snS z0sAKhai$~VxGILW&QJE)K#r$`?#>UxG#JcAYN>4I2YUxFp7^V z&*XR17XV*|3}uS5&V?t@%6R zgohb{Fn<#isO?Xe$sDpr*Jd-$M~oJkUZXj#&bO!R>d3_>)3)BVaaPUAcM{TS8xD;~ zE&>Ar8nZl)JB(^47d^vH*Zp6-1A3lXQf<${+eK|ew1;g)?1?N03U7dS$u04a%C@Ad_y^MCk?=yDFAUBemD+=fV_UNUq8Tq-62Di zP$L}4Bi@QB5x(=&)FAn01|E^^AA2chD)JPuOO@UQZ-|2zN*KqR^Sk z{i*$~pU$m8>+SRnH~0Og+-7vMf?>08dt;-PoZfAp8$P9OU90DtT1t5}emdmcF_{}r zRKg&g*VFEuz>4>gt6XM%PK&M`mdnY8?OFUyg!dIjXS237wmQnwunHBGo0MmOmW0p8T>5Q9jvq3jNs<1XHOMGI@-~Tv0!IiSC_y zH(DGL_2v8OvaNT1-0SY{&m42(X4}&f-zv3c1C;gYBQEhtMKG5W5AMXpMS;<{Aq#lT zoc=Q-^Bgav=9s)@cx<7&EbQM>8Pu~*@hQ}cP7Tf5Glu8pwa_zY=jLJ1GcGOP&&*LO z#|SISg&K6u&D-%rR(GSDiiH}y&&{9lMEJI%U2=sQjs zk)q*$Yta=16bru;!5?pxp>$UY^FGiG*j2%F9)Dh6-sv}C`CVhQC)-d z27mobUlGvV_wojRvQ^E}-QD+pks^C}3qRVbhVAYq1G)MxszZ_9!Y`lc^8>p74=IiT zy+@~A(c@ujf0p0o4V}o?8`tkeGzV;DVE)7*5&EwKV0=fl-aB*FZ{>}Ra&_Xf1jc%@ zsL_tL1Ll@8Oj9<+>$O@LXJqQD-Ez$D{8{cPbE7#fR$c3BqCy0#(d(9ss;sw5eur~W zpsx2WskqS#I{e;Kdi?O6R5S5NI7UU+5+`3YjETc_->l+qq^2Rs5!m~QEg#{`nsx?d z@@^!Q>1L)-1gQRtoV;ziCk5@p_I^y{QQwceMDtLx9Z?n^Vg^=tP42v~t`@yn}dRT)%C<(CPFAxXI*6sNh2qXF4{};%EWoz{M z3xtzE%>4ywVcE*Pjg_%uf>WAxq#J2u8?_r@+48=DG%67!{lEXxfIy1RA3zWI1L~r_ z{s9pv|9}AdKj4J;AK>l)nwGgOaVk2^QX$i_)e_Zs^I*9oxg1MK)jK-sZ!mWB2ViCX z1Db#R0gG+_fbXY&K=KO5caN@4WOTbO@7$SiDxvLUf-jn2BmAoyA)_nkI7lwv^<|gr z)K0cmu~!vXimmK~(0^tRBjYC2tDp^h%=%3SmtEW1G(6Xw;$mg^9x3J~B9;}$_bb}t z` zgi|}Ch$cy7S^t6`W6z!!!myxnt}CTyxOY>8QMgH)A1$h?@!FFh6hXE4V@UkVQ2NK9 z^_QXbk0He!WZ=m7+n_O)z#E!e`Iji1Tgu%5rcU27o;s`Jl}UL#>c?h!M`x9?V6wi< zRY5}YQX%|^W~D^7)74#@DnMhNb2LGALl>K#q`aHTeRg#9#1hIlZJ9!j*WFX6%C~|# zV^4zGuKENsHpndD)A8P!b1!(EuuVL5M#qkgb@rYggUKHSK2|KJ-5*6icpZ=JU-dg} z)df{&{*?WIFyheur>p@$BZd3#vfKJT1HYR zQ^5eXQn%>GRoe$<+^qrgb3hUzcEXU*9GxCX(8a?!SEk|<*hgUo%-s|CofEpDCG>$MrO0aL(CTWOO+l1RLDnv( zX+ZinN~qFB42CjV^~NH71)1J5PN)b=c-2Z;b!DX*OPSvMbbl2qc&r7C3QeV& zk|OS=RnXTxW&L#Cmc=ht+mNDN1%Oj{MnO?Wx(X zkCt57+R}C|Bt<%5hOv*U4sW)pE#OpDFw%;Egn0jFy+VfmMM+ zD+?pbqmvNkoS{&rlq{ht3oJ8+TM$W+Ph!bSr$Mh$q|!z==~MX;Xq7MBBAND8CJ|1J z7QHHrZJW-dk5hq4yHL7?>PKLCBHWTl+Sequ?f>0WAekmElNhEq}#;-Q3N4{Y0SlPdw7%uR^adD%+i2@fI|BM^m|B?%-dvAl}o+zs1A3<_Z+I{kGd1Kk1bm!ThH2bGN zY5u7{>D79Ki@$6>0)P1QA1(uC9LKp9P$LHY*SZR+vqNhbf4C>9$P4^?nnesCmPS86 ztko%LM1=(rh3JF>(dMu=t||(lOC)(`#2JlMgxBI#HZ+r>3@QmSNBuFwD8Om=fm}91e_Tt&f4ev?=l^z9W&UwlD*f$x zGW+9FlK#8okyGj4CC|zOda_;(CW?Ub^;B~PFnrOs8-%j}=QhV*hzGEFx;`~HTSQb+ zJ`&L0rwr|jCo5k)?o6dU7Edi7R$qgI7eh|AEm|VwE_O-6<@!xd2aA70w-!fiZO`X0 zC!Dzu=1>V`X4;;so@~7_y_@mDC!bNi9xt7^EYTP z4lo80LdCn9?5%ze6XcU{{&7*?5$)zv1An-$Qs^Y16$oj*wie)!#EbMYz9eRyvyh== z0n&oq8~}fVJ5qEOU+EsOD{g)Hbg(=N$k&%DJ6C?n4g+wjZ4uqNLxg|pcI5M9Rf!pVe2fsqdkg8(IHu?>VK z!9-Jee95E<1W~Dwa$(UyuApyO+Ayv?v8_nw0rm&H7H7&gEP45T&f*rS`6DF#r#%{U zOUHly(6*hl6n4udeQtP%NkkT3CyE7tea+m`09`2x!wbXv*Ttm&F8|ws|90TN9r$kt z{@a27cHqAq_-_Y(jE$FL6@dBxh=ub12-dT;hYj%Sy8>Egf&sw%n*Ex6%OI6Sd{c#F zfJ!nz83mxavXHQXCYU-4P@NU{|408N1pa@h)c=+Em+^TUZPLKn99IKms5DV2aWJ04|6FP!+!b0BACx9Hy)i0DvJ2V%W-{ z2um3xArX@W0Pw_s006!iC_x|$N)SuPLV<&Q5RnGW1OR{u3qim`0+ofnKmx!aAcTb> zp#cCo0Dw|P0RTW({7Z_U0CFKJN`UmB&M5&w2+0F(3$$^NaDV0i&9epCy#E}6TKb9zFpv$vfzQY$!%DtYvbk?l&z?wh(MgY7lTE0)PTz|M#6%NQm~V_6cR1 zCZ!^mhWV?QUgEiI3q76sw=;p!?2p{!&Uj!dzDIjRpuK47m;(|33Gg$F;{2ccw1Y|A zmi;U!LngchZV7OlcpPc?Pmq-QyotggibrJT;t-U1QXB68woC%O+e5FU6Q>d8tK)>5 z^+#(ht4-_6aty%>XuQt{aZ5LFE^g!Oai=X&PhXeYB{i%9MqFS`)Mhz9FCq8PWU*5v z3IBR2bWaSe>aV2FJ8=BW3LY1fTG_di|QK`fc0W7+cK)=^hPr zn2j%pU;D16Q(Po51`YK}g-qC%GJoGqj=5oxlJ@eGxX6;ehTM-wCRF=*O=jboQ@F54 z)ZpYQi|A|g_>TJz<(U_xrrY=|Hb{1|=Mg7L9ORVG$(Ij$I{ujtsr-PwCmuF|IJmRW z&+Q2xxh`2sJiI;K(z&^Me%ETDw+5VB z+eo>0o!Cv7{hajb%ZJ!+g{_N!Sb^N@a>jy~=XkfkYn4Ule-YhuJ$a#XePnawagz06 z+niX}`ub&);XU#`fUx4e_xX|+a`RK?6HCM5?c&OC72nVE z@gJ0KOCi8Z(v~5OC8zCWx6Rv1yR(@mE_E~S&Gx1X&&}4wGn-ZC^|xz=u~uzTEK&wq zLj#9A2J%Ro`f(GPWYnQxb+mzaI-O97qCO^33wF#pF!2bJ(0#)BWID!~;XW91+sH~0 zhU0Js>28)}kz?uE(h{lCIBl^e1s41vHveU`LMS&5uvX&%eqMU`9y0%i)E6Jd!trYQ zL#@dk8t)+=8!B4m2s*;|JgWSLc_r2qV59o;nv0SGwqc2O5gC>*{wPUqWf|R&n8ww^ zAavr`h^380I(m~x;$$pd16@REZiE8wH>z^ugtcyU9K<2IUN zGG;1UZ}02lr}8x=#%8Lq&{>OtH}~(ts(taz#aeit@C8m>psf;#5W+HjQyS`=>xd)4 z#F%FupQKEXDhzFm0Ur&rsI}?V=Zf5ibaZA*&S}zSJR945zeD?`!!)xsc>tKxro$$| zEGlvjsU^iaYGv=wlp> zPSK2=^|E?KxH_6~Hl3u|OnZoBE2c*1&mtNZU(xZ^bKSk(Ob2=coM0R%;r&4MT#f2k zjhjx9Rz=>hF0-Vh0i_(VP{Y>wav zS+CI%ff*WXcp5PX5@umjDtT5F4Kl45Jl^czw}*TtD(aKXv`T|=3c(e!9-tA=)m}6f zy0g#K-XOJ>DC4NH5Ygr)E1fkZ^dvrR6T9(XpjEUf7-v|b$%4TCJYyIOb?hzVa?#^R zKr-S?9`5D}ZuxP*|I95X5a=gSZM}{ zhaMs%j`4vGhD-z_tppQe=O%{!vY66PD8Vw}A&0ltXm{)6R?w3KD@JgNZC`7Mh1H zxBws@<_`64aA=Nr z$JY?mO&Uj}P-qK%!No_l#2~@i`xUr2BXSJ6ERIj=VE7Gr-dOTb<%L&2a704nm}4y8 z&i(J*uh%pU?pisZtQU2Uf?@7+z7sqJaGwpc7BbSrn6n(Ev{#i(Dq&w^&lKojaBelu zpKigb&=&iEPGAg$W>q_q5*}J{mi7_T{-fITx&vgbLH$~3D5W3+?bS2kvP4&D=za;# zDp&qtUjq(T{;po8bVT6@FCNE`2rBhsDmBOKv$i*ucPpxO?cc6(aZ}TJ=?H^lhBsrZ zF%vpNI8|eVu9lv?KK01i86WYJvkzTI@ym>+6t7qs!W=mc2CY`e1q$TH3i+d0+g3-45TYXBh>dX_pVv zp2}T=x_#ZYx%?NN$7Cc6*FfL;64;Jb_^KnL&gQMoCcz!EoSafE*`cOsJe|$k?sd^* z44djznDUatLeAU#Vo@vB=*2gN8+LNCV{V$13AU6N-rV}8=Q;lL>Z#4L5T94>YrkxE z@=!*Hq;HPTtFL2k`x+LsP7a< zYW`!CyyIRWqx%q0UTUd7!fG>pEoc7vq-aX!%b0Lr3bm1;9?jJjTQoOfpsq;^*O2LC z@n6n;!!@wBs*5CPx?K>YB2^tnj31-h6v(p<-N#m@{*5gani*TJoT@D#|HM4UlIM1` z2L{H;AL$eSE&D2Nht6M?f9I*H8p@ zRLQN-1!-w$8Nh9WH>%ornY7K_zA7N};T|8t4;#)UT5m$<`97($ z8I^b-`&vMkdv{F^x=93LDR|QG&k1N5VmfFXQ@H0uVM~Hb?oudg8?SK-DvOdGX3(gn zs$1|eqJPPKLG=}kF0S}AP{~-zD}H-zOFjej#p8ElycF)vOf=QL!u-_{?#n1SeagJ# z@}pv2B2 z!|)&ATD{L9Ym$8Ma=e>~RtzXtxd|#G)~u-Y`SEJP>;>5N zuT`9@lnuP6m|s7I3QXpS73RIt-q+}2I(UTA$z+;W`Tcmo&K1EY) zsZPF@>X(PxCsRd}(@~igZK`{cIzk0?jCWlP;O0(94- zOcwqiNCBT$O`{Uyfh3)^fx(JC?f6{yt~z@;)QrvV+yyt4#?mMqvF$NlRQ2j8!&xC# zL0tH0czAup9{OUo5@TJQ5PC-NW{uaZ1ErPEU>^nNE1FNE5Bc~?5Z59)CG z7RXCRn<2stw_@yY@Jw6zfzmFl4v#k3)VCal7<1=nC&UEB^-W4DP7S}HE?0C)a>AKXAT`RW%x^F;P6=#`cyz}*|_7FFa>=S>)2PS(i>*G z7wf)jv0XPB6x>-WY%;RC!f(PZ58M=N_Gb##LXl%)sJ0=W??o^N7CWmG$%7|9z%9Qg zsish}I1+B|V@ht~2=GgVqu6In)bvnkdVkq2z)jJALrCMU$yq7^M6Yz<7HZvBC%=}D zspY$;JJU+4h)O~4~yG!elVSBLY&Q>Dw?dX?)9T1_9l$>v6Oymd%8^_owyj;F=_`II-x5?i zdBy=ns7sVfcKod`tRS<83jOA0zqsVC&q(7d)#S`Kt|D&4T6hgc`9ybS<*2FtAkN$E z3y69%0$1g3j0Tw*-M)Zm>N&f{ItNUwSTro}L9(4}?@CoHB^R@@uOTkM;qyJa;k{D! z4WG=O!lX|(rl+U07|db}r+3Eaq37@oY~}fkrcejJw<0+FDBqH2P$j5bQ}D+0(!+qo z3grCae*D!|nI=%v^iXC}L)$mM+``N7U2)!I)Kv1G;S!g)Q3?}5D0$_hv4UYn_K|Tm zcBda^yqDH!A~Su;ilWl|f|49(R`A~V*^nQ$Fawfmbngd%NXET2W$R&qqJ(qPfzE|k zJU!hlmf8?_suc6Rk&Zsfa5v7{aq@PWjR=7oF%qun(6uT|l6(8n1_vE^D>jS?8zJLk z)U%ciwS&A=xa|uH_wq%3m%_2sS$AV7ZN!K2;dmZG;B8VQo7JnxJRAKb$`u4j3Y6Nx z>Y@%-Iq}DJ+UEdvRGOzi1`7Wk?||RLBt*{!5q+tvZK=%yY!io-bGty;#1rSL;^$n| z__p!UldxZed+j|G4%+R`s;r3mNHFlr*DN!?`@y_=<4lbs8 zh`H=y=1jv@g?Vme*;Z6cw9ToTAP88qwPCNbSR;!8nQN3)d+PpQTt4M=NWY(hWosxp zPwCc!lHj`PJFz8rXWXY=O`oqgq>5)c=iXG60KFDJJLlfN6G?KRVpLTBa&vMaECE0e*(9X#lCBDb(Ln)QD@MWG6;SZUu z_A-$1TK$^Xj5y2s(K4P~NL^*O8TJVnukn*y38;$j6~EHo<7pwwM;md+xtTy`@=%V9 zWU2lBIZO2oy~AiDrFr@>AKv&4fZFX z=kQmVo(Bl2Le&NC)*5(GMkdJ=BF(0reG+Zch?5u0d&n7Jl_h;tI@KRmOI>D~m+Bs-Jm!`dhGj=v43`>k^Wp1;Z0Ix;WN%alF8a_r6{KGT9owC}~!*0dohwB>$|9 z-^1ID(O|T~59Vg$-qDsXDtpr*rCeLR6E?_1$dl#xS(@?O?A`JGx9a2L0mpv6Ps<8R zbrdCNUn-uyZaR3lO(sMCzVgA$u>0PcUJ}iSPri_#Qq$FMY#8;McBgfNI}tIK=;NUe zn{#{>Hw_rrqskKmBqU;w7bEC0D;R|r7}(y{UsqlMOaLf2co=9ncm#L^1QgH}I!shl zbSzvVQW|P{HXcbeTi-C>4Bsg~BtId)5WhLUHa|Dt7vC&i&_zhF{XTy%-0Me_*M(9r zfuKQf*s%s$yYv0}ms5e`x1HB=B-^q>Or{++vTyO}vx(Vd-)|`VjB3$!5JL3hGhNy1 z)}WUTxWHj-S_|l-1JPh66&UumfM)06c6C!wEOM|{Z1#3(2W{6p)mt=a#x`Z?DMovg zL8}d38^Hp?M`39(cT;`wW@5Q=ylvMmTJnd61W`YxRZg2?y^xO9u6?hG9_YITPHWt( zW$L|_b1ct_$1_I0MYJQK{=BkuDI0ImDgV-KL~UC&9mpcW;?8EE-yE`y^~p#C zA}-F}k9Bz31|LsIUt!h=cB(bGfWto7EHH2q!Qcu;m5IeK^LY}hBpFg+B~I$>dc3=c z8t<-QF^M+Mqp9!hwS*NsP<)3CJqIFB5q zy_O~b{CWp9GKKQUYjcXmklb)N9G??&_)+ZY;ZKM zE;d-wib*zrkST6qPUMyILVA|E%VGKr;!JI+JHyFgY?PdKfM+c~Hi@tNrmk?V-O*1e z{KZ*<;nxw3dZ@z3g^AVZ71whBq$ZZlaIfvi}d=$omhE>zz?t~~3iQfRAeDi>2E=<#O3*|2_B>qh<%P~J^qioy|ibPDVL#S)o z{yF4Ddot}oq z45n*RysrHX`=}39q!wqcPV1w&-dYWp%E8C-7G0#zU+O2LXIXZ5lgikQmA;#p6c<9e zEhZ><`|;{I?i+P`WphvB1HTZeaQ2XT=}#eTCyWRY(hu-{ z4FX~ojMZYnwVHa3()NU#FZ(oS%(Ji(*u=J=FB-H>jbOR=E9)2-u>#&FgFLb4=Ok#cAS2rILsB6OWc}7A5lE8IF}gw{CRmEe~%K@ zxPnCxoYo5hhc*bBCQz>jM-xli1ve^)f`uVIlnGu#Lx`>law9k-Hn4Mewt{v%GK7Bo}MAj(PODIjAuc^SEs-UYWnZ;+f3V+DJ zN$+#m3Uftl!9=l`_L=h~q%&{@dWp;k`nJJK&TJwSNipP@>4#x+eZBnhGtdzW!sNv7 zeo!*6#rZug0P#zxoA0(PqKbP@bGedR(F->KKeeX|3;cKjxL2{3P=4Ev5spf*A7JfG zZ27C2Z(Yt$N1$9zAK!a;EA)6TDSV)KGLSbM2tiq_L zrH>rx#6v$!ddQ=vlwWlEWkfR9{`eR*Jc{rn-QtrzX4#I6;ELJ)orWk9*|1_$VCiua z=;YcIzXr8LaJPH>OK>3*Cpv`F{1Z0v<()>5#u!=Eke1Qvcm7GJk|q&Flm*+1(mi+78|+m(VE^@7pTKKb%Q}$lbSWsylk>Ulx?6jjBnsUqgb#t z5lLYNHtl$^bg71&a2}~L>P@MKIYhabWLKt7J)=Wp zb~Qlk6Ggfis;lnoV>TjP-V9G^v}IK6b?YCWRte1)dO5o6U}Od>;!4p-H2R?Gb)nG_ z2OxwvOM6H!{CJAw0E-mUR=lFl!b*9Vhk$Gi*?pm+wBhh**KY)fsctV=p}8%d5KcV7AnZ_|MQ8R^5E4 z6>j^$MPmz2g-nE-)U>b7=jmz)Z2Ns#T}ysQrj>VMV5thzrdZ9uOW6>|&W|NhDd#Ie zzA9>?<@>3VLpHwtDd!dMzJsub^%_?yE!C3;68*>5iM-6-9?)D3ooLqIin~cgSyD?+ zDnk!v*a_>1`^((VZ=0|S&-&u>hnPcUk0puc<(8EEshU*mp@M+c~*J?;ffKY{1;!H%51<3={$<)?{YC`Vyt?A=l2Azr)ElBtskNqiXv^+xhb z2CUN&3PwUCN-y40=jR?Fn%!pw>Pb86MxNhEiaF2twg&;MgZ_C?%Mhb;536;t;t$dH zNuR}T_F_^xIYU1o%w4mD5`a;mHVGD@<9*w{~V zS@E&(3ZXCT@Ho$u6UU@?0)i2KOva+~%r&W9U~?C$dCa5QSPGeDot#&m&wpQ%N`N-b zNWe-)+Jh7=r7@%gQl{+El7R2XN+K<9wb84nnkT}&b;2O|*(HxZt8+ZC7C%btOsul% zJ@pMrAZ!&JuAG0w`Z(orA18B!cly-y=hx1#OqJrm0s^`c zp16j(8Ga6&gL%9i{j|OO<3=JVR-GEhks)sM+H zMsWbnvW=#ih&Tp+!mZ*f2Clp-YO9N~rqiOCZ(!a#_ofhEmadtds#?S39IEYp*Vf;7 z+R`vG1D(^+%*!Lhz+1$Kqf4l4b@)7(w)=%%jx%phWA^%l>J)JI5#Zs4;>CV04$-i_ zf6LJ#=S0`s%E)~`c&6M6zpZ}TQg_3t80C|43^7^?l9_6Kq#xY%c-7?AG(AZ|;am^; z2;cX0Ad)UDyjH4p-`z^K#&O+8cVp_&cr*) z%q{SNg< zzN#doYbyS;H?!+5CAR^Ly%XAGGnMdsP+eNMQZThySq z4#0}Qybf7;+n>3M{T4XZ=Uc)uE>ffov~kS+>h5!893#>+_k&nJ4A1xdP+fS<=dSL& zuQHaPgd_YU)CaMpyb!m;i8QDkzD*Yg<=j)%6Kx%`F0oFr)z2$z5&8%q^Xps%r)vE2 z)NI)qUJQ+?G``2_DXLvP!H8UTvXD3^RaUH;lWeNsV3CSnNp z;Kl?t><5e2dx3yzkuHrPcQ4-y3jzGB!5ro`)!y98HDxrk{NNqeaK9PSSRivqMj&;& znTNY#ZK>jq{ZM(ztrhtwm1J>Qm#Jh9R{6B?rW;0G<6(wI;ciKpIw1f$7A@B^whC&?ACiGw_2e9f2=6)L<;+|iMH~qsUc>L2^v>es9X40LO3k3hMhG?n zflh(S=*ENJw6seyUz69FCQ1m+e9v#j6sD8O7c%{GB5XVFW92iJbn%rMetpTN*SW{6 zGAd~Ah;+ydt=6s#!_*AIIeA;G%X3i6bTC2tv3$GFy5ob;#T$r%TeaAsB&lzqqLxgRM z?G7c}g-dGWk~$zOr@=ia>deJqWQsb@&qTwXAI9$NYsA@Rx$AP><@v{->n)G!-W z$Ah$h*u6?3aPoF*ghW1x%VzhSdE=5dX8_Yv^HvY~RU8`Cssck-{8>Tqu`)rDy&G<_ zUeHBld-zz^Wy~Pm1jdObcCaX?r2o`oq|0SVSZIwb3_N7!8*zp6q*Q`5XDg7+)k8X- zp4QkMmA1dlD|zzD$PBsuPB;pOKgpR2%d`4=i(Byt`vm;ilJjX9egrvp?M!n0K8!d+ z!Abi&oOD6;Xp+YvH2O=r)vl&xzVVJLe{#4@EtSoe4`dKeP<D^Cy&?{UT+~VHd&Bk7*Bsx5B|_5KN03g)a6pkku5_AOO7}2s zKYPcFPzE@>u7%6>_m{JWZIUGTPxjH!>_gXad#S5a7Jh&VQ6ie#pI87mAw zC(0>TC3xFpq49Y&I81ofq^F2Ht<7nzsXJu*y9OiWMhjX{&pNTD_EH;o!Ug)nMlQ;8 za^9!cQW<HT+4AHf$+94*!RZQyT+;D{0Ll4Pw%lkcS$U0MS+6{iY!kkay70DsL%VVOSb@&m)EN-F6mMTIFlz3I(%e~7S)c~9y>B_)RrCwoSe zu`1I~(YAdmKgBUR-rZ3JH!{ghOp_Pfp)&wRxMJWx_3@Gr^6sJWNJ(}{S$DjDb+dB1 z#9&T~lsq@@nHr)5-@pud1?@gF$ng>`3=3*1n#J2wGcSh+3dGx%F5;v*g7bWoE>uBh zNZ{YsCgv&ZS5b1Df)d8~8d2SCCeY_E_jS$~oZpF+mm-2v?F2(d9rg@4iTP*FxlJQd z3!c4cWkDM;Rg{ot@w0aXu~ML6gFt_i-%^zP#{B!);~|!OL_M&T!ny)0)LFg^J@(i` zSayUr?(Em|4+zKT*BMLnU*;NQB=TAX4JCe0V3~0Yx$~fZSIoNf0Ty+ZP84~+4{G{) z!+T+;fguVED?&o&;Heo@*1JkZ!+>tIs%L@8>#`&yu79^D+CY*u&+a^V82J+F+`MrR zwPWP`S$X;}vMywx7h=&oAX&I2^8cUV`whKX3{jptfk3{Z<$Ag3%CY!x+> z?r(0EX5?K_JHx_X32k?Us|`>Kcj)#Lw!T&20bj!dv|Pq*n}dDAK36B2p#HfYolnhm zmgOf$kB!ZQ{8p)Rmruz5y*bEqynrzy-RH#oDCS{ac9W$VA&zE@vc#`w32{-Mnglsv zc@!54A(OPAz9X!%5~cgK^dK$KO}CTxqxu8$Ig|*1&9Y$KX*=q|BZb`H$B#r9Jy$g{ zp<{nD-954mfJ+cF@AGecv|RoSxh8G^?${XI9$$X+UM8<(A??=B^2qiLaih$|F8v?% z8p)7u->F^3{4{w^OCi%1ajR&?m?=F5&jr^vT;m9yzkHid-6lgnF>Q8IZJ)F3=~I8p ziHw%5l-T~@CqmXJRVkk4BTE3?HA#m@X57?B{4-z)TGtae@Mf^!ZdkDvC$Q?33ynw z8H;TZ?G`h^aXn6QmGa@)6iv50vpJXU*hCq&SkNTq`=`s`;Y*H*x#q7x&j;8Jgbx%` zyQ4#;G}%6flc-p~B~{zlQ&$Oq;gQb*l)A}&ghXJLwIxyD&WU z0%Au$*+u$`6S;FWIIL%t#UjMrpmw~c<*WDnTjXlFg?Ur|&nIZSw=x#2`4l zj#=0Yvr1xcg}(t~IxMtTR#PC~sjFujZ0(OD#U8m77s91uYS?sd#;Hl4PE78})ER^p8T$dcQE(ZvnaYDIom7`*Xsxlbgk-h(6a98joQ;Nc^628rnynp z%<2XznRbS{{AuScPZ;H|cKBmW@f$w=Ow791-`SP@;#=*tIq(6x{Lprd>D#=0ab~-lvmp)ZegwCDcOZ?j7(#J*VHd}_7S>)0wcpr}Aa_8l2 zC0*e|H(PPbr-n6_DMtgCW)-7&yG-WcXrK#%c7ZmUf2AsX4ll%hIa79^;;p%wVB{Ds ziLjkOp9$P*4JdfFLmDWq^5wi$!$?ie+A|iEOW0Xo{|+=!-zSW5CPOUQSZYjFepV8uba0|mL~Hy_ ziXs9)fSdf;W&l>H$g7kGxLe0~q!UWb<^AO-%BR(_un8UN^#}zdD&~u-Wa8)|xWn%L zY&LJIl>quts%NHd>TT+lCnT-a82-rd8B+lVO>7xUHWH7MLmm&)uBTwFQ<`Iror~O4 zZ-Q3*&y1fTrj3FCCZ?7C<7#k%C8Kv$C2jW2fxnqaZhR%M2cm>kb}3=(^eABGLRz9S zomomm@{Q^PpZy^$!NpdKE?I7c8X)v{q&Qnp)x|a~USx&r&7^YW#N{8nR!kT0dYeWa zad{S-W$B@~G%jHwNK@Y7&FHodbbsYhnIluG(`irD+^DKJ#a@-F9=MPs53t7%-$qSM zBwhAGooa?e3`Dcu`{4W44 zK+?bPp238Qek$Rp!uDb$dwR7NiY0k}B7dQD8Jc$thnKQCKa)%e+ze?6 zW}POw)?hy|ivv7e`QaI8Rmey{J7sp^vJ)~?^ia8s_%O4_5t6CftD2jGT0b7ZdwocG z2l~9UC1jR}d@VOU@tZH5(CZo6Pa>*nZ2Rrd7l6q{XJZO$LMxBFErmKDP{u1t*)UE1 z601EaY}%zX9T#gq z6dExnU7cxvZN;hKA=IT6Sn$Tzio{W3P1}T5>>M-dNm|kTROTpLeE@%w=-|gAgPTtq zLb7>@&_^sV<@fv15caWjQQ073;)ofeE;O5IZ|;A)4z!!|Iatfm2r(jrp z*+}qMkA>G{;BbvvZ-$-m+Z4{Jvp&X z`zSHTcKvwemxspo7<}sQP|X{?hS$B<%BRb&0+5dduP5g2i3xO2Wo8~|VKy|Z0sCLM zSz!|0lQSD3Y#4%M<>p_LI>5k1>E7eYtK?Ezo&2U`PJob|obL%oGQfUyC1;LmETkg; zME^_uvr5SCp@?TQ)dwwn$OWONliYF3js3*f6xvcoI7wU*66YcW2D-Bg)r~}FfPesx z|B0zhoFo!Fm0^olv^q9_j&ICkAV4~66^sG=8)Df2l8pM^?vY0**LmKK9TV=^cr7Guy93N zS?Q-z^|GG_Ba)L-LxprHG}w=*QDIsA#&UR%hc~KaFwH$H>pdFsHoqzBPgqbBA^}0= zMpdI25C!-PoEn+_0HJm4e(r%x%|f=j_B~9r!WmOwsXGu+NRp6>W%nBy5tcmar9r>| zCWeO;X+kfyv%q`WY9^Xl3_@@WhKF2DQ|1^aW(Qi51S$Y10TZX+%l1KNmcLG=# zFxX_KkCjv5XTpCh**0u7meBSjt~`?uQ5YCz!$q%5J%b||@BX9J9|*r5mDJ9j#v5bxikY1z$M6`xoF)*+86*GEJSf!u0!A_$oPw*wn%haL< zH>CNRPX3IO9qn=Z?-#zsba_P zjq`Kx`+-RpO(vp+A%#ezNYQW?$opATWir=xC-jMXPhIq5>C43)56UN5$U08YczIB} z3-!P7^&lW&36QPqy{3Ju^A&FiFiaosl>`@&RiBCj)?IxV!I1 zZ8#s&`M>|s3;bVPuzw{jS5G0~n(93KiP2L7aKGGtd2w~-&12wbs#}8;>BX3N$;zsb zBHF)WLOW)|W|BVs>!Ho;fqY?ZJ%o__i^=_}G>aEFI?7DtFS`#zWG|ngJ)l2-oPrle zMM_l9#$!;9GF?}){6%Ge0}n~#d`a=ykKr6r zTw5-14pD?8!Mo9CyfV!A%erP`urDpCwq_OOrgb#^xs8QeC@P`b36&yn)kAFaZ`KzP z&F7YRv0}@A81;tC&KX>$DaIy+oS7uYcK2nwl0$G@tlJOL1%8>l1WPH_j9WA;i$9fL z`eh{-1Ie2{_RK90%{Ayu4F}GX{Y@90ka2Yr%SWU>iUqx`RqtvkX%&0((zdNdw|NZa z3XNa=Vlhhju9x~J7u4%3o_*w$fFFVRekaX_7XhOHl@g(XVML#zoJB1&jLr)biwx0d z6?yPu3dNdI$VinVcCeK}j3NVgBg;BBI8@Jkn>N@4(cQ@j!|X#TVjS1q=#Q?`OpNFp zzRuKyNvA>+PQivjda?2`sbs^%ytND99x<1W?iUsqVonf^E@$#iqPhVKi_yKrXA_{b zq|=z8N*3XmeV1KGy+cj{7Qp0v6pLhGC7n@^I(3Y778DK%2gWQ%Bo7P;VH+RlxC$K< z*Zl}0Arwp*0A;y=LRSGGnG#cgqXh^E2EYab2?PQX5Euyz7o7-@O8^iH0T2mzP$L5Z z1_T8L1_T2FPzntP3=Rwr2m}S-2`~c-PzxUp_Y4#i3|$ye3gL3Y#P!oK@ZUE@N*beF5ja^8d68LxiiLFn}H#YDl4&3QLu7}*(OKQm~Gz#Owy_;9qR7* zuf0Y-%z+zc@PU@NixV^YYiEg{{BT>bE<2xvSVt^o+z{kgQ^#^BA?Hi%1hSb^eI*IC z(@9wh-CliM-fl>20VV37UW``t9zcIO7V`qu=PgyAgxSGP~?Xs(RAOJGgZz zyzoX$A49djN)=T=Ab4=f#;R z^otf#UNtk(CgKDMukECU=iwNnsQsA=wnd3mbt0UHz$6(j+61IOit}-mivnEK6I@xH zg@TY#F!smcbm#1$73cDR3>2V2>&xCD;kT}o!n04v#eFJ!nR*YCk3eCBfpy1z5dbfE}r97K7tC4t(+xNr!iN@_?p_p~^fgec` z$*z*jdkQ@2CzO^<{MGR-J&9sdtoS}D4iy*DU+R%fx{;{QCbkgu!=!FLe|oM16h+YrrQwh#6WK{olfa`Hql za}_{Ju^YopI=5Orv~YXODDgLT_|)iL0mCj5S%SEc>(I>wdg>r4YH-fS_N{d*L<~;B z+yLCtk`@R&ARnmcb2H8kH6aEr{i0!miKgc1c+dKe92znBxU*T|>!c5gTGZ{`6~Uq$SjZ?9c zu+8b`)#m6As%wOht2*c;L$DENx0xZM+fhcH-g@VJ9XF#JqUjm`0~gv&u z>v{>M@_OXuh;jxF)c?Mpx%K9K8)~=$$^MS&t88BR>+#%#5iPjrPrx9YZh#2q#eA}# zcLt;iC-)52CauWwhi3-?t9FL;T@u?4OKgPjM?kdk)|ky!Bwu^E3V~Sv@l4{!eN}X4 zm+Lp-nN?{BQ;LYVKXQdNfl&|x$(z@o;1OP< zFl-K#O%uY*v?UDe9CrEHL=dR9vJZEEx(ri7QStqpu+H1{3eL|h^TN9?_^2pS`{R*- z1B^?@Rzx%**-ROr?8m~zhORF=aeTvubMT4>8rOdaYxK#kR(PkO9Px;u^pR)z6yTD+xd}hAH zg%REEbJ;IMfl<-Nlej`%)Q|U2E<_0Xt_UxKac@&Uu2lg|O#X-G68mO&@c1b$Y8Bsf zbB?&SrsIrv-aT{~Pg~N(AHuo+u2hur<4bA&F18Rk#6`7>E~yoasb-ad6T<7(pq#Sw zZW3iP!R$U`_Q~rD^BrkXkn#NrF4>3Ut`m82;S6BBaM^^p?}^@C<`Y>wAQECU9@(_| z+~KsrP`e90VUbNd^2~V!w}B@ot|JG?#s^1L7E4T&kWFL-ChhdP0~?2KLo8E^#xVDk zR1Ak3o<VtRqoS;DIhBeMgOzUyCvg(&rO`07`9B` zrVV~d1Z?I9kdD-0^>df#u$Rx=1%%qM(OMf)OVxt(zjAOMU+0LjsX|(LPt<5THYDMi z_{TrI$Mhs+^>uf)XGDSCE2p}?g+VFY6#NBt{uw0VF4uPlE#16?9f(E-=W=w^xec=r z7Xi_fyDM#}zcOT3G^hS|ykL9ir#Z|9zi|!f3*XD#{FwE#nUCx!h3$S+sH=A-(jYQF zylZ%7Mk+1phj|;y3@J|;t~c*Ur2;%){1tvWInL5+B`$UHaX6I4tGO=qv-+pPWgw7M zl1}%@VSP(OZ|E1KG|G`>j{L&n{XwAiSsd}F*JS!lb_}0OyY6{x@AD1s9Q&u5#b0-v zx|C?q8&jpBQ81^MpgxDx(D=xg1c=UTx1A9&W*Txejdd=E`046L`1T+ztFEc`R&UW5 z3^qjn?Bpe#UDC>JVb}n^-~wSSiI!E4yT()vd%R8Ugn3iO>JobVe`cc<2>-!~|LJ<* z4JQ`QF@qBPBYHg|p5*aoowbb2LLR2Mg7Q4GJ#*l~C>-Y^b_@O=ICE_f_i;iK8*H1> z|AWb-&;;rDh`=aidH+y9dK2e*O^?6_3^YC*gnmXa*>C%&mvmGV>M(Wf^>075`Hy4| z8BeBw6t&F`+E{ltNV0Fgb6`{-Wh+8$b|}1Rr`fLywPuDGer>cOJ9%Tp@lY$p*ILT) z-gQ=ahofqXrfE}8pq&HUTW@$=l+|JrgfYHeQ6R-vCHGT@Fcja9U0424$Q-Ykp{75< zW~$t_eA@jo+_d>oumG%v9aR4Ffq$q%!dD4PMIm7wSLTZc(c(Lgvhev6Raqb z59CCRXpA9T?529y!I-Yw3n^^~_}kJyo$={Divf2b4|Ao5DFM_~j4HR=mMr!I;hBtj z<{~E5fqy>dJeBb{GS{x#G}4jYnv(67nzgBg0HFsTL`+j7Jva47R`Ltu9Wzf;5{mGf zKXjik`Bo6lb9p zYluoLNg))N1R}iO3bcu?jCF~ z=rG;kId;oMSp~XnWg^D?cI@n$ZcZ;`Bzj7#WV3kCzsJg`Lfh$sEM;%4jiMQt>jo;! zf;W7VYQv}sMlq73hh;6JDr|^0w-L_&BfMG~{-ksszq3SA$|IBKTGU*+w6CkMwd(Ip z@17rh^p;DLP|O|CSKtxT+#Jjy9v5BOVlgULvFo@Me19weM|S;G-A;5fUZc>w(KdPm zQ>^1?f#SZaw<>%mGu@WcYqc}dsY=QE2|2Y5Ui_UWkfvZ2cVfQ)!x?6mgO5Igk1>M& zAK#W#m9W80uL*Q!ZSZ^RY|m|_{1s&a`*>}_j`Z9 zm=2i3!yqm&UZsekOCZ*eSVifNIuZ`6Y#j+}1!wX#A%~`hEVBy?uofS#B9aIR0q6qd za@j#Eb@MG5v!uYUkE}rWBuC**mvG@P8WTJc?ex)}mqZSM-A69w!k0JO;;2@I`f^FN z!KVD;U&MFm93W50=97p`bAiulhWKpejf4qxZDW-egK%9RFcw1y4Gj_nkOdF}F9HGw z2?G!?3_b;85)7B9Vc|AS!&(BToWKhWyaNL;3;`UOJ)toBAk!(}+Sgp1w5{yflrED( z+*;f$uGG$1QKpV^*=w$(cnk>XKm1KYcvVke;)bMs?B#RnVxbzedm0 zE|CdpvNoZF<6d<$Y~a?&v&)&|S0Vvy#V_7W^QB$2|5<_nNGhuZ&)#3@vozSvAJ!)2 zRS%xZj zk!rY(3^aIdoS~{54er_z45Q;W5fD&!5-+#aG2qCV$yvnU*9dHV+4pU2cy_UI{mv5l z?-7?xY2LA161U6znsU09y2$}0aqvZZ2KwX}qQ)g?sWYK`V~U;U@ZEfA7}oC>5~5{9 zF%zmdkb}cI1SP}re+>{>B=26~{lQXCcMzOeN)YGu>Zi6#%;s%n4;LbVQv1H?KZljw zWvqSTlEya$x1iesd1ugUW*ROIuvtq1=dYP?#^84xjzEAip%GPa)W@et#ITXcUG7?F{20hVd5*!30prO6~9Q98eovLr{ccXDSa?(vb3yRE}DH z&lbX%f+v`s^U>lX1}dyo1U(1;>wHl`;%YhM6l4pS1o4}rJA<&p2ZF$q2(8jdfMKyM z&pyRoqDrRb_ZJDhh1YiMOFsGN%hG>uR8ImN#2qwKd)dn(twb|nQ+-Jh31=jM( zhQEt?v8K}>HOM~{k)H2RkqeMD6?w+>OnQ1P6-$;481|rWTD$zDlJhO>gDfJIGd*AO z)jY3L=!NMwX4U$=oiYpkfGajUSU!Ensj4vWIwEGmN9j3bk|+4SP045xZ(23&uSMZy z_>~E1aq;QDV7V-Qg5(%<$J;GvmD0meRoA=Dz`cfE@mnC~!lR*}uw2AiuXBy~7=N#SttlCS z6u4PA_jibM2zbVaet_T2z+|0qp7Wst#zLA`5V2$|oQ^%ZZD zId;-e=%uS6VGDI)F#I$x4c9`tQu;oCRNFiBHoqlj=#mRU;Hi4*6b&M4Sut&aMjeV= z=b9Pt>YP9!Nt~JHkgIW<)8@|?73=jws{sD`*i;b<>YQjyQL2yH8JfZPURKt;0v`*Ro2n%x*D(R&aI53buVxHV-v%`3 z(ZeT!`V_%XkU6b-zQupIa%BL1_v$ai7^TJ-*qYU^C_u}KH-{60qh22e2i`n`M(l-G z--zl0woiRN$q7t1w5k&zp1NiuQuDP=cqolq3RMbv)$=r9K zhkyWiQnFZ=l;6f$hOJx0@JK3uMbk>?=CAXEGML6mw>W8V9Q@+a zXwb{Jn1+uWjU=m85GJ*Ot>Rs%5ZRTx2vcxBu#6;f(8z)`iVu9?>o(d^*>X zV28P{N;7;E(i5U!AYOejT~-gFlZ{4vfo5}V6U(Fp&gObgLwS|#p?rQK${@OGH|~?9 z;NFqJgeL1DToG7LBXR{OH`nfF!%9E~qF~qaM0+C^GN5G`0cBAFFs#lG7CK9a03ing z5CISdHV{cu3xs7!E(0Gj1yc|o7O)Z_2T?Lm3gGAuEC?ll5D-@yco1b4d+jz7DC7?& z<%*|GyQzG2D3;2>RiQF&v>g*zl6n^1c(c`Dw7NQyCM+C8s0beVM$=okPOwa9(GBBHt{Nq-1X^?wRS`~Tbo)8aRQ%tIN;IiYrS zctBU3Z9MASqF7qsgv*jT9f-j5pc?-^f99GyKO+?rxzkF?&)76%3j+!&1#_is&}#UP zDlr&%R=^iUfImlJRiuz5gtmqu0(%ji_4KUBrns>Txk!aV7Nk-S>Dy|a1k4L|5jVtz#rZn;sDb43KGt8&y8{gh-IM%b`NRRAV z)aA&$^TWV?eR@j>f0|Kb1!88TPzyM(jTI9EugpNuvU0EUF~07o8!XZ_Urx~a=!X?; z0Nhv(oL~+VWJ?m67W+68`8B6wp-ANy#++FqHQP6y{OyH$JORBwpH**9gN}WlT#-fn zcMjV01V-ry5RvVoK_qbV@;8luGzcPdMwY!QCbL=hSanof@Pr}SQTfP)yBdXCb>MYb zz^4lvHjC7`XB|`70Tu_)Eays`4YkW|!<}g4ff4P+Gr7sXQ*D6=IbYW3pB&P~&v$WJ zF7S^RYx0e#=DOb?5mH?Z3Yobeg?(Zl&0@xc2`HK_$1fA%fhkR&T^qh!uf~bguGU&-DKkrrI?jXNtu^STrP%>GKyN3Jsqj9qx%pJSnxeMtIF--%FNR@d z%l|=ZcJ!I$H0OPzUfskx7{I(Ij{tb$CvBDIucwtMS9t75tEV;-sSg6l^3e8YeW*U= z-@wfAcTRT4h`Km+jqU66&ruIV=N^sl4nAZu70dOb*c$se!)SSqhf-}oXuiiHVw6s9 z#u>_Sh7>Bdm;^KP&3L9DtzV?=ggi}+{+0v#a214prB6AH=}K`Vsw^xxt%ZGYUQH99 zbEs=g%|$WWg{ek6(XaE-UH`k6x@~?>sAgjpZKc3^`G;5F_yFDwwoXE zX`DKvk!oPf>UnCGE~ig6vNJkfc$rA`BzYl6kcx|gQppkw73T_qc#W^JX`Qq(%*+O& zw4>gO)TDmG47D@i+qCaXsZa)*8kFi8d{StXa?QhYrEtpJa1mK{BgY;39I2t`0&6@W z2jO6p|C72uJX$Kz#QA1nzWzcR^0?YJvPc=w_hyfI%9ofhEp1j;cJ6TYq_@#s?Dq@5 z%5I3~>?!)#&zg@`Tix90``sX8_v_aPu;h+?9E}zXv}EkRO+MMwa0b`u@ior_1u-&N zGse1@ey|G~CLJrTj)tXa3u6j@uOdN`;fd5%zrDBxz^B)(mzBX^*5~?VU~bT&6BBDu z#V&T;L9iw{*Fc^h=6&pVM&@HwxM)rwTe^Ao@lw>~g z1j9$(T6Tj5Y1&UY-J8RvP=Sq6ZhTUwX>fRO?QtVCamPdzwB)S8cSsQXX5U6fhh$Fgb&%Q}w0cmF*63==bs;xRjE};+mq5_whLVX&U>&)#jZA zCvMH4PGHmGBy%`=GbR$~ntEChuw|dy4edb7Mm(Pl&AG4B#(nQPf%&}xGRaGEJx@0W zN!0MPlyFB0p>|-7^BK~wt7b4^ec;+{_dyDBhG2c92KSe;-=%!*v{$_@lop@VmLwo- zZm@d#1fk)-DKO5$b7RZAy(v&d7NA|d!>*`(lfGB%YOH)#-RfyiJO1(*%LX>=@FaLE z%+TzEqwoP*GQ;2G-AyH_zL< z9x+{M4|;q1d0AuURr~H(GTKgB*ND{MsL{ro!n@xA?nu1pSiFNuP88fs9XcJDS>8ep z1N6R0iPGUHBvM1^q>4$o)|DSp!{7Woww8dnES9)AW1S6g;=GV5T4+Xg)b$Q@COZq4f zV&U-}Obh|Ru=fTB$0#Ah6Jj;Y%vY*4DH;8fd<4vWHBYV)`E)-dQ3l>|>msNMC_d!qzUEQ%)G;(b7wP3vTKR$OE(Mv^;9JUwd9S%kt|gc9U*g(sle50olgeBH>$|J}>No?YmknV^>XWH2&pLQTJBNjEaZW z{>I@bTx(@R?rj_DMK>}eR7v`Q%@9RlBRXCfiS&Ld;|=D1jox(DqJGQnXq*<{2ScG^ zWO42^K?Hhi8cAif)8CGmZLWFVY8or27M2|uY7g$!J~#qnz%}m*DI*#5YL`?(f{sCA-ly$>FEqJDPM_g5IMlkppsmMd{I?(+uCv>tQrJgXdg7%)ClO&_nnj6-$U7SF3%L4LKKaE74GA0w4;UO2 z5C$lxVB%aZ(P;?iYc%L(9T_$hW`x^d;`odh5x~m`4VqNk#Y)ku23EAv@ue&o<&5FB z`8g335c_-_3aGPJk^H#=zmQlQMi#_~P+Sia4%6TX+Z-hL@^ue`*aQBffJHDX_#MVB z4&MoffNICHUh`%xj58H8wE+{Yp~)SGeB7AIMIYihzw4kPpkj8AWPCg5Q2yd3!;Q@> zj!!i)Y#8|^Wc)WNdK?CP=(>tw-@j5oYqi$dDtIrIHS^XM5Vuvc5XF8(<-23bPKc^g z?(#g{phy*jgEj+v)K9t|2^Cm!Q+mFBl!ttm+{d#@5OxTolP@w;TdLh8x9Y8YaDn1T z?!sg}`5Pxs#yI-r=6RE})L|Cp z7p`lf6CzD+gOG?%>JyPOH;H{fmE-Bs7ZI5DFVW7?%JYwEMuz9=G-33#GmFwt>x*rD zu&0?e5oi*$po^^vqD~DNZ%9gX91Q~AfFzS8+$5;DvpCe&VO^ZqB0yB3kS>t40I2MG zB(PH6FCjKwWce`P+f7G^7dnKyPiZxTwspoM7I^!Gu7nY4Wfy#13n2eq#>^+c!G{Wq z=0gPx1l|Q}ty}4e51{=Ta9}xkYS~HutA@BeK?*`AUm=#E?B>$#fK6IHH8(7I>MHoX ztR&oC6`7)UmE;}P0N&frT%Cd(n0GH)oT(Vf)v};~f)ke|OCsj)hym8t;2**2%praN zL3IGMlZXXvNVtKc8oChb;KRs@HfXZgOu&~n<8&uDm;p%^zak$2W)n!4k~tv(wV zIcjKGtn?6=o?r8{MDSlwW2t`|1wQJ-2XQ(tZRR&sR-xRP&Dvbr@N;b{+NJ=`vp#XY zUPdm+^bPKbIMqb@>5aJ7A$Z20vXP@`5x208BUqHo5P%SRbmC9BzlI`8#VC02Q&>+9ww$2DWuY-zy82tRMb89lCpIxtJxY z5waGp?b%Ua|F@g-=6t2@bZv;%7Sn@%hN7d)Qw?I06OJ&-*9i z3P#iy1BV^{#bUGzW7lK4!ob$&ZcrK7WvKf~`}zF?&Nxq`(=29=P@1AajeV(65&?tb zV^kthi>WyM{Qm0jm6eu5eF<)NJE4UV2bvjUO|Y51)cSX5dLW{yx7`wxdOf))=ZDgD z4~vAK+Jkp{olD4RQZ;nZMot*hvcS=Zp6tw3f$KOFyf!H8g6J=zOk-g)e>{v=&^a3& z6p_O+l!_7&A+}4byHv>4Y5YHCWK_d!)>(prAjpg{H8xnkBYq3Sr7wxvId#j94GUR1 zwV<&Gtw?%F%Colmn%Vva@wFk-%ozcl7+cy_e^o@@D@LPQV_Sq!!U<|Wm5yNr?{~OJ z?h~9|P>5I#+|gZNj0fx8f{0hTd;a3u(Ct76x4PGF!}Gn`Q}lAwYP#5pQI~a(LJuWl z=xF?Yan^D%!#jJ%^^Uc7o-a7->5how{%aJl`-4V+&76PENVRpN8{xax{Dka2={*nb zaY=ly7IHsvM#r^DL;;1Pt>+8)K@w?(>k{LSvKRrFV$ZHgTHv31f7@^*3kXAGFw)u# z_O33BMYe8VV2Lvw9BEsvRAe=>#|v=kvK``xfzj9L0-nMdn^HE8W;pnZ^6WzWTD;w~ z3lM?oD(SQbdj>co@MK%}$2^2sbqwIp6}NtM4A z>iO5|elD6We%6F5Jcp6$k|eKem1gwJ&#Ls)OXlluY0x{qZV%vX+Zo%+5KZPw!ReJT zlMy@0kl>Eok$~>1TVU=bw7`epsW{Ac&!8?i_q(!gHF4wDHr_#`g;dJQU)hNZ_o+m@ z*sG(wteAygW8?+;8L@7|XcluJGT(iXL^`-$?tFHwpe8FMko5rGwgW|WM!s!~-0izB zKj@FaCQST(Rm*(Z`{6vT2}1oGj{Kgc{@pb(Hl|#ka8A>35i4wyT%#Z{_@?H~wj56{ zjhwO7hIR2p{q|09!stPw2AFSpg2y~Z4{u}%7 z`^&f{KlCwiqiam=W#EHF{6J-U`f~#XukUM*4TcK)Q2FuHf02GD(o1z5`)=CegcKTI zpza?0&WZ7YiMCb?y;S9M^U}Y<1bgt33)?k;rO@hC)$yQkHD=G>)c#W%l_YS|8Tb@p zDj^H^VEquBe1x32W z#ILq56O(3LWw@9Os|?~)1@<%9Gdl%ks;!IAdJRf5$h-Bnuk2YYq+n8JhCo~0!c!?e z&T&<$l7x#FKRCz17(-#9CV$^o1vTMQi&wbO+$2Zu=-0ono&KV><@*A;N$se*HGa2% zEC+a;E7h0I$XY~713~RgSk5U$gChr%*|S@9Fj*7J4?bw&IvwFs8}+%zDU#$iAjf5U zQe{9CWq%xI8uPa$9=%3fRV=t=9xgIV&Z%Y`?VT|3K-@S8W!!a2GFC~mmfT(ojvRP( zN}3U1Ws>e3kf!E#_(*a!4fEq-$z92Zw~#YXyYTB+4XArt(zo`qv1C9{A>4l>|5#Hz zwPwjFhNguuW$w@IxC~A3c-BAeK4$C-GEkj; zr7-4$HRS#lZ6Jn@>X0d^8f}bPw5qo zf*-QZ8$|K<5K3f_%3;!xF_I^_M^$;A>eAUR%<8qFMBr;>TcaS~0=tz+@iRRtxe znFlq|5lP~~S|G_Ti!rNDqL>qF*W43FHEGy%jCPqzBqGCi>6~8m6zf z^qTP7GsVPYRD1aJ>b_+K4X5vB(jp|caH`BO#49YEQQDzvL!s8&XT0XEQBa-smEMx~ zG1M;jjD-y()>ZfYt{KMln;DAS=!Bm}K@QzJVRDksQavBW>~GoY&Qkm($m0umH%SIAUi>NlUq!P3}hZ zwz@A=0Kvbkpk6>gE7otqQb)u*+Lp!xT2fKzYx>h=%JtJrLL3z2AcbwI>V@)kcKpMZ zuBztLGlKRvzf!(AL3C4*q`6!5QNN@JSp16k-{qhcoZd)EQGOD!*Q=H%4BRU}NXvOP z(uLcYOV04VoZ>FlC!Ysi*j5xPfONLmGyaprKb)zi^WH1qp}%Q?NwNhAoJg_E%*7H%FuY8 z__VfSw8d>r7DYnT0C3+R!EHc;S@fHbD2MYQ;4{Q44nk`uMWV?}!UgC%VZ3$>WYgv7 z8^W``Pf4cR24+_@SuCGr6KVxx_s4G0@SFKP={U+6!wyJ^e8jR(1dyNI8{hK8ECOyC zwU8)C7u}ln;Q3lCQ1Orud7b=&7qBuiOoWAjdDUtjkqtRT-(K{B(7B^8c~@V1jo_Jk zb8<)aN$vLc-o&0_B$#iV&7MzFUXmyrwng$*nSSm+a;AfmrvE?$85V#d_;pvBvuqSG zsk;Yn6L9rRTJi*AxiDkB7fIl~B1AB3rVh223~uFH!ZpnSJfi6!pSR&W>*0IdR*g~u zoK%hNurThhX8=bDwFEh1gos$tMF;o?)y*(qa+Qgtn0%lr7B48;$!_SmLWcaE=38ni z&$`S?wjIKI&5`YLb2cp)4i{fV^k1Dc0x-_L3 z6I|4Y%$zUcZg_XBEsTr|WqIElWzjE3DMv1;uCb6tlUTb{((?iGt|KHYBe;w)_R*^i zg54-%i=z8Nj;LwJtC{D1`ex}b)R3>8lugkw-0SwP=VWX-FuRfr#%BQH$Si#losRjDgP|1g^yx{Cr;T@1A@z#g3CK1OFTMP$a0> z@C4>&WawSdn&^D#7)oeWn!b@sCBExDb%g+~WPu58SLI4{i7bAa2W8mrAMvkuTmrvm zb89hd8nAmx1;d8!9hddq3xAd!?8Jg8`t>t$cJrF%c9N=~CLsTKNEkq`UYB@_xf*`2VD-OQpLpId5=;Uk8*G zfc3tE1z5oSF%dCsGvs5mI&}6e2!JcOh8Rs${Q1`HBISdO?@RB)i_45v5K8xw^5!J0 ztXKJ@S);km{NH7)Cv z2hsb|j~ei1C}v1Pm2@n+=@z0j9aMtWIFzmqZvg-UB^@OI6Dx;&)|7BFAtZDp9DJ!_ zv}kU-VJ^!MwY1V)eloacy(a$b?)TdJd<;fQ)scPMZyE<5_0k+lz?M3+f?e|?6S=+B z&k(x8gb%~58T7kOuAxqhjux6l>SQ`tM7m`;{m6Yo+*&dG>5fSdvW;Qgr0G^Z6-$(Q z4gKJM41kQ9CWOw=QPZOVNxdWF5brAIyXn=KjeHW#a@W{1*j1~l_tbC(>q}5We)71P zC7dyx;Cu98Z6qgr*Y5a(RaS$c68Rimkz&_2tWetWW`g7ZADnxbD9mL&JyMx6x}Yfj zt;nDR9jx$!E1RB|j_R>xU#1i`^iens6{-(kYVPxc$uKjZ87yzF12MRo81lN$pJi}i zKq#i?Qw^n2?%bDw21)XBRFbqJ*ey`2s2ow*^rhe=Ew}-3@7CuWi%S9nzq-$Id1;Zt zwJa^KY#d!}c?^8>bV=m4fjP}P8pDc4>lX++b+RqjL{Z+YwG}9MSFIZ)7I^c%I;4&Y z^ltseSsZW;!`u--*hZb2(x=CWi2uffjg)nkcjhD@v{<~~i$mVD9dhzU<$nojm(=2Y z*y#~I?6pKzGiZLiU`rJVz-l4ZY>Dfu!aKbtDY|k9SA{}zu4vGM@!Vbr5P|*XB-u8# za#f&KwrDb?iz}2n)t2iCr-KBQ3S+QqcaGdgS*QUid&21bk{Hv1AeQVXnA#eCF%LrE z*4p}EY8L;lPD@in{s-!`gNT#Bq#T!#aBjT|sYrO1N3w#Clc9$nhze!~(e}(XEhsM^H9BIs?xTDHKwgE=>-OphIN6~ zvs+~Nw4gE11Y?-@X?_)h;Qyj!XF?WwvO!5FW5p7|P&hvSgq^r(i&ln)WZ}{*RN#y= z#AdO@TFqP(R%;fPrqbRlC!|2LG&B6B6*dQ-Di2b2!*p7aWc3!k#bCRI;)3ajMLgNA z$+JT*Lf$CGUirH=qc>Kewz`d`Ro=slZM%WUutz_Owk7y_0Jc6;Hort^OR;O;(^j*B zx4yALC}yYOfn4UwU8J{dvL_0gxqXN;mSJ(s$XqD;#lL&DCJ zg#si?w|CE~!n(*y;LdYl@lUR~DaUUESxfq_}%NHB+FkEIy%~mCWpjWB0eLFzGSiFY66qJ1}B9A4h>_jqnB&>MVYyB%`a#aXA zPOY(AUgWvyGir+te!BpsT0MES7!HJ28F$eQBSv1QN+V^{hulahvoJFUnw^AGUU)#{ zzE84yk!IBOiEFtxC@0+E+o{7U|<1V<@{@uQ1bE&j;OENTe zM(PUwbOx|n0vZ;4=og~g?OU%1ZR}$QQ;Ew2w{GX9)Ui!#SU5 zRefbpB|($z1upLH1B1J}yEC}ETn2X;+}+*X-Q9f{+}(X}7~Ga`<88d%{?Xl05nY{~ zm06M5m359grk!4TUkzs9g&P1)q)#em%&Tk zERdK>txbTMnz8vF-q1Aa?`P7t4guZxTET;Pfm{~347wE2J)8K*0)c_M`uo{ovn4r< z!*dpX7aUQzdZptL5s0~ZVPh-ZlINJP(6}wD^0;JvBX}MSu$}QeSKcetY#!5GvH4gAq!bFj3V3JBSPfewRu}~YB_{Aq8;rF> zSeA|9oIMa^DoR&jJc~yzWXnUcEDH$6M+r*V99aNkyL0X)7tWf!5h;aECMU`JEU11O zFQiDiIHvWHT!{N+RuXr8kXSGgsE+;&ppLqjnOU~!3VafMz^ihTd1AHG>-QtvC7n{g zrY_Ax5vnCVvzs+6R3lZaqrh$&?5zp27u@`DyQntWZtJDY{PO?c(tL~fEqlWt!n7PSHg++{CR^3|&Mzb>v=^azZu&tQ9^5{DR@C6@ zhIVS>W6Z8&9$vSB^YJdmOjN>eCBCN`#}nT~OiCuPwFZ3)d<6q(L_(WW{|@Z!T?JRX zm>UG!w2c2}>_~6=72B65eI^)|n}zSapfx^nA@5R)Dd|urC9ZqPC&ZMSBUIKcis;wg zctb&G{UXnhQV|{%M`ORAp_yMBo(kN}@;`_AbV?F)@0sfk{~ z^;+c;O!!dR?y_6gN05PmYCiV`?_iFC-ceZ%QG$=)qltpJZM(r1SDWJsRSjcW6QzHa z_o1M)PF;g2jMqH7OW1hHK!EX#`}Qt&AR&irC# zBDZl+(jSdk%n@aE+n+3@aT9(nT3`~|=4w;n<)h_b15qZ3&Ruhj&vctHr3cgIqi*ik zI?7GcC2TQeG}k6$K!kE8>F7Knhm_|AJfcTErO*9xS|;>~C1HNg1o(<}`F<>r4P3gj z|A>}9?3jbQ^$nsYb?mRWhMRkmGnF31e`h{Hn) z>JaV{{%RvHVZCqs&U}9Groqez*k5~k205Q=(UkCYMj}w(8-EkCkZ+c;E6Q6)Ip)DJ zp!ZIe$VPy;jsMk7pXRoUkWAS5DCeFzy0@&Z0)0GA(-q=@rTFSwejLtD7T>$7`SXBX z9uamQuJ+qA2$1!+W#2Ko>Whjq;J^4ZM1vB$xlPP{Ds*h zDb@bT(F9gwrF7XTt?@)2M5_c*l))ZFI9&W1IE%muuw%OMfqZt?PAl<{Hss%>4Y)f2 z-|rCZOi9d2eid;r5=txz^f7U!2;@LlxYH!+hTtw56)XM;(UopZhtm^24=3d)slQK8 zw>GZxL2bur;F=rC2%dkWCiq@fM1iSmQ!_b0|^i@SE{gjSPr{|B_K)!-kGE-f_yd<8nrNQ5D@Bql zQ-+ol1yV7a3irA8&P7DYAFfr!Her`S^rlHyafh6Nm>nL5^yn0@q2%+a2Trh+rAhYs zhqi<0=<1K;T?6T3JCF|3bf;IXxy7^)PU3&^kZk|X*>-afa&=CjM+}P@=iG)cWjcCCR@nq)BACoNjkNS|*%Qf{=z2H0R2; zJ0hH$2aM0!H>{>#Zx$uZ9N1WRq_X6<0V}RlAMMq6T8iCG#i%byZk>WrrI<|wKDF$y zg%HUTQLt_NYI%n!AD5u{?gOe@9PgH1K9yvD*>Jn-HME7>b+NV|r^GxSx4^!iWZc#D z*^QnVW+~l;U)C24>Z3P>V@Cf#pXw>*dAJ{szu`9RCQ!XUe1sff$n|k_=_=uqXuc{F zX*iKcZ%@%0Zp49b(;rLhg5kwCtJ0$)kh14j*%0|F47X{=q+9YfE+2&xof7L3ojq$~ z!Uk-*A=c5QP7zX*kA1xBWkEDsR3fuY37gc-QD8#*9-7P*-H2KxcFBpqk-Avgtzt$Q zI+!qhJLCc#DrbmeXJLH+mMzBTQkgF5uGIE@!lE%&2zGoPHUTLo7glF+SO3aU#R zD5Ggg+@uFCwQ?qXBJ*(T(o?D1N0QSZdfTI~Fa9{|=5;(~s%LPHlwIpx-hk4JDqGL4 zr6$CG1XA(>4!NMULz5m^wlY?V>2%#n>y(iH0xXn%O4|)$2PXY1NOC2q^tcHY&hix| zMILPR5hv~b&fd{S&s);XnTrRup+#-h?UrAaRxc~*W+l_+{0=fmj;R{f^p%dYwT6JF zPc-i1l%&~GaUyKR()f)dk^hNa7XOxBpTs};DprhB9+e`MsvlpXxT)u_G;x|MoQDb@ z<4OVMJhyj?uk-A={++*dsYFWZ#tzw;E4vsYUi|rP$vXSdJiPN-rJW@h!7eOT1RS3; zRuZoYBQyFn;_(g27p<#1e|(W%A36tC8j%$JQ==#?&OwI^GXf$pUQ-K(%MA2|ehO3{ z^)Lj9WoGE*FoR5HKuk*b;AEa8Vn~?T8K78PI_mDkxJ@~aK0T4>J=bc3*pIPSrH15#fZF zSxaSo@cmbu#!6`O=&NQd`o}DnUkhqn zdO~=|XaLcI;{Le^lkK=!f#{FKAt_Nv6%e?x4W;`w`f{uWG3FrZH^$6cPQ3ZL}7-`&rBc@NT5Zu)SO$$GUpYPV0OEdUZB_Ac@oszyfqZbYv1IxA-o`By-D zEf5W2ROp9#g|UnnQru6$MA=9#FH7R;-M{^7`lQqSKJYts3Jw&k!NiqG-BR#`iQ#Au z<@_PYpl4}Z$%Y)2mkK-vlO!V{EpoirbG2Lt#LOILpLY^!WUdCaK6lbppN)R%^=}*< z_pUH*dPuc%DcDzYusPwFk@%}mf<=azP-<@Bm$ZQU_ohk3)=s?EXonx9^<{eC+sYc_ zuDt&y*+n$IGlk3eHcL;Uqa-IH9jUlQW%CjcuYj-*Na=04KVY;-zquSt#?<^ne7-h2 z>R2ZI7!-xGcetlnU)MB~>S4=WpfpK1i{3GAcW4ihseB-cgA_((w}O~P8j$HjD2enr zIbQakon9>t9uHRc9zKZ2DHzh!?@#;vVnJ(m*r}+R^6=g0Q~1 z6e3TYX?B6qgAKx@E;Z(EWHBx|-1GN!e37dbV{M>art;fFqY{gWH_$ss zv|JT*j2es}2M+$o~mQEf_J+EXvI_@$m4xPSSsyGK@IWJnZ!2q!)Yb=xV;&e*Ki+o-khrtH4% ziClhl#@_B;eAc#Gy{%8p7Y&~bN+&H9I?9r``^U`pyp&Ja9dVrcd6FS9VuS|=6kTRK zW2vAZ>>5~m(T};}fV^lg7!FiugVD2E>ue6RtRPaGuz+*b`dDqZA$KuZ2sA>ehha{= zYQ;I9^*9yVy(Kp{iqurds)>Ig59DDm5*Gqd(8TkBaPF?!h}%d&8*v?|T&_#jv_@(d zBC??BHl|yvJ#2)x%SbujPa^C1xpbyYcotF(e%c?pgMop3eZTEBDTb)g+iXzA40z9= z`;<2O@9#tk&yLO*PD0+DB?YnlaL;(t1VCdOQpFJK<7&0cO#}mfd~j=gF{Pv3i4aNM z_X=MRUHyovMMj@p+)`}{LJ*JAR7!vRB!QAJBUO$39y9%n9;)oTU=@tlfhTzi6GrPV`1%u3SE{ z4>P_plVEwK#GMcjtR2=WT`@5__`tSid955X+GAO?8q08qR|(-bC=@L6a6=)pEWy*p zGZjrUW=luN^3U*P$Mr;@p~c#ug-iEqJVCP{F4Fu;ddboIU`Tt?bYepXXOTvp*l{mC zZu-Q&Lt7OacA1oz=hXEo@*v-x9!i!#qQs*#&~tpK)ZHw~K{oRj(qC2ksalAqCK&~0 zD%)xk5t_+D77+n`SedG#(E>Ho;I~OOAM#V;Fc54ng?+1jv5{6oNGW45A?ipMXeLx5 zDQIj>T{0Grw>Bx#mze0)b9yD}N?~69nHOJujip44>4@@n1C(Ot93GC^ zM})hJdLPEv(K;}KGX!p>ng!H7xqGbRm{I53TNzMAg`y;qCvn70?Gaaag%xRFF~!SN zDnG2UpOVp`))W8c(A@w}^xL!OA;9JVDLyFE7ipKX8E@HE4>5oavS$r(6V=lqr2F7s z8ctZ1=uAPdI-kqwe#F{Oui$m)?`Oxs77k(Y+F^&5t1;MK)LPoHIgjTB)A#2_7Ni|# zB+hWP=HTIA9z>9sI$N^*5#W-A!R}?}!7htVPC7mY2@_8|II+_AE57nLY)iwYo#9RV z8blD1{n$cFmHCYNf@*o)Bc6T3fi;>uzm=uo7m20Y5>ekcpLM26IRb`rJ zHk6M0ARM@rD&NL5E`?)kAEXRqvmgrNxW-;<%!h?Uy+7j&l?rby{)0NH$pO!LDy%eK zWxyvCb8W6dd;V+e)2B%eob%>{MitUG!N&Qu6e;UedzDjEnC!cd9wcGZ6ICPZAMVzU zIo(WxQ;$EbEI9WQlLn}jIj8X*iq0a_BMIwodnx_Ff!U#R=G0Y%V>+RHlLczDYd4Cj zY0w`5AlIR(0H;Rf=@s%T7AAVROWTaFrgBiFO0iB%1~DYTy=he^xY;kKO!kgrjUy#)(?eo!;LlGe!Wr zm8547*OxbYXXHP%#AR24KINqb4S2*JH<(W+xnN>z*>^ODl;+x_>sL|;1M6j%gbmDEC zuo7}wgOuq13;6UkZR*NdI$UF@BNnmFR14~1VqJJfzW2rtxiI&pke>NDc;Vms~@Ie{0 zh*QEm@*;K=#e6Ki)Uu{6ubRf!LYC-?r^SK0jIFUFXk^m*WB8`8_D~V->uVP4&*ncW z2=H21mkLanVmiTe>FYpye%+=JE_=L1-b-PU9>lvg+NOrqnOdSVRE8TH<}90h4&IxQm;gy z5e?sWO>#~+x0o@N?*TPt@Y~kB75`Nkh15XFbnhLxB`Ew_K_8|Kf4>tkAAhi)_lD%f zA5Uq(X1WCF+!}kdV2Q5@@TY)EPKl8nL z3=gvMZUt*YNTfxqP9%Ngn_2|mbjAbeG4iqQw+a3D0-rE8wEyzV{1(`oOeS&Vr}P{h zK~pO>BxUp38Y}#Y@_`2231Y88l>55#!6LXzgw%kWVC(z2 z@I_LC=TmxGT>=0yMxF}fVqSK~cy(=_k$O|2F}L-FEl0mgCMdigp4yNoT@D^X`NJKd zF+b7i<;_)Vd1yZN2E4Oe!ZmbIw|gz7)wJQ&BMKV9kZbQw@^t)sfO&+Cp{FtZSnTu{ z4bj^JX&lkz({bW*by!rp4{_BFO|w*$TYRyX7TY%GNM1FE-WHxArI{12*xPQklk>gw zSo(7<#L1d-Sz8D88I`zLQ;;eODc_(6*fc|j;rkh>J{{_$jYf^lD|4aQ4BkL$qg^|h zJO=M9g|##rrQuU?eL>M=eYZG#5~+zjY8+-ZwgEih8S0=$P<01E=u=puKgE-VHMQom zh_{tBJ1@7Pl~vWt>GCzQ{~CHz$NYSadr<0oqw$IPjd4hn5GU*&?e+#N^qU zP;Zq8ahC{VscbUoccH}OjPi*?6;=ZE`52^(Qm!!Ptdgu>+XeNh7*iN$^2yem_KGul z*SixoN6l@SOpE^fOgY)z1#{!=k1BbaYniAh*~#dr7*=s91E2f67hlQgVWJXnuFe=%?%=x(7Z>`>QXf#vlI1>$t>{f=nb-K*RJMg;Y8mBro zx>HXW23*h`g>VS05=8j$0sUZmt|5cDJa zyYCUiXp%`X_lduZz%58@)$GA%6KGe)poo3y%Jy@w`!BYe-3UfFJ$ZM;54S5|ZZC{ufBL%qXROKnJ^rd> z{|8kUrzIE5H#6dD0s(e3`znHqa-6jIvTIYD7YE_zL%dE2Cs5*}{(}L1H3y?77W#Ym zpWJsA^FzbO^1mxG*RvI@2^sw)Q7QX&k)yj)JN>)qme??cDSMSkvS9JCnsGYTAq}%j zbB@%sS?XN^+&@6MlC_F|Kvpv7oi8Qjo0C{ar;4Y`|MJG%5~M*sZYs)+s z#Kg#1jE^Gcs}#z!vGUfCY%x>^O+WM%5~`&-ORWV0+^t7#ln&5*~eT3M~zQk zHoAj68WbdljT}bpYmvp!WRt+TxIEILmlpZI@>Fj{zIj=b+s3cg)8~ElNAU~)*dvNc zw&Z2I(yuxx@u;Q55T*TSufLUu(|4KK+O$;kk?)w_WU~d;BCD66CoBnx&QVp6Da%N) z94{!BX;qldxfjNvS`P1tc7JzrqlJDC8JDdS-!)(u*(kjuxD3J!qc@3`a%FAcw#CO; zZKNP2TkPaWf7H&Xm&k=%EW|Ovi7DRG^Si^S=L3PvxjPA>5p*G$2M&oBqEox;TRpve zZKzS9$z^iL;B|XHw`u6=Of%1FOY66PaT}1PV$|UYw|LU?W{t4Sb@NyIG35CE#mU7D zs`e0bWe0Z!x6EQ@km_=EDvTet2we)5b)u%$?jstPiT4}UknTKTZRab=PzmP&T1<*# zGgcZkcZRHd@+he(bUNHF}mLm9;zN8D{Nb1Ku#(?Ey!WBYCEK7L0^+!sNmq6x0iTu(G z4yjhE(8^RS(i*AoNySfL5W;aVQdVC&SQTvAip}!0*WS80+;V%M#vx|$VqjIHWn{-w zxJZv9n*9gX9p51<_mi$^0J5+>F7Ek{T;y8%TjgS^sM_h;-}((nk$J~j>~(ketSWfY(S3%I z|Hv?cGxzrBR$C|xDFkR#e){*-|OfNx*`zyQP-Z@6EL za3Hd1P`6~zplZMXAh=N%Qd(DoO%<+O_Y`!ee;$V{PzTNSQ3orDwiB8(5olD*g8G*~{LQm5tA97!_o!TdW?JcfpCslR_I)yjTD85T^O2MWO+~urv@h{(YP4bK5rn3=12Hb<3$?g@*QCDkJ13-F z{fo}5HKi0#4&00}@gx<5yK1BGKN(%e&e))_g%qgWFpyL~)Y!`q zhPSwC|2=cDjX|#*CkypG5|%9>wp#5iyHz64bi|Y@WRCd1ETty z25=Ka!hG2t004wQ?ANeWRl)%FT?(9*VE?p^jkks!!p=1O>7_OOfurXi@4!j@ zO10~tZqwdUq_o(_Lge|av4X-l?QrUH2$vo81P_%I0}`#4eaDi;mwW`S-LFD_iC?6D;A*c*GIn-pOsPICgb*ISC%V{*BOL{<5~wS5C!!un{$rYzB*Pb`%e> zl90Y?qsFh<`vun&>1G4-B=7y?@9mOshWo%tjaeq_gNoYZpF1McSc4>PZ~(yc3sV#f zi01F~f7K1qP5UCzgT{rF@cqgSMA4F%2J|V%d<1-&>=`)Xh2%RGWrBjoIl~G<0IOJb zYxqUzp}&8<$wgWxuXIyMj7QAk*-jV*Tp!W>F_zoi9DiY<@=P)QfjYK(9dzsJ#R~_< zXD5(1#oJnEJawhDq@>DsL)}dE2Pzb9SKh*ea`a*}PbI^lU13d&n^%DhiKCOwitJ+X zk&9$9sK6$op+P7YO5QzLeI`L}eah|0uhI14jI^i+8&17KV&2;dGbn+hVfS}7ZT0b5 zuygWBf`O|bBaL=UZWAfFjoAJ08qABMfd(VzzFN}W%3;@xyA^)Dl-G;paqZgD;>?Ln zVTp=zC>O_NlQM5zF;`G^2KHqlL2BspQ&PXHje((OOm zXN4A|1Om~G1GoTMUxv>0)dUBPii8DC=yy-6E*^GmBQ5q78#lH1U} z2HZ-x6V2<}fs`%7&sttKcOS7}S%&^qho_yi&#`f5qY4zC<}&IwlC=rNWxBvy zcteWFn0qKNAO>?l^#Ax30K&x3&+qf=I3ATYOqMtirI=;U$B!k8Fk7I)IsKZ&oG)^t zzhr_G{Obz@V*U)^2Izl@`5(yvp;BOAVRg^|`fmrEvABF>TTf}ovwz)i1&_a0u)520 z_uF^G8B)MD^Vd&imb6e!m`?+GHrqZE@N7$&NQvA5G}#;{@|WL|1*UE%(HIu*e_CZ5`=cghb=E=q<eeWT8wtW9}>Z zgFiTXha3qL!S`A0rbitu^`~$8EuOt>Pd`yVbtg4$5eYEbp>(>>L5!uyKZKk8SMg$& zndlU&cMd%S64~jNZjZa-Wp5E&WzTDjRtF2BEeQ9qek?KRj;i~+SAJ4Z@T=0RR=)u{ z<>}6zm8Yhk%kZ8tun5oDZ@I7#R}z8;@k)XlZ3QyWxA+;_3I zJ-}(<)pV^tH`X0A#vGK$Iqgk~bTZN(Q)`E7+}fe%()wpGzK`SPXyKE1#$;vUOW0`3 z@FzNr-HD`k(1-SFTEaKr5H6)!xY599W6G`Jw;gk>iT-F?3at}Nq!~kBza_&s;!5RV ztvdpAH^E?CC<$S-N%Z z5O>~IW2He`=sPTm$}csBGhp#gsMjt2nI)LaK0R)Hc9#7t2V0S=OX>W&1AMc%68}Hd~kd13{J*hJysu-EAdFAkcL za~d_J)EeoJyVek}-4(u(DHMlVa6TSUVbNQsK6~m<6uQHxK{vWgbh;CVGF#?r6aHhW zJbp}LW2UaxI8qddc8EW&qjEwubD3CQo$!7JmRNE3HKj}58X^^H_qU0u8CMcyg`?}q zb*8Z~UEULolm#kC8y7rjpS1~V@eZj=0JJa+bN7T~1 zu-bHSnyZt+<@hPiBD4N*(NII`>#N-XP6&QGsljydGxCFWJIB>vRp2C^Yvz0IQMEhz zE28QJUnVJcg6FkmxO94Ey}7Zr;lflVm(p}4PW3S{@*yljB!RG+q}r%4WTaV);ZMlU z&8*DtUshhpP3dN`F}3QBZI;~?M|t<KvZ$s>ONF0VHptOs`K2DXHBn@V6CaUv{Zb$>?DYWbyyHh zB_yU~j0_#~Jqr_~qd{2Ll3!tk@S7<5;5t=EO^9zEZvUsE>ot*T=tCaLv=Ae78IRDQ zFv`vZz+E*pNM&ZEh`2Ake~8Swe)xu1N@l=gu8<3RPM(8hzIKmk13zbQ zc`)$K$$`A3Eh8xb(iBlZ+?dOX@3KFzETPC(Y$@KQEu8>HXE46O-ee`P<2Tzzq~jR& z0gsjp&y2uA0D*Qe-0a|qA{PNtA^U-}YQP^QZg1dr@KoI00ReYpOPs4S1Y;g!zRro{ zLhSM0v?8rHL9=4SwnVivboJ;M7w+*sMoNtDVCoG>H+*_uy1S@5 z$N7x^59|2N$|D&0rgw#FOF`wtb*;a*;5lv>n(C<29P!whhY$Wrl*T5A;CBF&N5W;G zB}Z^KyiFCtLnHe+g3icM9S29og;@Zo4<@P)pzCjT63SndQXQJB#aao1RU&N=i>_lD zfM_w;z*4hL(?c2COCgT)3nCa~7`yRmIl*$6rH&9o%_Wu`BX9`ZKByEY6lCy0h5i-% z^kd`+V23K&fFY9?l)EF}70%hO5=Z&>P^KNLsVeo}zV=|Qk7I>`Qv_+qhyY_8D3>}o zLwA{~Xa7ZQaqM>>{)84&F{_B+w43oKgs={{wk!IzufwpEMm1MNq*`54HGZwAE{$w% zL4ic_pi=lIC5@yc%&I^MCz~Sc2WGcNU`|c!Uy*Jpt3`ShwiE5=058ehCBm1W5B;eG z*+b};0s)%&Lt|Ej8m6%ZUE}2H&)MZ7&dP;s3bluFShLb{_IcHgQ}x8j){@nQa)SFf z8buSEav2rv?$SS#s%lmG8XIqUP!s4h`44M$|A0CLIxan%`F3mYmVt+^l{O9Q_f(nr zch-S5P2DZaDW~ZjnyF_DoP+A^!5;CMpjW*FUh^Va7v!|pe;keTOPyl^W;~OuwlmFb zSj#rFayh&f9GP&e>wxjH2#x~-;ceJ`ci?)qATrjGeWAn)Drl4w_d5+r2sEtJ*o)dW_5xO}*b)@)juXkVu zNfOrr~}19SlrKVYCjaO1$x_s+rdy!`=))@9*fp3UBl zQELQJ0;E{Wq*2?GaBU(BM_}Lkd(_>X+@*N4B-vC%VHAezkbyuvztpb)Fy^b%{{(=5 zh`(U4f&6}#EZi*6&`3x~h)5{VfbK~n${pPf@T&-a$d*VEFus7!U(9tdgamuQZO@;2 zD!E5C-CDoJoW8b4tW8dhV5r~!B%`LfmFQ*`b@~&TyWoO;=T|l71_^mi}jEF0a#{4(b|aLbyLLGD;PO6Xn2?*IhiOZj^M1ixhS z_{wj^gjM{zG@~Oe+yKc+*#HUuRs_y^2_lwyGqA0r=ar$QDj)e}aieI`zYQ$Lt7+cB zPgs@9y4aq(e;Yn(`U(Hx2PuOA3H&AfJ^uexirBx-2qBCCz4JDe&du7`xhcC|4-7}! z!%B_zu(wbPMkBWjmT!jDvitb_*@OHf36;?=1Fsm>Q)0fki2yC`5aqjBJ&RT<8Ub+hz{8U0mi{{u;Xo>j4I~_;+i&?3UiE3A z!?|y@)EmhGe-nB|D41*k_LjBjTLG>{;O*Qi7{uXR#smU#WRE;s5s`}tY;#$_NeCoSvUoJXo@*(9ir~1u=4TO^#{!pO@ zrK6=@h)%$z3{iiKEFXXfj29;FIQazR-y3G* z#S{NsRnZx=PM&mZ^KNdp7xCFGA7RNyd;%PD^KAb!APZAj!$2UBvA@uNXAweQO@NS6 zFz{fZAOr*e7JVjw3h%4v>~9Uc5Em;LFEOw1R$?T60{#3={aRGj?eIS%<76RI@LDes z-D;P{$i=?Rfr^q*;`3so*^XsX%M|Dmz@S~#I1h0J$`%kxP80|v*8B1T)vwq5cPd~C z1{H(n7fXud*9Z*_U{L%;jb$j0sh5WVj^uYBN4XIb;_nw(hx)r<65V=yOG2+TMEjW3l!CU3mUipRu@C7YR2liJ|NkT>$UEW+5?}WKFaTut Ts>0U=3JUD&3}M literal 0 HcmV?d00001 diff --git a/test/mpileup/mpileup.1.out b/test/mpileup/mpileup.1.out new file mode 100644 index 000000000..41340661d --- /dev/null +++ b/test/mpileup/mpileup.1.out @@ -0,0 +1,70 @@ +##fileformat=VCFv4.2 +##FILTER= +##contig= +##ALT= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##FORMAT= +#CHROM POS ID REF ALT QUAL FILTER INFO FORMAT HG00100 HG00101 HG00102 +17 100 . C <*> 0 . DP=18;I16=17,0,0,0,688,29762,0,0,958,55682,0,0,332,7446,0,0;QS=3,0;MQ0F=0 PL 0,27,189 0,9,108 0,15,134 +17 101 . C <*> 0 . DP=18;I16=17,0,0,0,650,27530,0,0,958,55682,0,0,331,7303,0,0;QS=3,0;MQ0F=0 PL 0,27,182 0,9,99 0,15,132 +17 102 . C <*> 0 . DP=18;I16=17,0,0,0,695,30453,0,0,958,55682,0,0,330,7178,0,0;QS=3,0;MQ0F=0 PL 0,27,188 0,9,111 0,15,139 +17 103 . T <*> 0 . DP=18;I16=16,0,0,0,692,31998,0,0,929,54841,0,0,323,7035,0,0;QS=3,0;MQ0F=0 PL 0,24,189 0,9,108 0,15,147 +17 104 . G <*> 0 . DP=18;I16=15,0,0,0,611,26723,0,0,900,54000,0,0,295,6259,0,0;QS=3,0;MQ0F=0 PL 0,24,178 0,6,89 0,15,133 +17 105 . G <*> 0 . DP=19;I16=17,0,0,0,604,23936,0,0,989,58441,0,0,317,6751,0,0;QS=3,0;MQ0F=0 PL 0,27,170 0,9,97 0,15,125 +17 106 . G <*> 0 . DP=19;I16=17,0,0,0,644,26574,0,0,989,58441,0,0,299,6093,0,0;QS=3,0;MQ0F=0 PL 0,30,190 0,6,85 0,15,124 +17 107 . C <*> 0 . DP=19;I16=17,0,0,0,694,30064,0,0,989,58441,0,0,313,6543,0,0;QS=3,0;MQ0F=0 PL 0,27,192 0,9,108 0,15,136 +17 108 . C <*> 0 . DP=19;I16=17,0,0,0,692,30148,0,0,989,58441,0,0,310,6420,0,0;QS=3,0;MQ0F=0 PL 0,27,190 0,9,108 0,15,135 +17 109 . T <*> 0 . DP=19;I16=17,0,0,0,741,34273,0,0,989,58441,0,0,307,6319,0,0;QS=3,0;MQ0F=0 PL 0,27,195 0,9,110 0,15,150 +17 110 . G <*> 0 . DP=19;I16=17,0,0,0,704,31276,0,0,989,58441,0,0,304,6240,0,0;QS=3,0;MQ0F=0 PL 0,27,194 0,9,104 0,15,136 +17 111 . G <*> 0 . DP=19;I16=16,0,0,0,584,24362,0,0,929,54841,0,0,272,5416,0,0;QS=3,0;MQ0F=0 PL 0,30,167 0,6,88 0,12,118 +17 112 . C <*> 0 . DP=19;I16=17,0,0,0,680,29854,0,0,989,58441,0,0,296,6052,0,0;QS=3,0;MQ0F=0 PL 0,27,191 0,9,95 0,15,135 +17 113 . A <*> 0 . DP=19;I16=16,0,0,0,645,28035,0,0,960,57600,0,0,266,5318,0,0;QS=3,0;MQ0F=0 PL 0,27,176 0,6,87 0,15,139 +17 114 . C <*> 0 . DP=19;I16=17,0,0,0,674,28788,0,0,989,58441,0,0,286,5856,0,0;QS=3,0;MQ0F=0 PL 0,27,182 0,9,103 0,15,133 +17 115 . C <*> 0 . DP=21;I16=18,0,0,0,708,30546,0,0,1049,62041,0,0,274,5490,0,0;QS=3,0;MQ0F=0 PL 0,30,189 0,6,89 0,18,147 +17 116 . A <*> 0 . DP=21;I16=17,1,0,0,727,31755,0,0,1049,62041,0,0,253,5079,0,0;QS=3,0;MQSB=1;MQ0F=0 PL 0,27,183 0,6,90 0,21,175 +17 117 . G <*> 0 . DP=21;I16=17,1,0,0,712,30478,0,0,1049,62041,0,0,249,5019,0,0;QS=3,0;MQSB=1;MQ0F=0 PL 0,27,183 0,6,85 0,21,177 +17 118 . G <*> 0 . DP=20;I16=16,1,0,0,636,26574,0,0,958,55682,0,0,266,5426,0,0;QS=3,0;MQSB=1;MQ0F=0 PL 0,27,175 0,3,60 0,21,162 +17 119 . G <*> 0 . DP=19;I16=16,1,0,0,629,26439,0,0,958,55682,0,0,267,5553,0,0;QS=3,0;MQSB=1;MQ0F=0 PL 0,24,175 0,6,73 0,21,160 +17 120 . A <*> 0 . DP=19;I16=16,1,0,0,672,29188,0,0,958,55682,0,0,264,5518,0,0;QS=3,0;MQSB=1;MQ0F=0 PL 0,24,175 0,6,83 0,21,171 +17 121 . G <*> 0 . DP=19;I16=16,1,0,0,662,28460,0,0,958,55682,0,0,260,5454,0,0;QS=3,0;MQSB=1;MQ0F=0 PL 0,24,181 0,6,80 0,21,168 +17 122 . C <*> 0 . DP=20;I16=17,1,0,0,716,31224,0,0,1018,59282,0,0,256,5410,0,0;QS=3,0;MQSB=1;MQ0F=0 PL 0,24,181 0,9,99 0,21,178 +17 123 . T <*> 0 . DP=18;I16=15,1,0,0,661,29997,0,0,898,52082,0,0,255,5385,0,0;QS=3,0;MQSB=1;MQ0F=0 PL 0,21,167 0,9,112 0,18,166 +17 124 . T <*> 0 . DP=19;I16=17,1,0,0,626,24802,0,0,987,56523,0,0,279,6003,0,0;QS=3,0;MQSB=1;MQ0F=0 PL 0,27,154 0,9,104 0,18,154 +17 125 . A <*> 0 . DP=18;I16=15,1,0,0,611,25689,0,0,898,52082,0,0,254,5340,0,0;QS=3,0;MQSB=1;MQ0F=0 PL 0,21,154 0,9,104 0,18,162 +17 126 . A <*> 0 . DP=18;I16=16,1,0,0,648,27366,0,0,927,52923,0,0,279,5947,0,0;QS=3,0;MQSB=1;MQ0F=0 PL 0,24,162 0,9,107 0,18,174 +17 127 . C <*> 0 . DP=18;I16=16,1,0,0,646,26972,0,0,927,52923,0,0,279,5949,0,0;QS=3,0;MQSB=1;MQ0F=0 PL 0,24,163 0,9,109 0,18,160 +17 128 . A <*> 0 . DP=18;I16=16,1,0,0,673,28797,0,0,927,52923,0,0,279,5971,0,0;QS=3,0;MQSB=1;MQ0F=0 PL 0,24,169 0,9,111 0,18,162 +17 129 . A <*> 0 . DP=17;I16=15,1,0,0,645,27891,0,0,867,49323,0,0,280,6012,0,0;QS=3,0;MQSB=1;MQ0F=0 PL 0,24,168 0,9,113 0,15,159 +17 130 . A <*> 0 . DP=17;I16=15,1,0,0,641,27295,0,0,867,49323,0,0,281,6071,0,0;QS=3,0;MQSB=1;MQ0F=0 PL 0,24,169 0,9,113 0,15,152 +17 131 . C <*> 0 . DP=16;I16=14,1,0,0,606,25732,0,0,838,48482,0,0,256,5472,0,0;QS=3,0;MQSB=1;MQ0F=0 PL 0,21,167 0,9,110 0,15,147 +17 132 . A <*> 0 . DP=16;I16=14,1,0,0,627,27579,0,0,838,48482,0,0,256,5514,0,0;QS=3,0;MQSB=1;MQ0F=0 PL 0,21,169 0,9,110 0,15,151 +17 133 . T <*> 0 . DP=15;I16=13,2,0,0,584,22816,0,0,838,48482,0,0,282,6196,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL 0,21,163 0,9,105 0,15,150 +17 134 . C <*> 0 . DP=15;I16=13,2,0,0,607,24653,0,0,838,48482,0,0,283,6267,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL 0,21,177 0,9,105 0,15,152 +17 135 . T <*> 0 . DP=15;I16=13,2,0,0,600,24178,0,0,838,48482,0,0,284,6352,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL 0,21,173 0,9,106 0,15,156 +17 136 . G <*> 0 . DP=15;I16=13,2,0,0,574,22258,0,0,838,48482,0,0,286,6450,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL 0,21,172 0,9,105 0,15,134 +17 137 . T <*> 0 . DP=15;I16=13,2,0,0,563,21377,0,0,838,48482,0,0,289,6561,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL 0,21,160 0,9,104 0,15,139 +17 138 . C <*> 0 . DP=15;I16=13,2,0,0,584,23088,0,0,838,48482,0,0,291,6637,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL 0,21,172 0,9,108 0,15,142 +17 139 . C <*> 0 . DP=15;I16=13,2,0,0,554,20790,0,0,838,48482,0,0,292,6680,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL 0,21,161 0,9,106 0,15,143 +17 140 . A <*> 0 . DP=15;I16=13,2,0,0,583,22789,0,0,838,48482,0,0,292,6690,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL 0,21,163 0,9,107 0,15,153 +17 141 . G <*> 0 . DP=14;I16=12,2,0,0,534,20750,0,0,778,44882,0,0,292,6664,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL 0,18,158 0,9,108 0,15,142 +17 142 . C <*> 0 . DP=14;I16=12,2,0,0,503,18593,0,0,778,44882,0,0,292,6650,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL 0,18,157 0,9,97 0,15,129 +17 143 . G <*> 0 . DP=14;I16=11,2,0,0,415,13657,0,0,718,41282,0,0,285,6599,0,0;QS=3,0;MQSB=0.590909;MQ0F=0 PL 0,18,128 0,9,95 0,12,97 +17 144 . A <*> 0 . DP=14;I16=12,2,0,0,519,19725,0,0,778,44882,0,0,291,6609,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL 0,18,152 0,9,105 0,15,129 +17 145 . A <*> 0 . DP=14;I16=12,2,0,0,527,20289,0,0,778,44882,0,0,290,6584,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL 0,18,153 0,9,106 0,15,138 +17 146 . T <*> 0 . DP=14;I16=12,2,0,0,514,19484,0,0,778,44882,0,0,289,6573,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL 0,18,152 0,9,103 0,15,128 +17 147 . A <*> 0 . DP=14;I16=12,2,0,0,515,19213,0,0,778,44882,0,0,288,6576,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL 0,18,150 0,9,99 0,15,140 +17 148 . C <*> 0 . DP=14;I16=12,2,0,0,541,21019,0,0,778,44882,0,0,286,6542,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL 0,18,157 0,9,106 0,15,146 +17 149 . C <*> 0 . DP=14;I16=12,2,0,0,512,19326,0,0,778,44882,0,0,283,6471,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL 0,18,148 0,9,109 0,15,140 +17 150 . T <*> 0 . DP=13;I16=11,2,0,0,511,20251,0,0,749,44041,0,0,280,6362,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL 0,18,153 0,6,84 0,15,152 diff --git a/test/mpileup/mpileup.1.sam b/test/mpileup/mpileup.1.sam new file mode 100644 index 000000000..65d9095af --- /dev/null +++ b/test/mpileup/mpileup.1.sam @@ -0,0 +1,1016 @@ +@HD VN:1.0 SO:coordinate +@SQ SN:17 LN:4200 M5:a9a06ca09c111789d92723fbf39820f6 AS:NCBI37 SP:Human +@RG ID:ERR013140 LB:g1k-sc-HG00100-A SM:HG00100 PI:450 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR016352 LB:g1k-sc-HG00100-A SM:HG00100 PI:450 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR156632 LB:3815246 SM:HG00100 PI:352 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR162872 LB:3815246 SM:HG00100 PI:349 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR162875 LB:3815246 SM:HG00100 PI:348 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR242939 LB:6503965 SM:HG00100 PI:459 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR242943 LB:6503965 SM:HG00100 PI:457 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR242947 LB:6503965 SM:HG00100 PI:456 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR242951 LB:6503965 SM:HG00100 PI:457 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR242955 LB:6503965 SM:HG00100 PI:458 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR242959 LB:6503965 SM:HG00100 PI:457 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR242963 LB:6503965 SM:HG00100 PI:457 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR242967 LB:6503965 SM:HG00100 PI:457 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR242971 LB:6503965 SM:HG00100 PI:458 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR242975 LB:6503965 SM:HG00100 PI:457 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR242979 LB:6503965 SM:HG00100 PI:457 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR242983 LB:6503965 SM:HG00100 PI:458 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR242987 LB:6503965 SM:HG00100 PI:457 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR242991 LB:6503965 SM:HG00100 PI:458 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR242995 LB:6503965 SM:HG00100 PI:458 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR242999 LB:6503965 SM:HG00100 PI:456 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR243003 LB:6503965 SM:HG00100 PI:458 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR243007 LB:6503965 SM:HG00100 PI:457 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR243011 LB:6503965 SM:HG00100 PI:456 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR243015 LB:6503965 SM:HG00100 PI:456 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR243019 LB:6503965 SM:HG00100 PI:458 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR243023 LB:6503965 SM:HG00100 PI:457 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR243027 LB:6503965 SM:HG00100 PI:458 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR243031 LB:6503965 SM:HG00100 PI:457 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR243035 LB:6503965 SM:HG00100 PI:457 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR243039 LB:6503965 SM:HG00100 PI:456 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR243043 LB:6503965 SM:HG00100 PI:457 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR243047 LB:6503965 SM:HG00100 PI:456 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR243051 LB:6503965 SM:HG00100 PI:457 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR243055 LB:6503965 SM:HG00100 PI:455 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR243059 LB:6503965 SM:HG00100 PI:457 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR243063 LB:6503965 SM:HG00100 PI:457 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR243067 LB:6503965 SM:HG00100 PI:457 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR243071 LB:6503965 SM:HG00100 PI:455 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR243075 LB:6503965 SM:HG00100 PI:457 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR243079 LB:6503965 SM:HG00100 PI:457 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR243083 LB:6503965 SM:HG00100 PI:458 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR243087 LB:6503965 SM:HG00100 PI:457 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR243091 LB:6503965 SM:HG00100 PI:456 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR245024 LB:6503965 SM:HG00100 PI:457 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR245028 LB:6503965 SM:HG00100 PI:458 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR245032 LB:6503965 SM:HG00100 PI:459 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR245034 LB:6503965 SM:HG00100 PI:458 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR245038 LB:6503965 SM:HG00100 PI:458 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR245041 LB:6503965 SM:HG00100 PI:458 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR245045 LB:6503965 SM:HG00100 PI:458 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR245049 LB:6503965 SM:HG00100 PI:458 CN:SC PL:ILLUMINA DS:SRP001294 +@RG ID:ERR245053 LB:6503965 SM:HG00100 PI:456 CN:SC PL:ILLUMINA DS:SRP001294 +@PG ID:bwa_index PN:bwa VN:0.5.9-r16 CL:bwa index -a bwtsw $reference_fasta +@PG ID:bwa_aln_fastq PN:bwa PP:bwa_index VN:0.5.9-r16 CL:bwa aln -q 15 -f $sai_file $reference_fasta $fastq_file +@PG ID:bwa_sam PN:bwa PP:bwa_aln_fastq VN:0.5.9-r16 CL:bwa sampe -a 1350 -r $rg_line -f $sam_file $reference_fasta $sai_file(s) $fastq_file(s) +@PG ID:bwa_sam.1 PN:bwa PP:bwa_aln_fastq VN:0.5.9-r16 CL:bwa sampe -a 1056 -r $rg_line -f $sam_file $reference_fasta $sai_file(s) $fastq_file(s) +@PG ID:bwa_sam.2 PN:bwa PP:bwa_aln_fastq VN:0.5.9-r16 CL:bwa sampe -a 1047 -r $rg_line -f $sam_file $reference_fasta $sai_file(s) $fastq_file(s) +@PG ID:bwa_sam.3 PN:bwa PP:bwa_aln_fastq VN:0.5.9-r16 CL:bwa sampe -a 1044 -r $rg_line -f $sam_file $reference_fasta $sai_file(s) $fastq_file(s) +@PG ID:bwa_sam.4 PN:bwa PP:bwa_aln_fastq VN:0.5.9-r16 CL:bwa sampe -a 1377 -r $rg_line -f $sam_file $reference_fasta $sai_file(s) $fastq_file(s) +@PG ID:bwa_sam.5 PN:bwa PP:bwa_aln_fastq VN:0.5.9-r16 CL:bwa sampe -a 1371 -r $rg_line -f $sam_file $reference_fasta $sai_file(s) $fastq_file(s) +@PG ID:bwa_sam.6 PN:bwa PP:bwa_aln_fastq VN:0.5.9-r16 CL:bwa sampe -a 1368 -r $rg_line -f $sam_file $reference_fasta $sai_file(s) $fastq_file(s) +@PG ID:bwa_sam.7 PN:bwa PP:bwa_aln_fastq VN:0.5.9-r16 CL:bwa sampe -a 1371 -r $rg_line -f $sam_file $reference_fasta $sai_file(s) $fastq_file(s) +@PG ID:bwa_sam.8 PN:bwa PP:bwa_aln_fastq VN:0.5.9-r16 CL:bwa sampe -a 1374 -r $rg_line -f $sam_file $reference_fasta $sai_file(s) $fastq_file(s) +@PG ID:bwa_sam.9 PN:bwa PP:bwa_aln_fastq VN:0.5.9-r16 CL:bwa sampe -a 1371 -r $rg_line -f $sam_file $reference_fasta $sai_file(s) $fastq_file(s) +@PG ID:bwa_sam.10 PN:bwa PP:bwa_aln_fastq VN:0.5.9-r16 CL:bwa sampe -a 1374 -r $rg_line -f $sam_file $reference_fasta $sai_file(s) $fastq_file(s) +@PG ID:bwa_sam.11 PN:bwa PP:bwa_aln_fastq VN:0.5.9-r16 CL:bwa sampe -a 1371 -r $rg_line -f $sam_file $reference_fasta $sai_file(s) $fastq_file(s) +@PG ID:bwa_sam.12 PN:bwa PP:bwa_aln_fastq VN:0.5.9-r16 CL:bwa sampe -a 1374 -r $rg_line -f $sam_file $reference_fasta $sai_file(s) $fastq_file(s) +@PG ID:bwa_sam.13 PN:bwa PP:bwa_aln_fastq VN:0.5.9-r16 CL:bwa sampe -a 1371 -r $rg_line -f $sam_file $reference_fasta $sai_file(s) $fastq_file(s) +@PG ID:bwa_sam.14 PN:bwa PP:bwa_aln_fastq VN:0.5.9-r16 CL:bwa sampe -a 1374 -r $rg_line -f $sam_file $reference_fasta $sai_file(s) $fastq_file(s) +@PG ID:bwa_sam.15 PN:bwa PP:bwa_aln_fastq VN:0.5.9-r16 CL:bwa sampe -a 1368 -r $rg_line -f $sam_file $reference_fasta $sai_file(s) $fastq_file(s) +@PG ID:bwa_sam.16 PN:bwa PP:bwa_aln_fastq VN:0.5.9-r16 CL:bwa sampe -a 1374 -r $rg_line -f $sam_file $reference_fasta $sai_file(s) $fastq_file(s) +@PG ID:bwa_sam.17 PN:bwa PP:bwa_aln_fastq VN:0.5.9-r16 CL:bwa sampe -a 1371 -r $rg_line -f $sam_file $reference_fasta $sai_file(s) $fastq_file(s) +@PG ID:bwa_sam.18 PN:bwa PP:bwa_aln_fastq VN:0.5.9-r16 CL:bwa sampe -a 1368 -r $rg_line -f $sam_file $reference_fasta $sai_file(s) $fastq_file(s) +@PG ID:bwa_sam.19 PN:bwa PP:bwa_aln_fastq VN:0.5.9-r16 CL:bwa sampe -a 1374 -r $rg_line -f $sam_file $reference_fasta $sai_file(s) $fastq_file(s) +@PG ID:bwa_sam.20 PN:bwa PP:bwa_aln_fastq VN:0.5.9-r16 CL:bwa sampe -a 1371 -r $rg_line -f $sam_file $reference_fasta $sai_file(s) $fastq_file(s) +@PG ID:bwa_sam.21 PN:bwa PP:bwa_aln_fastq VN:0.5.9-r16 CL:bwa sampe -a 1374 -r $rg_line -f $sam_file $reference_fasta $sai_file(s) $fastq_file(s) +@PG ID:bwa_sam.22 PN:bwa PP:bwa_aln_fastq VN:0.5.9-r16 CL:bwa sampe -a 1371 -r $rg_line -f $sam_file $reference_fasta $sai_file(s) $fastq_file(s) +@PG ID:bwa_sam.23 PN:bwa PP:bwa_aln_fastq VN:0.5.9-r16 CL:bwa sampe -a 1368 -r $rg_line -f $sam_file $reference_fasta $sai_file(s) $fastq_file(s) +@PG ID:bwa_sam.24 PN:bwa PP:bwa_aln_fastq VN:0.5.9-r16 CL:bwa sampe -a 1371 -r $rg_line -f $sam_file $reference_fasta $sai_file(s) $fastq_file(s) +@PG ID:bwa_sam.25 PN:bwa PP:bwa_aln_fastq VN:0.5.9-r16 CL:bwa sampe -a 1368 -r $rg_line -f $sam_file $reference_fasta $sai_file(s) $fastq_file(s) +@PG ID:bwa_sam.26 PN:bwa PP:bwa_aln_fastq VN:0.5.9-r16 CL:bwa sampe -a 1371 -r $rg_line -f $sam_file $reference_fasta $sai_file(s) $fastq_file(s) +@PG ID:bwa_sam.27 PN:bwa PP:bwa_aln_fastq VN:0.5.9-r16 CL:bwa sampe -a 1365 -r $rg_line -f $sam_file $reference_fasta $sai_file(s) $fastq_file(s) +@PG ID:bwa_sam.28 PN:bwa PP:bwa_aln_fastq VN:0.5.9-r16 CL:bwa sampe -a 1371 -r $rg_line -f $sam_file $reference_fasta $sai_file(s) $fastq_file(s) +@PG ID:bwa_sam.29 PN:bwa PP:bwa_aln_fastq VN:0.5.9-r16 CL:bwa sampe -a 1365 -r $rg_line -f $sam_file $reference_fasta $sai_file(s) $fastq_file(s) +@PG ID:bwa_sam.30 PN:bwa PP:bwa_aln_fastq VN:0.5.9-r16 CL:bwa sampe -a 1371 -r $rg_line -f $sam_file $reference_fasta $sai_file(s) $fastq_file(s) +@PG ID:bwa_sam.31 PN:bwa PP:bwa_aln_fastq VN:0.5.9-r16 CL:bwa sampe -a 1374 -r $rg_line -f $sam_file $reference_fasta $sai_file(s) $fastq_file(s) +@PG ID:bwa_sam.32 PN:bwa PP:bwa_aln_fastq VN:0.5.9-r16 CL:bwa sampe -a 1371 -r $rg_line -f $sam_file $reference_fasta $sai_file(s) $fastq_file(s) +@PG ID:bwa_sam.33 PN:bwa PP:bwa_aln_fastq VN:0.5.9-r16 CL:bwa sampe -a 1368 -r $rg_line -f $sam_file $reference_fasta $sai_file(s) $fastq_file(s) +@PG ID:bwa_sam.34 PN:bwa PP:bwa_aln_fastq VN:0.5.9-r16 CL:bwa sampe -a 1371 -r $rg_line -f $sam_file $reference_fasta $sai_file(s) $fastq_file(s) +@PG ID:bwa_sam.35 PN:bwa PP:bwa_aln_fastq VN:0.5.9-r16 CL:bwa sampe -a 1374 -r $rg_line -f $sam_file $reference_fasta $sai_file(s) $fastq_file(s) +@PG ID:bwa_sam.36 PN:bwa PP:bwa_aln_fastq VN:0.5.9-r16 CL:bwa sampe -a 1377 -r $rg_line -f $sam_file $reference_fasta $sai_file(s) $fastq_file(s) +@PG ID:bwa_sam.37 PN:bwa PP:bwa_aln_fastq VN:0.5.9-r16 CL:bwa sampe -a 1374 -r $rg_line -f $sam_file $reference_fasta $sai_file(s) $fastq_file(s) +@PG ID:bwa_sam.38 PN:bwa PP:bwa_aln_fastq VN:0.5.9-r16 CL:bwa sampe -a 1368 -r $rg_line -f $sam_file $reference_fasta $sai_file(s) $fastq_file(s) +@PG ID:sam_to_fixed_bam PN:samtools PP:bwa_sam VN:0.1.17 (r973:277) CL:samtools view -bSu $sam_file | samtools sort -n -o - samtools_nsort_tmp | samtools fixmate /dev/stdin /dev/stdout | samtools sort -o - samtools_csort_tmp | samtools fillmd -u - $reference_fasta > $fixed_bam_file +@PG ID:sam_to_fixed_bam.1 PN:samtools PP:bwa_sam.1 VN:0.1.17 (r973:277) CL:samtools view -bSu $sam_file | samtools sort -n -o - samtools_nsort_tmp | samtools fixmate /dev/stdin /dev/stdout | samtools sort -o - samtools_csort_tmp | samtools fillmd -u - $reference_fasta > $fixed_bam_file +@PG ID:sam_to_fixed_bam.2 PN:samtools PP:bwa_sam.2 VN:0.1.17 (r973:277) CL:samtools view -bSu $sam_file | samtools sort -n -o - samtools_nsort_tmp | samtools fixmate /dev/stdin /dev/stdout | samtools sort -o - samtools_csort_tmp | samtools fillmd -u - $reference_fasta > $fixed_bam_file +@PG ID:sam_to_fixed_bam.3 PN:samtools PP:bwa_sam.3 VN:0.1.17 (r973:277) CL:samtools view -bSu $sam_file | samtools sort -n -o - samtools_nsort_tmp | samtools fixmate /dev/stdin /dev/stdout | samtools sort -o - samtools_csort_tmp | samtools fillmd -u - $reference_fasta > $fixed_bam_file +@PG ID:sam_to_fixed_bam.4 PN:samtools PP:bwa_sam.4 VN:0.1.17 (r973:277) CL:samtools view -bSu $sam_file | samtools sort -n -o - samtools_nsort_tmp | samtools fixmate /dev/stdin /dev/stdout | samtools sort -o - samtools_csort_tmp | samtools fillmd -u - $reference_fasta > $fixed_bam_file +@PG ID:sam_to_fixed_bam.5 PN:samtools PP:bwa_sam.5 VN:0.1.17 (r973:277) CL:samtools view -bSu $sam_file | samtools sort -n -o - samtools_nsort_tmp | samtools fixmate /dev/stdin /dev/stdout | samtools sort -o - samtools_csort_tmp | samtools fillmd -u - $reference_fasta > $fixed_bam_file +@PG ID:sam_to_fixed_bam.6 PN:samtools PP:bwa_sam.6 VN:0.1.17 (r973:277) CL:samtools view -bSu $sam_file | samtools sort -n -o - samtools_nsort_tmp | samtools fixmate /dev/stdin /dev/stdout | samtools sort -o - samtools_csort_tmp | samtools fillmd -u - $reference_fasta > $fixed_bam_file +@PG ID:sam_to_fixed_bam.7 PN:samtools PP:bwa_sam.7 VN:0.1.17 (r973:277) CL:samtools view -bSu $sam_file | samtools sort -n -o - samtools_nsort_tmp | samtools fixmate /dev/stdin /dev/stdout | samtools sort -o - samtools_csort_tmp | samtools fillmd -u - $reference_fasta > $fixed_bam_file +@PG ID:sam_to_fixed_bam.8 PN:samtools PP:bwa_sam.8 VN:0.1.17 (r973:277) CL:samtools view -bSu $sam_file | samtools sort -n -o - samtools_nsort_tmp | samtools fixmate /dev/stdin /dev/stdout | samtools sort -o - samtools_csort_tmp | samtools fillmd -u - $reference_fasta > $fixed_bam_file +@PG ID:sam_to_fixed_bam.9 PN:samtools PP:bwa_sam.9 VN:0.1.17 (r973:277) CL:samtools view -bSu $sam_file | samtools sort -n -o - samtools_nsort_tmp | samtools fixmate /dev/stdin /dev/stdout | samtools sort -o - samtools_csort_tmp | samtools fillmd -u - $reference_fasta > $fixed_bam_file +@PG ID:sam_to_fixed_bam.10 PN:samtools PP:bwa_sam.10 VN:0.1.17 (r973:277) CL:samtools view -bSu $sam_file | samtools sort -n -o - samtools_nsort_tmp | samtools fixmate /dev/stdin /dev/stdout | samtools sort -o - samtools_csort_tmp | samtools fillmd -u - $reference_fasta > $fixed_bam_file +@PG ID:sam_to_fixed_bam.11 PN:samtools PP:bwa_sam.11 VN:0.1.17 (r973:277) CL:samtools view -bSu $sam_file | samtools sort -n -o - samtools_nsort_tmp | samtools fixmate /dev/stdin /dev/stdout | samtools sort -o - samtools_csort_tmp | samtools fillmd -u - $reference_fasta > $fixed_bam_file +@PG ID:sam_to_fixed_bam.12 PN:samtools PP:bwa_sam.12 VN:0.1.17 (r973:277) CL:samtools view -bSu $sam_file | samtools sort -n -o - samtools_nsort_tmp | samtools fixmate /dev/stdin /dev/stdout | samtools sort -o - samtools_csort_tmp | samtools fillmd -u - $reference_fasta > $fixed_bam_file +@PG ID:sam_to_fixed_bam.13 PN:samtools PP:bwa_sam.13 VN:0.1.17 (r973:277) CL:samtools view -bSu $sam_file | samtools sort -n -o - samtools_nsort_tmp | samtools fixmate /dev/stdin /dev/stdout | samtools sort -o - samtools_csort_tmp | samtools fillmd -u - $reference_fasta > $fixed_bam_file +@PG ID:sam_to_fixed_bam.14 PN:samtools PP:bwa_sam.14 VN:0.1.17 (r973:277) CL:samtools view -bSu $sam_file | samtools sort -n -o - samtools_nsort_tmp | samtools fixmate /dev/stdin /dev/stdout | samtools sort -o - samtools_csort_tmp | samtools fillmd -u - $reference_fasta > $fixed_bam_file +@PG ID:sam_to_fixed_bam.15 PN:samtools PP:bwa_sam.15 VN:0.1.17 (r973:277) CL:samtools view -bSu $sam_file | samtools sort -n -o - samtools_nsort_tmp | samtools fixmate /dev/stdin /dev/stdout | samtools sort -o - samtools_csort_tmp | samtools fillmd -u - $reference_fasta > $fixed_bam_file +@PG ID:sam_to_fixed_bam.16 PN:samtools PP:bwa_sam.16 VN:0.1.17 (r973:277) CL:samtools view -bSu $sam_file | samtools sort -n -o - samtools_nsort_tmp | samtools fixmate /dev/stdin /dev/stdout | samtools sort -o - samtools_csort_tmp | samtools fillmd -u - $reference_fasta > $fixed_bam_file +@PG ID:sam_to_fixed_bam.17 PN:samtools PP:bwa_sam.17 VN:0.1.17 (r973:277) CL:samtools view -bSu $sam_file | samtools sort -n -o - samtools_nsort_tmp | samtools fixmate /dev/stdin /dev/stdout | samtools sort -o - samtools_csort_tmp | samtools fillmd -u - $reference_fasta > $fixed_bam_file +@PG ID:sam_to_fixed_bam.18 PN:samtools PP:bwa_sam.18 VN:0.1.17 (r973:277) CL:samtools view -bSu $sam_file | samtools sort -n -o - samtools_nsort_tmp | samtools fixmate /dev/stdin /dev/stdout | samtools sort -o - samtools_csort_tmp | samtools fillmd -u - $reference_fasta > $fixed_bam_file +@PG ID:sam_to_fixed_bam.19 PN:samtools PP:bwa_sam.19 VN:0.1.17 (r973:277) CL:samtools view -bSu $sam_file | samtools sort -n -o - samtools_nsort_tmp | samtools fixmate /dev/stdin /dev/stdout | samtools sort -o - samtools_csort_tmp | samtools fillmd -u - $reference_fasta > $fixed_bam_file +@PG ID:sam_to_fixed_bam.20 PN:samtools PP:bwa_sam.20 VN:0.1.17 (r973:277) CL:samtools view -bSu $sam_file | samtools sort -n -o - samtools_nsort_tmp | samtools fixmate /dev/stdin /dev/stdout | samtools sort -o - samtools_csort_tmp | samtools fillmd -u - $reference_fasta > $fixed_bam_file +@PG ID:sam_to_fixed_bam.21 PN:samtools PP:bwa_sam.21 VN:0.1.17 (r973:277) CL:samtools view -bSu $sam_file | samtools sort -n -o - samtools_nsort_tmp | samtools fixmate /dev/stdin /dev/stdout | samtools sort -o - samtools_csort_tmp | samtools fillmd -u - $reference_fasta > $fixed_bam_file +@PG ID:sam_to_fixed_bam.22 PN:samtools PP:bwa_sam.22 VN:0.1.17 (r973:277) CL:samtools view -bSu $sam_file | samtools sort -n -o - samtools_nsort_tmp | samtools fixmate /dev/stdin /dev/stdout | samtools sort -o - samtools_csort_tmp | samtools fillmd -u - $reference_fasta > $fixed_bam_file +@PG ID:sam_to_fixed_bam.23 PN:samtools PP:bwa_sam.23 VN:0.1.17 (r973:277) CL:samtools view -bSu $sam_file | samtools sort -n -o - samtools_nsort_tmp | samtools fixmate /dev/stdin /dev/stdout | samtools sort -o - samtools_csort_tmp | samtools fillmd -u - $reference_fasta > $fixed_bam_file +@PG ID:sam_to_fixed_bam.24 PN:samtools PP:bwa_sam.24 VN:0.1.17 (r973:277) CL:samtools view -bSu $sam_file | samtools sort -n -o - samtools_nsort_tmp | samtools fixmate /dev/stdin /dev/stdout | samtools sort -o - samtools_csort_tmp | samtools fillmd -u - $reference_fasta > $fixed_bam_file +@PG ID:sam_to_fixed_bam.25 PN:samtools PP:bwa_sam.25 VN:0.1.17 (r973:277) CL:samtools view -bSu $sam_file | samtools sort -n -o - samtools_nsort_tmp | samtools fixmate /dev/stdin /dev/stdout | samtools sort -o - samtools_csort_tmp | samtools fillmd -u - $reference_fasta > $fixed_bam_file +@PG ID:sam_to_fixed_bam.26 PN:samtools PP:bwa_sam.26 VN:0.1.17 (r973:277) CL:samtools view -bSu $sam_file | samtools sort -n -o - samtools_nsort_tmp | samtools fixmate /dev/stdin /dev/stdout | samtools sort -o - samtools_csort_tmp | samtools fillmd -u - $reference_fasta > $fixed_bam_file +@PG ID:sam_to_fixed_bam.27 PN:samtools PP:bwa_sam.27 VN:0.1.17 (r973:277) CL:samtools view -bSu $sam_file | samtools sort -n -o - samtools_nsort_tmp | samtools fixmate /dev/stdin /dev/stdout | samtools sort -o - samtools_csort_tmp | samtools fillmd -u - $reference_fasta > $fixed_bam_file +@PG ID:sam_to_fixed_bam.28 PN:samtools PP:bwa_sam.28 VN:0.1.17 (r973:277) CL:samtools view -bSu $sam_file | samtools sort -n -o - samtools_nsort_tmp | samtools fixmate /dev/stdin /dev/stdout | samtools sort -o - samtools_csort_tmp | samtools fillmd -u - $reference_fasta > $fixed_bam_file +@PG ID:sam_to_fixed_bam.29 PN:samtools PP:bwa_sam.29 VN:0.1.17 (r973:277) CL:samtools view -bSu $sam_file | samtools sort -n -o - samtools_nsort_tmp | samtools fixmate /dev/stdin /dev/stdout | samtools sort -o - samtools_csort_tmp | samtools fillmd -u - $reference_fasta > $fixed_bam_file +@PG ID:sam_to_fixed_bam.30 PN:samtools PP:bwa_sam.30 VN:0.1.17 (r973:277) CL:samtools view -bSu $sam_file | samtools sort -n -o - samtools_nsort_tmp | samtools fixmate /dev/stdin /dev/stdout | samtools sort -o - samtools_csort_tmp | samtools fillmd -u - $reference_fasta > $fixed_bam_file +@PG ID:sam_to_fixed_bam.31 PN:samtools PP:bwa_sam.31 VN:0.1.17 (r973:277) CL:samtools view -bSu $sam_file | samtools sort -n -o - samtools_nsort_tmp | samtools fixmate /dev/stdin /dev/stdout | samtools sort -o - samtools_csort_tmp | samtools fillmd -u - $reference_fasta > $fixed_bam_file +@PG ID:sam_to_fixed_bam.32 PN:samtools PP:bwa_sam.32 VN:0.1.17 (r973:277) CL:samtools view -bSu $sam_file | samtools sort -n -o - samtools_nsort_tmp | samtools fixmate /dev/stdin /dev/stdout | samtools sort -o - samtools_csort_tmp | samtools fillmd -u - $reference_fasta > $fixed_bam_file +@PG ID:sam_to_fixed_bam.33 PN:samtools PP:bwa_sam.33 VN:0.1.17 (r973:277) CL:samtools view -bSu $sam_file | samtools sort -n -o - samtools_nsort_tmp | samtools fixmate /dev/stdin /dev/stdout | samtools sort -o - samtools_csort_tmp | samtools fillmd -u - $reference_fasta > $fixed_bam_file +@PG ID:sam_to_fixed_bam.34 PN:samtools PP:bwa_sam.34 VN:0.1.17 (r973:277) CL:samtools view -bSu $sam_file | samtools sort -n -o - samtools_nsort_tmp | samtools fixmate /dev/stdin /dev/stdout | samtools sort -o - samtools_csort_tmp | samtools fillmd -u - $reference_fasta > $fixed_bam_file +@PG ID:sam_to_fixed_bam.35 PN:samtools PP:bwa_sam.35 VN:0.1.17 (r973:277) CL:samtools view -bSu $sam_file | samtools sort -n -o - samtools_nsort_tmp | samtools fixmate /dev/stdin /dev/stdout | samtools sort -o - samtools_csort_tmp | samtools fillmd -u - $reference_fasta > $fixed_bam_file +@PG ID:sam_to_fixed_bam.36 PN:samtools PP:bwa_sam.36 VN:0.1.17 (r973:277) CL:samtools view -bSu $sam_file | samtools sort -n -o - samtools_nsort_tmp | samtools fixmate /dev/stdin /dev/stdout | samtools sort -o - samtools_csort_tmp | samtools fillmd -u - $reference_fasta > $fixed_bam_file +@PG ID:sam_to_fixed_bam.37 PN:samtools PP:bwa_sam.37 VN:0.1.17 (r973:277) CL:samtools view -bSu $sam_file | samtools sort -n -o - samtools_nsort_tmp | samtools fixmate /dev/stdin /dev/stdout | samtools sort -o - samtools_csort_tmp | samtools fillmd -u - $reference_fasta > $fixed_bam_file +@PG ID:sam_to_fixed_bam.38 PN:samtools PP:bwa_sam.38 VN:0.1.17 (r973:277) CL:samtools view -bSu $sam_file | samtools sort -n -o - samtools_nsort_tmp | samtools fixmate /dev/stdin /dev/stdout | samtools sort -o - samtools_csort_tmp | samtools fillmd -u - $reference_fasta > $fixed_bam_file +@PG ID:gatk_target_interval_creator PN:GenomeAnalysisTK PP:sam_to_fixed_bam VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T RealignerTargetCreator -R $reference_fasta -o $intervals_file -known $known_indels_file(s) +@PG ID:gatk_target_interval_creator.1 PN:GenomeAnalysisTK PP:sam_to_fixed_bam.1 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T RealignerTargetCreator -R $reference_fasta -o $intervals_file -known $known_indels_file(s) +@PG ID:gatk_target_interval_creator.2 PN:GenomeAnalysisTK PP:sam_to_fixed_bam.2 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T RealignerTargetCreator -R $reference_fasta -o $intervals_file -known $known_indels_file(s) +@PG ID:gatk_target_interval_creator.3 PN:GenomeAnalysisTK PP:sam_to_fixed_bam.3 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T RealignerTargetCreator -R $reference_fasta -o $intervals_file -known $known_indels_file(s) +@PG ID:gatk_target_interval_creator.4 PN:GenomeAnalysisTK PP:sam_to_fixed_bam.4 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T RealignerTargetCreator -R $reference_fasta -o $intervals_file -known $known_indels_file(s) +@PG ID:gatk_target_interval_creator.5 PN:GenomeAnalysisTK PP:sam_to_fixed_bam.5 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T RealignerTargetCreator -R $reference_fasta -o $intervals_file -known $known_indels_file(s) +@PG ID:gatk_target_interval_creator.6 PN:GenomeAnalysisTK PP:sam_to_fixed_bam.6 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T RealignerTargetCreator -R $reference_fasta -o $intervals_file -known $known_indels_file(s) +@PG ID:gatk_target_interval_creator.7 PN:GenomeAnalysisTK PP:sam_to_fixed_bam.7 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T RealignerTargetCreator -R $reference_fasta -o $intervals_file -known $known_indels_file(s) +@PG ID:gatk_target_interval_creator.8 PN:GenomeAnalysisTK PP:sam_to_fixed_bam.8 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T RealignerTargetCreator -R $reference_fasta -o $intervals_file -known $known_indels_file(s) +@PG ID:gatk_target_interval_creator.9 PN:GenomeAnalysisTK PP:sam_to_fixed_bam.9 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T RealignerTargetCreator -R $reference_fasta -o $intervals_file -known $known_indels_file(s) +@PG ID:gatk_target_interval_creator.10 PN:GenomeAnalysisTK PP:sam_to_fixed_bam.10 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T RealignerTargetCreator -R $reference_fasta -o $intervals_file -known $known_indels_file(s) +@PG ID:gatk_target_interval_creator.11 PN:GenomeAnalysisTK PP:sam_to_fixed_bam.11 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T RealignerTargetCreator -R $reference_fasta -o $intervals_file -known $known_indels_file(s) +@PG ID:gatk_target_interval_creator.12 PN:GenomeAnalysisTK PP:sam_to_fixed_bam.12 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T RealignerTargetCreator -R $reference_fasta -o $intervals_file -known $known_indels_file(s) +@PG ID:gatk_target_interval_creator.13 PN:GenomeAnalysisTK PP:sam_to_fixed_bam.13 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T RealignerTargetCreator -R $reference_fasta -o $intervals_file -known $known_indels_file(s) +@PG ID:gatk_target_interval_creator.14 PN:GenomeAnalysisTK PP:sam_to_fixed_bam.14 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T RealignerTargetCreator -R $reference_fasta -o $intervals_file -known $known_indels_file(s) +@PG ID:gatk_target_interval_creator.15 PN:GenomeAnalysisTK PP:sam_to_fixed_bam.15 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T RealignerTargetCreator -R $reference_fasta -o $intervals_file -known $known_indels_file(s) +@PG ID:gatk_target_interval_creator.16 PN:GenomeAnalysisTK PP:sam_to_fixed_bam.16 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T RealignerTargetCreator -R $reference_fasta -o $intervals_file -known $known_indels_file(s) +@PG ID:gatk_target_interval_creator.17 PN:GenomeAnalysisTK PP:sam_to_fixed_bam.17 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T RealignerTargetCreator -R $reference_fasta -o $intervals_file -known $known_indels_file(s) +@PG ID:gatk_target_interval_creator.18 PN:GenomeAnalysisTK PP:sam_to_fixed_bam.18 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T RealignerTargetCreator -R $reference_fasta -o $intervals_file -known $known_indels_file(s) +@PG ID:gatk_target_interval_creator.19 PN:GenomeAnalysisTK PP:sam_to_fixed_bam.19 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T RealignerTargetCreator -R $reference_fasta -o $intervals_file -known $known_indels_file(s) +@PG ID:gatk_target_interval_creator.20 PN:GenomeAnalysisTK PP:sam_to_fixed_bam.20 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T RealignerTargetCreator -R $reference_fasta -o $intervals_file -known $known_indels_file(s) +@PG ID:gatk_target_interval_creator.21 PN:GenomeAnalysisTK PP:sam_to_fixed_bam.21 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T RealignerTargetCreator -R $reference_fasta -o $intervals_file -known $known_indels_file(s) +@PG ID:gatk_target_interval_creator.22 PN:GenomeAnalysisTK PP:sam_to_fixed_bam.22 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T RealignerTargetCreator -R $reference_fasta -o $intervals_file -known $known_indels_file(s) +@PG ID:gatk_target_interval_creator.23 PN:GenomeAnalysisTK PP:sam_to_fixed_bam.23 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T RealignerTargetCreator -R $reference_fasta -o $intervals_file -known $known_indels_file(s) +@PG ID:gatk_target_interval_creator.24 PN:GenomeAnalysisTK PP:sam_to_fixed_bam.24 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T RealignerTargetCreator -R $reference_fasta -o $intervals_file -known $known_indels_file(s) +@PG ID:gatk_target_interval_creator.25 PN:GenomeAnalysisTK PP:sam_to_fixed_bam.25 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T RealignerTargetCreator -R $reference_fasta -o $intervals_file -known $known_indels_file(s) +@PG ID:gatk_target_interval_creator.26 PN:GenomeAnalysisTK PP:sam_to_fixed_bam.26 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T RealignerTargetCreator -R $reference_fasta -o $intervals_file -known $known_indels_file(s) +@PG ID:gatk_target_interval_creator.27 PN:GenomeAnalysisTK PP:sam_to_fixed_bam.27 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T RealignerTargetCreator -R $reference_fasta -o $intervals_file -known $known_indels_file(s) +@PG ID:gatk_target_interval_creator.28 PN:GenomeAnalysisTK PP:sam_to_fixed_bam.28 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T RealignerTargetCreator -R $reference_fasta -o $intervals_file -known $known_indels_file(s) +@PG ID:gatk_target_interval_creator.29 PN:GenomeAnalysisTK PP:sam_to_fixed_bam.29 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T RealignerTargetCreator -R $reference_fasta -o $intervals_file -known $known_indels_file(s) +@PG ID:gatk_target_interval_creator.30 PN:GenomeAnalysisTK PP:sam_to_fixed_bam.30 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T RealignerTargetCreator -R $reference_fasta -o $intervals_file -known $known_indels_file(s) +@PG ID:gatk_target_interval_creator.31 PN:GenomeAnalysisTK PP:sam_to_fixed_bam.31 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T RealignerTargetCreator -R $reference_fasta -o $intervals_file -known $known_indels_file(s) +@PG ID:gatk_target_interval_creator.32 PN:GenomeAnalysisTK PP:sam_to_fixed_bam.32 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T RealignerTargetCreator -R $reference_fasta -o $intervals_file -known $known_indels_file(s) +@PG ID:gatk_target_interval_creator.33 PN:GenomeAnalysisTK PP:sam_to_fixed_bam.33 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T RealignerTargetCreator -R $reference_fasta -o $intervals_file -known $known_indels_file(s) +@PG ID:gatk_target_interval_creator.34 PN:GenomeAnalysisTK PP:sam_to_fixed_bam.34 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T RealignerTargetCreator -R $reference_fasta -o $intervals_file -known $known_indels_file(s) +@PG ID:gatk_target_interval_creator.35 PN:GenomeAnalysisTK PP:sam_to_fixed_bam.35 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T RealignerTargetCreator -R $reference_fasta -o $intervals_file -known $known_indels_file(s) +@PG ID:gatk_target_interval_creator.36 PN:GenomeAnalysisTK PP:sam_to_fixed_bam.36 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T RealignerTargetCreator -R $reference_fasta -o $intervals_file -known $known_indels_file(s) +@PG ID:gatk_target_interval_creator.37 PN:GenomeAnalysisTK PP:sam_to_fixed_bam.37 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T RealignerTargetCreator -R $reference_fasta -o $intervals_file -known $known_indels_file(s) +@PG ID:gatk_target_interval_creator.38 PN:GenomeAnalysisTK PP:sam_to_fixed_bam.38 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T RealignerTargetCreator -R $reference_fasta -o $intervals_file -known $known_indels_file(s) +@PG ID:bam_realignment_around_known_indels PN:GenomeAnalysisTK PP:gatk_target_interval_creator VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T IndelRealigner -R $reference_fasta -I $bam_file -o $realigned_bam_file -targetIntervals $intervals_file -known $known_indels_file(s) -LOD 0.4 -model KNOWNS_ONLY -compress 0 --disable_bam_indexing +@PG ID:bam_realignment_around_known_indels.1 PN:GenomeAnalysisTK PP:gatk_target_interval_creator.1 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T IndelRealigner -R $reference_fasta -I $bam_file -o $realigned_bam_file -targetIntervals $intervals_file -known $known_indels_file(s) -LOD 0.4 -model KNOWNS_ONLY -compress 0 --disable_bam_indexing +@PG ID:bam_realignment_around_known_indels.2 PN:GenomeAnalysisTK PP:gatk_target_interval_creator.2 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T IndelRealigner -R $reference_fasta -I $bam_file -o $realigned_bam_file -targetIntervals $intervals_file -known $known_indels_file(s) -LOD 0.4 -model KNOWNS_ONLY -compress 0 --disable_bam_indexing +@PG ID:bam_realignment_around_known_indels.3 PN:GenomeAnalysisTK PP:gatk_target_interval_creator.3 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T IndelRealigner -R $reference_fasta -I $bam_file -o $realigned_bam_file -targetIntervals $intervals_file -known $known_indels_file(s) -LOD 0.4 -model KNOWNS_ONLY -compress 0 --disable_bam_indexing +@PG ID:bam_realignment_around_known_indels.4 PN:GenomeAnalysisTK PP:gatk_target_interval_creator.4 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T IndelRealigner -R $reference_fasta -I $bam_file -o $realigned_bam_file -targetIntervals $intervals_file -known $known_indels_file(s) -LOD 0.4 -model KNOWNS_ONLY -compress 0 --disable_bam_indexing +@PG ID:bam_realignment_around_known_indels.5 PN:GenomeAnalysisTK PP:gatk_target_interval_creator.5 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T IndelRealigner -R $reference_fasta -I $bam_file -o $realigned_bam_file -targetIntervals $intervals_file -known $known_indels_file(s) -LOD 0.4 -model KNOWNS_ONLY -compress 0 --disable_bam_indexing +@PG ID:bam_realignment_around_known_indels.6 PN:GenomeAnalysisTK PP:gatk_target_interval_creator.6 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T IndelRealigner -R $reference_fasta -I $bam_file -o $realigned_bam_file -targetIntervals $intervals_file -known $known_indels_file(s) -LOD 0.4 -model KNOWNS_ONLY -compress 0 --disable_bam_indexing +@PG ID:bam_realignment_around_known_indels.7 PN:GenomeAnalysisTK PP:gatk_target_interval_creator.7 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T IndelRealigner -R $reference_fasta -I $bam_file -o $realigned_bam_file -targetIntervals $intervals_file -known $known_indels_file(s) -LOD 0.4 -model KNOWNS_ONLY -compress 0 --disable_bam_indexing +@PG ID:bam_realignment_around_known_indels.8 PN:GenomeAnalysisTK PP:gatk_target_interval_creator.8 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T IndelRealigner -R $reference_fasta -I $bam_file -o $realigned_bam_file -targetIntervals $intervals_file -known $known_indels_file(s) -LOD 0.4 -model KNOWNS_ONLY -compress 0 --disable_bam_indexing +@PG ID:bam_realignment_around_known_indels.9 PN:GenomeAnalysisTK PP:gatk_target_interval_creator.9 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T IndelRealigner -R $reference_fasta -I $bam_file -o $realigned_bam_file -targetIntervals $intervals_file -known $known_indels_file(s) -LOD 0.4 -model KNOWNS_ONLY -compress 0 --disable_bam_indexing +@PG ID:bam_realignment_around_known_indels.10 PN:GenomeAnalysisTK PP:gatk_target_interval_creator.10 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T IndelRealigner -R $reference_fasta -I $bam_file -o $realigned_bam_file -targetIntervals $intervals_file -known $known_indels_file(s) -LOD 0.4 -model KNOWNS_ONLY -compress 0 --disable_bam_indexing +@PG ID:bam_realignment_around_known_indels.11 PN:GenomeAnalysisTK PP:gatk_target_interval_creator.11 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T IndelRealigner -R $reference_fasta -I $bam_file -o $realigned_bam_file -targetIntervals $intervals_file -known $known_indels_file(s) -LOD 0.4 -model KNOWNS_ONLY -compress 0 --disable_bam_indexing +@PG ID:bam_realignment_around_known_indels.12 PN:GenomeAnalysisTK PP:gatk_target_interval_creator.12 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T IndelRealigner -R $reference_fasta -I $bam_file -o $realigned_bam_file -targetIntervals $intervals_file -known $known_indels_file(s) -LOD 0.4 -model KNOWNS_ONLY -compress 0 --disable_bam_indexing +@PG ID:bam_realignment_around_known_indels.13 PN:GenomeAnalysisTK PP:gatk_target_interval_creator.13 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T IndelRealigner -R $reference_fasta -I $bam_file -o $realigned_bam_file -targetIntervals $intervals_file -known $known_indels_file(s) -LOD 0.4 -model KNOWNS_ONLY -compress 0 --disable_bam_indexing +@PG ID:bam_realignment_around_known_indels.14 PN:GenomeAnalysisTK PP:gatk_target_interval_creator.14 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T IndelRealigner -R $reference_fasta -I $bam_file -o $realigned_bam_file -targetIntervals $intervals_file -known $known_indels_file(s) -LOD 0.4 -model KNOWNS_ONLY -compress 0 --disable_bam_indexing +@PG ID:bam_realignment_around_known_indels.15 PN:GenomeAnalysisTK PP:gatk_target_interval_creator.15 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T IndelRealigner -R $reference_fasta -I $bam_file -o $realigned_bam_file -targetIntervals $intervals_file -known $known_indels_file(s) -LOD 0.4 -model KNOWNS_ONLY -compress 0 --disable_bam_indexing +@PG ID:bam_realignment_around_known_indels.16 PN:GenomeAnalysisTK PP:gatk_target_interval_creator.16 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T IndelRealigner -R $reference_fasta -I $bam_file -o $realigned_bam_file -targetIntervals $intervals_file -known $known_indels_file(s) -LOD 0.4 -model KNOWNS_ONLY -compress 0 --disable_bam_indexing +@PG ID:bam_realignment_around_known_indels.17 PN:GenomeAnalysisTK PP:gatk_target_interval_creator.17 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T IndelRealigner -R $reference_fasta -I $bam_file -o $realigned_bam_file -targetIntervals $intervals_file -known $known_indels_file(s) -LOD 0.4 -model KNOWNS_ONLY -compress 0 --disable_bam_indexing +@PG ID:bam_realignment_around_known_indels.18 PN:GenomeAnalysisTK PP:gatk_target_interval_creator.18 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T IndelRealigner -R $reference_fasta -I $bam_file -o $realigned_bam_file -targetIntervals $intervals_file -known $known_indels_file(s) -LOD 0.4 -model KNOWNS_ONLY -compress 0 --disable_bam_indexing +@PG ID:bam_realignment_around_known_indels.19 PN:GenomeAnalysisTK PP:gatk_target_interval_creator.19 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T IndelRealigner -R $reference_fasta -I $bam_file -o $realigned_bam_file -targetIntervals $intervals_file -known $known_indels_file(s) -LOD 0.4 -model KNOWNS_ONLY -compress 0 --disable_bam_indexing +@PG ID:bam_realignment_around_known_indels.20 PN:GenomeAnalysisTK PP:gatk_target_interval_creator.20 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T IndelRealigner -R $reference_fasta -I $bam_file -o $realigned_bam_file -targetIntervals $intervals_file -known $known_indels_file(s) -LOD 0.4 -model KNOWNS_ONLY -compress 0 --disable_bam_indexing +@PG ID:bam_realignment_around_known_indels.21 PN:GenomeAnalysisTK PP:gatk_target_interval_creator.21 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T IndelRealigner -R $reference_fasta -I $bam_file -o $realigned_bam_file -targetIntervals $intervals_file -known $known_indels_file(s) -LOD 0.4 -model KNOWNS_ONLY -compress 0 --disable_bam_indexing +@PG ID:bam_realignment_around_known_indels.22 PN:GenomeAnalysisTK PP:gatk_target_interval_creator.22 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T IndelRealigner -R $reference_fasta -I $bam_file -o $realigned_bam_file -targetIntervals $intervals_file -known $known_indels_file(s) -LOD 0.4 -model KNOWNS_ONLY -compress 0 --disable_bam_indexing +@PG ID:bam_realignment_around_known_indels.23 PN:GenomeAnalysisTK PP:gatk_target_interval_creator.23 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T IndelRealigner -R $reference_fasta -I $bam_file -o $realigned_bam_file -targetIntervals $intervals_file -known $known_indels_file(s) -LOD 0.4 -model KNOWNS_ONLY -compress 0 --disable_bam_indexing +@PG ID:bam_realignment_around_known_indels.24 PN:GenomeAnalysisTK PP:gatk_target_interval_creator.24 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T IndelRealigner -R $reference_fasta -I $bam_file -o $realigned_bam_file -targetIntervals $intervals_file -known $known_indels_file(s) -LOD 0.4 -model KNOWNS_ONLY -compress 0 --disable_bam_indexing +@PG ID:bam_realignment_around_known_indels.25 PN:GenomeAnalysisTK PP:gatk_target_interval_creator.25 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T IndelRealigner -R $reference_fasta -I $bam_file -o $realigned_bam_file -targetIntervals $intervals_file -known $known_indels_file(s) -LOD 0.4 -model KNOWNS_ONLY -compress 0 --disable_bam_indexing +@PG ID:bam_realignment_around_known_indels.26 PN:GenomeAnalysisTK PP:gatk_target_interval_creator.26 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T IndelRealigner -R $reference_fasta -I $bam_file -o $realigned_bam_file -targetIntervals $intervals_file -known $known_indels_file(s) -LOD 0.4 -model KNOWNS_ONLY -compress 0 --disable_bam_indexing +@PG ID:bam_realignment_around_known_indels.27 PN:GenomeAnalysisTK PP:gatk_target_interval_creator.27 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T IndelRealigner -R $reference_fasta -I $bam_file -o $realigned_bam_file -targetIntervals $intervals_file -known $known_indels_file(s) -LOD 0.4 -model KNOWNS_ONLY -compress 0 --disable_bam_indexing +@PG ID:bam_realignment_around_known_indels.28 PN:GenomeAnalysisTK PP:gatk_target_interval_creator.28 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T IndelRealigner -R $reference_fasta -I $bam_file -o $realigned_bam_file -targetIntervals $intervals_file -known $known_indels_file(s) -LOD 0.4 -model KNOWNS_ONLY -compress 0 --disable_bam_indexing +@PG ID:bam_realignment_around_known_indels.29 PN:GenomeAnalysisTK PP:gatk_target_interval_creator.29 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T IndelRealigner -R $reference_fasta -I $bam_file -o $realigned_bam_file -targetIntervals $intervals_file -known $known_indels_file(s) -LOD 0.4 -model KNOWNS_ONLY -compress 0 --disable_bam_indexing +@PG ID:bam_realignment_around_known_indels.30 PN:GenomeAnalysisTK PP:gatk_target_interval_creator.30 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T IndelRealigner -R $reference_fasta -I $bam_file -o $realigned_bam_file -targetIntervals $intervals_file -known $known_indels_file(s) -LOD 0.4 -model KNOWNS_ONLY -compress 0 --disable_bam_indexing +@PG ID:bam_realignment_around_known_indels.31 PN:GenomeAnalysisTK PP:gatk_target_interval_creator.31 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T IndelRealigner -R $reference_fasta -I $bam_file -o $realigned_bam_file -targetIntervals $intervals_file -known $known_indels_file(s) -LOD 0.4 -model KNOWNS_ONLY -compress 0 --disable_bam_indexing +@PG ID:bam_realignment_around_known_indels.32 PN:GenomeAnalysisTK PP:gatk_target_interval_creator.32 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T IndelRealigner -R $reference_fasta -I $bam_file -o $realigned_bam_file -targetIntervals $intervals_file -known $known_indels_file(s) -LOD 0.4 -model KNOWNS_ONLY -compress 0 --disable_bam_indexing +@PG ID:bam_realignment_around_known_indels.33 PN:GenomeAnalysisTK PP:gatk_target_interval_creator.33 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T IndelRealigner -R $reference_fasta -I $bam_file -o $realigned_bam_file -targetIntervals $intervals_file -known $known_indels_file(s) -LOD 0.4 -model KNOWNS_ONLY -compress 0 --disable_bam_indexing +@PG ID:bam_realignment_around_known_indels.34 PN:GenomeAnalysisTK PP:gatk_target_interval_creator.34 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T IndelRealigner -R $reference_fasta -I $bam_file -o $realigned_bam_file -targetIntervals $intervals_file -known $known_indels_file(s) -LOD 0.4 -model KNOWNS_ONLY -compress 0 --disable_bam_indexing +@PG ID:bam_realignment_around_known_indels.35 PN:GenomeAnalysisTK PP:gatk_target_interval_creator.35 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T IndelRealigner -R $reference_fasta -I $bam_file -o $realigned_bam_file -targetIntervals $intervals_file -known $known_indels_file(s) -LOD 0.4 -model KNOWNS_ONLY -compress 0 --disable_bam_indexing +@PG ID:bam_realignment_around_known_indels.36 PN:GenomeAnalysisTK PP:gatk_target_interval_creator.36 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T IndelRealigner -R $reference_fasta -I $bam_file -o $realigned_bam_file -targetIntervals $intervals_file -known $known_indels_file(s) -LOD 0.4 -model KNOWNS_ONLY -compress 0 --disable_bam_indexing +@PG ID:bam_realignment_around_known_indels.37 PN:GenomeAnalysisTK PP:gatk_target_interval_creator.37 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T IndelRealigner -R $reference_fasta -I $bam_file -o $realigned_bam_file -targetIntervals $intervals_file -known $known_indels_file(s) -LOD 0.4 -model KNOWNS_ONLY -compress 0 --disable_bam_indexing +@PG ID:bam_realignment_around_known_indels.38 PN:GenomeAnalysisTK PP:gatk_target_interval_creator.38 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T IndelRealigner -R $reference_fasta -I $bam_file -o $realigned_bam_file -targetIntervals $intervals_file -known $known_indels_file(s) -LOD 0.4 -model KNOWNS_ONLY -compress 0 --disable_bam_indexing +@PG ID:bam_count_covariates PN:GenomeAnalysisTK PP:bam_realignment_around_known_indels VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T CountCovariates -R $reference_fasta -I $bam_file -recalFile $bam_file.recal_data.csv -knownSites $known_sites_file(s) -l INFO -L '1;2;3;4;5;6;7;8;9;10;11;12;13;14;15;16;17;18;19;20;21;22;X;Y;MT' -cov ReadGroupCovariate -cov QualityScoreCovariate -cov CycleCovariate -cov DinucCovariate +@PG ID:bam_count_covariates.1 PN:GenomeAnalysisTK PP:bam_realignment_around_known_indels.1 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T CountCovariates -R $reference_fasta -I $bam_file -recalFile $bam_file.recal_data.csv -knownSites $known_sites_file(s) -l INFO -L '1;2;3;4;5;6;7;8;9;10;11;12;13;14;15;16;17;18;19;20;21;22;X;Y;MT' -cov ReadGroupCovariate -cov QualityScoreCovariate -cov CycleCovariate -cov DinucCovariate +@PG ID:bam_count_covariates.2 PN:GenomeAnalysisTK PP:bam_realignment_around_known_indels.2 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T CountCovariates -R $reference_fasta -I $bam_file -recalFile $bam_file.recal_data.csv -knownSites $known_sites_file(s) -l INFO -L '1;2;3;4;5;6;7;8;9;10;11;12;13;14;15;16;17;18;19;20;21;22;X;Y;MT' -cov ReadGroupCovariate -cov QualityScoreCovariate -cov CycleCovariate -cov DinucCovariate +@PG ID:bam_count_covariates.3 PN:GenomeAnalysisTK PP:bam_realignment_around_known_indels.3 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T CountCovariates -R $reference_fasta -I $bam_file -recalFile $bam_file.recal_data.csv -knownSites $known_sites_file(s) -l INFO -L '1;2;3;4;5;6;7;8;9;10;11;12;13;14;15;16;17;18;19;20;21;22;X;Y;MT' -cov ReadGroupCovariate -cov QualityScoreCovariate -cov CycleCovariate -cov DinucCovariate +@PG ID:bam_count_covariates.4 PN:GenomeAnalysisTK PP:bam_realignment_around_known_indels.4 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T CountCovariates -R $reference_fasta -I $bam_file -recalFile $bam_file.recal_data.csv -knownSites $known_sites_file(s) -l INFO -L '1;2;3;4;5;6;7;8;9;10;11;12;13;14;15;16;17;18;19;20;21;22;X;Y;MT' -cov ReadGroupCovariate -cov QualityScoreCovariate -cov CycleCovariate -cov DinucCovariate +@PG ID:bam_count_covariates.5 PN:GenomeAnalysisTK PP:bam_realignment_around_known_indels.5 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T CountCovariates -R $reference_fasta -I $bam_file -recalFile $bam_file.recal_data.csv -knownSites $known_sites_file(s) -l INFO -L '1;2;3;4;5;6;7;8;9;10;11;12;13;14;15;16;17;18;19;20;21;22;X;Y;MT' -cov ReadGroupCovariate -cov QualityScoreCovariate -cov CycleCovariate -cov DinucCovariate +@PG ID:bam_count_covariates.6 PN:GenomeAnalysisTK PP:bam_realignment_around_known_indels.6 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T CountCovariates -R $reference_fasta -I $bam_file -recalFile $bam_file.recal_data.csv -knownSites $known_sites_file(s) -l INFO -L '1;2;3;4;5;6;7;8;9;10;11;12;13;14;15;16;17;18;19;20;21;22;X;Y;MT' -cov ReadGroupCovariate -cov QualityScoreCovariate -cov CycleCovariate -cov DinucCovariate +@PG ID:bam_count_covariates.7 PN:GenomeAnalysisTK PP:bam_realignment_around_known_indels.7 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T CountCovariates -R $reference_fasta -I $bam_file -recalFile $bam_file.recal_data.csv -knownSites $known_sites_file(s) -l INFO -L '1;2;3;4;5;6;7;8;9;10;11;12;13;14;15;16;17;18;19;20;21;22;X;Y;MT' -cov ReadGroupCovariate -cov QualityScoreCovariate -cov CycleCovariate -cov DinucCovariate +@PG ID:bam_count_covariates.8 PN:GenomeAnalysisTK PP:bam_realignment_around_known_indels.8 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T CountCovariates -R $reference_fasta -I $bam_file -recalFile $bam_file.recal_data.csv -knownSites $known_sites_file(s) -l INFO -L '1;2;3;4;5;6;7;8;9;10;11;12;13;14;15;16;17;18;19;20;21;22;X;Y;MT' -cov ReadGroupCovariate -cov QualityScoreCovariate -cov CycleCovariate -cov DinucCovariate +@PG ID:bam_count_covariates.9 PN:GenomeAnalysisTK PP:bam_realignment_around_known_indels.9 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T CountCovariates -R $reference_fasta -I $bam_file -recalFile $bam_file.recal_data.csv -knownSites $known_sites_file(s) -l INFO -L '1;2;3;4;5;6;7;8;9;10;11;12;13;14;15;16;17;18;19;20;21;22;X;Y;MT' -cov ReadGroupCovariate -cov QualityScoreCovariate -cov CycleCovariate -cov DinucCovariate +@PG ID:bam_count_covariates.10 PN:GenomeAnalysisTK PP:bam_realignment_around_known_indels.10 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T CountCovariates -R $reference_fasta -I $bam_file -recalFile $bam_file.recal_data.csv -knownSites $known_sites_file(s) -l INFO -L '1;2;3;4;5;6;7;8;9;10;11;12;13;14;15;16;17;18;19;20;21;22;X;Y;MT' -cov ReadGroupCovariate -cov QualityScoreCovariate -cov CycleCovariate -cov DinucCovariate +@PG ID:bam_count_covariates.11 PN:GenomeAnalysisTK PP:bam_realignment_around_known_indels.11 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T CountCovariates -R $reference_fasta -I $bam_file -recalFile $bam_file.recal_data.csv -knownSites $known_sites_file(s) -l INFO -L '1;2;3;4;5;6;7;8;9;10;11;12;13;14;15;16;17;18;19;20;21;22;X;Y;MT' -cov ReadGroupCovariate -cov QualityScoreCovariate -cov CycleCovariate -cov DinucCovariate +@PG ID:bam_count_covariates.12 PN:GenomeAnalysisTK PP:bam_realignment_around_known_indels.12 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T CountCovariates -R $reference_fasta -I $bam_file -recalFile $bam_file.recal_data.csv -knownSites $known_sites_file(s) -l INFO -L '1;2;3;4;5;6;7;8;9;10;11;12;13;14;15;16;17;18;19;20;21;22;X;Y;MT' -cov ReadGroupCovariate -cov QualityScoreCovariate -cov CycleCovariate -cov DinucCovariate +@PG ID:bam_count_covariates.13 PN:GenomeAnalysisTK PP:bam_realignment_around_known_indels.13 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T CountCovariates -R $reference_fasta -I $bam_file -recalFile $bam_file.recal_data.csv -knownSites $known_sites_file(s) -l INFO -L '1;2;3;4;5;6;7;8;9;10;11;12;13;14;15;16;17;18;19;20;21;22;X;Y;MT' -cov ReadGroupCovariate -cov QualityScoreCovariate -cov CycleCovariate -cov DinucCovariate +@PG ID:bam_count_covariates.14 PN:GenomeAnalysisTK PP:bam_realignment_around_known_indels.14 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T CountCovariates -R $reference_fasta -I $bam_file -recalFile $bam_file.recal_data.csv -knownSites $known_sites_file(s) -l INFO -L '1;2;3;4;5;6;7;8;9;10;11;12;13;14;15;16;17;18;19;20;21;22;X;Y;MT' -cov ReadGroupCovariate -cov QualityScoreCovariate -cov CycleCovariate -cov DinucCovariate +@PG ID:bam_count_covariates.15 PN:GenomeAnalysisTK PP:bam_realignment_around_known_indels.15 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T CountCovariates -R $reference_fasta -I $bam_file -recalFile $bam_file.recal_data.csv -knownSites $known_sites_file(s) -l INFO -L '1;2;3;4;5;6;7;8;9;10;11;12;13;14;15;16;17;18;19;20;21;22;X;Y;MT' -cov ReadGroupCovariate -cov QualityScoreCovariate -cov CycleCovariate -cov DinucCovariate +@PG ID:bam_count_covariates.16 PN:GenomeAnalysisTK PP:bam_realignment_around_known_indels.16 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T CountCovariates -R $reference_fasta -I $bam_file -recalFile $bam_file.recal_data.csv -knownSites $known_sites_file(s) -l INFO -L '1;2;3;4;5;6;7;8;9;10;11;12;13;14;15;16;17;18;19;20;21;22;X;Y;MT' -cov ReadGroupCovariate -cov QualityScoreCovariate -cov CycleCovariate -cov DinucCovariate +@PG ID:bam_count_covariates.17 PN:GenomeAnalysisTK PP:bam_realignment_around_known_indels.17 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T CountCovariates -R $reference_fasta -I $bam_file -recalFile $bam_file.recal_data.csv -knownSites $known_sites_file(s) -l INFO -L '1;2;3;4;5;6;7;8;9;10;11;12;13;14;15;16;17;18;19;20;21;22;X;Y;MT' -cov ReadGroupCovariate -cov QualityScoreCovariate -cov CycleCovariate -cov DinucCovariate +@PG ID:bam_count_covariates.18 PN:GenomeAnalysisTK PP:bam_realignment_around_known_indels.18 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T CountCovariates -R $reference_fasta -I $bam_file -recalFile $bam_file.recal_data.csv -knownSites $known_sites_file(s) -l INFO -L '1;2;3;4;5;6;7;8;9;10;11;12;13;14;15;16;17;18;19;20;21;22;X;Y;MT' -cov ReadGroupCovariate -cov QualityScoreCovariate -cov CycleCovariate -cov DinucCovariate +@PG ID:bam_count_covariates.19 PN:GenomeAnalysisTK PP:bam_realignment_around_known_indels.19 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T CountCovariates -R $reference_fasta -I $bam_file -recalFile $bam_file.recal_data.csv -knownSites $known_sites_file(s) -l INFO -L '1;2;3;4;5;6;7;8;9;10;11;12;13;14;15;16;17;18;19;20;21;22;X;Y;MT' -cov ReadGroupCovariate -cov QualityScoreCovariate -cov CycleCovariate -cov DinucCovariate +@PG ID:bam_count_covariates.20 PN:GenomeAnalysisTK PP:bam_realignment_around_known_indels.20 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T CountCovariates -R $reference_fasta -I $bam_file -recalFile $bam_file.recal_data.csv -knownSites $known_sites_file(s) -l INFO -L '1;2;3;4;5;6;7;8;9;10;11;12;13;14;15;16;17;18;19;20;21;22;X;Y;MT' -cov ReadGroupCovariate -cov QualityScoreCovariate -cov CycleCovariate -cov DinucCovariate +@PG ID:bam_count_covariates.21 PN:GenomeAnalysisTK PP:bam_realignment_around_known_indels.21 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T CountCovariates -R $reference_fasta -I $bam_file -recalFile $bam_file.recal_data.csv -knownSites $known_sites_file(s) -l INFO -L '1;2;3;4;5;6;7;8;9;10;11;12;13;14;15;16;17;18;19;20;21;22;X;Y;MT' -cov ReadGroupCovariate -cov QualityScoreCovariate -cov CycleCovariate -cov DinucCovariate +@PG ID:bam_count_covariates.22 PN:GenomeAnalysisTK PP:bam_realignment_around_known_indels.22 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T CountCovariates -R $reference_fasta -I $bam_file -recalFile $bam_file.recal_data.csv -knownSites $known_sites_file(s) -l INFO -L '1;2;3;4;5;6;7;8;9;10;11;12;13;14;15;16;17;18;19;20;21;22;X;Y;MT' -cov ReadGroupCovariate -cov QualityScoreCovariate -cov CycleCovariate -cov DinucCovariate +@PG ID:bam_count_covariates.23 PN:GenomeAnalysisTK PP:bam_realignment_around_known_indels.23 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T CountCovariates -R $reference_fasta -I $bam_file -recalFile $bam_file.recal_data.csv -knownSites $known_sites_file(s) -l INFO -L '1;2;3;4;5;6;7;8;9;10;11;12;13;14;15;16;17;18;19;20;21;22;X;Y;MT' -cov ReadGroupCovariate -cov QualityScoreCovariate -cov CycleCovariate -cov DinucCovariate +@PG ID:bam_count_covariates.24 PN:GenomeAnalysisTK PP:bam_realignment_around_known_indels.24 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T CountCovariates -R $reference_fasta -I $bam_file -recalFile $bam_file.recal_data.csv -knownSites $known_sites_file(s) -l INFO -L '1;2;3;4;5;6;7;8;9;10;11;12;13;14;15;16;17;18;19;20;21;22;X;Y;MT' -cov ReadGroupCovariate -cov QualityScoreCovariate -cov CycleCovariate -cov DinucCovariate +@PG ID:bam_count_covariates.25 PN:GenomeAnalysisTK PP:bam_realignment_around_known_indels.25 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T CountCovariates -R $reference_fasta -I $bam_file -recalFile $bam_file.recal_data.csv -knownSites $known_sites_file(s) -l INFO -L '1;2;3;4;5;6;7;8;9;10;11;12;13;14;15;16;17;18;19;20;21;22;X;Y;MT' -cov ReadGroupCovariate -cov QualityScoreCovariate -cov CycleCovariate -cov DinucCovariate +@PG ID:bam_count_covariates.26 PN:GenomeAnalysisTK PP:bam_realignment_around_known_indels.26 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T CountCovariates -R $reference_fasta -I $bam_file -recalFile $bam_file.recal_data.csv -knownSites $known_sites_file(s) -l INFO -L '1;2;3;4;5;6;7;8;9;10;11;12;13;14;15;16;17;18;19;20;21;22;X;Y;MT' -cov ReadGroupCovariate -cov QualityScoreCovariate -cov CycleCovariate -cov DinucCovariate +@PG ID:bam_count_covariates.27 PN:GenomeAnalysisTK PP:bam_realignment_around_known_indels.27 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T CountCovariates -R $reference_fasta -I $bam_file -recalFile $bam_file.recal_data.csv -knownSites $known_sites_file(s) -l INFO -L '1;2;3;4;5;6;7;8;9;10;11;12;13;14;15;16;17;18;19;20;21;22;X;Y;MT' -cov ReadGroupCovariate -cov QualityScoreCovariate -cov CycleCovariate -cov DinucCovariate +@PG ID:bam_count_covariates.28 PN:GenomeAnalysisTK PP:bam_realignment_around_known_indels.28 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T CountCovariates -R $reference_fasta -I $bam_file -recalFile $bam_file.recal_data.csv -knownSites $known_sites_file(s) -l INFO -L '1;2;3;4;5;6;7;8;9;10;11;12;13;14;15;16;17;18;19;20;21;22;X;Y;MT' -cov ReadGroupCovariate -cov QualityScoreCovariate -cov CycleCovariate -cov DinucCovariate +@PG ID:bam_count_covariates.29 PN:GenomeAnalysisTK PP:bam_realignment_around_known_indels.29 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T CountCovariates -R $reference_fasta -I $bam_file -recalFile $bam_file.recal_data.csv -knownSites $known_sites_file(s) -l INFO -L '1;2;3;4;5;6;7;8;9;10;11;12;13;14;15;16;17;18;19;20;21;22;X;Y;MT' -cov ReadGroupCovariate -cov QualityScoreCovariate -cov CycleCovariate -cov DinucCovariate +@PG ID:bam_count_covariates.30 PN:GenomeAnalysisTK PP:bam_realignment_around_known_indels.30 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T CountCovariates -R $reference_fasta -I $bam_file -recalFile $bam_file.recal_data.csv -knownSites $known_sites_file(s) -l INFO -L '1;2;3;4;5;6;7;8;9;10;11;12;13;14;15;16;17;18;19;20;21;22;X;Y;MT' -cov ReadGroupCovariate -cov QualityScoreCovariate -cov CycleCovariate -cov DinucCovariate +@PG ID:bam_count_covariates.31 PN:GenomeAnalysisTK PP:bam_realignment_around_known_indels.31 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T CountCovariates -R $reference_fasta -I $bam_file -recalFile $bam_file.recal_data.csv -knownSites $known_sites_file(s) -l INFO -L '1;2;3;4;5;6;7;8;9;10;11;12;13;14;15;16;17;18;19;20;21;22;X;Y;MT' -cov ReadGroupCovariate -cov QualityScoreCovariate -cov CycleCovariate -cov DinucCovariate +@PG ID:bam_count_covariates.32 PN:GenomeAnalysisTK PP:bam_realignment_around_known_indels.32 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T CountCovariates -R $reference_fasta -I $bam_file -recalFile $bam_file.recal_data.csv -knownSites $known_sites_file(s) -l INFO -L '1;2;3;4;5;6;7;8;9;10;11;12;13;14;15;16;17;18;19;20;21;22;X;Y;MT' -cov ReadGroupCovariate -cov QualityScoreCovariate -cov CycleCovariate -cov DinucCovariate +@PG ID:bam_count_covariates.33 PN:GenomeAnalysisTK PP:bam_realignment_around_known_indels.33 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T CountCovariates -R $reference_fasta -I $bam_file -recalFile $bam_file.recal_data.csv -knownSites $known_sites_file(s) -l INFO -L '1;2;3;4;5;6;7;8;9;10;11;12;13;14;15;16;17;18;19;20;21;22;X;Y;MT' -cov ReadGroupCovariate -cov QualityScoreCovariate -cov CycleCovariate -cov DinucCovariate +@PG ID:bam_count_covariates.34 PN:GenomeAnalysisTK PP:bam_realignment_around_known_indels.34 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T CountCovariates -R $reference_fasta -I $bam_file -recalFile $bam_file.recal_data.csv -knownSites $known_sites_file(s) -l INFO -L '1;2;3;4;5;6;7;8;9;10;11;12;13;14;15;16;17;18;19;20;21;22;X;Y;MT' -cov ReadGroupCovariate -cov QualityScoreCovariate -cov CycleCovariate -cov DinucCovariate +@PG ID:bam_count_covariates.35 PN:GenomeAnalysisTK PP:bam_realignment_around_known_indels.35 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T CountCovariates -R $reference_fasta -I $bam_file -recalFile $bam_file.recal_data.csv -knownSites $known_sites_file(s) -l INFO -L '1;2;3;4;5;6;7;8;9;10;11;12;13;14;15;16;17;18;19;20;21;22;X;Y;MT' -cov ReadGroupCovariate -cov QualityScoreCovariate -cov CycleCovariate -cov DinucCovariate +@PG ID:bam_count_covariates.36 PN:GenomeAnalysisTK PP:bam_realignment_around_known_indels.36 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T CountCovariates -R $reference_fasta -I $bam_file -recalFile $bam_file.recal_data.csv -knownSites $known_sites_file(s) -l INFO -L '1;2;3;4;5;6;7;8;9;10;11;12;13;14;15;16;17;18;19;20;21;22;X;Y;MT' -cov ReadGroupCovariate -cov QualityScoreCovariate -cov CycleCovariate -cov DinucCovariate +@PG ID:bam_count_covariates.37 PN:GenomeAnalysisTK PP:bam_realignment_around_known_indels.37 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T CountCovariates -R $reference_fasta -I $bam_file -recalFile $bam_file.recal_data.csv -knownSites $known_sites_file(s) -l INFO -L '1;2;3;4;5;6;7;8;9;10;11;12;13;14;15;16;17;18;19;20;21;22;X;Y;MT' -cov ReadGroupCovariate -cov QualityScoreCovariate -cov CycleCovariate -cov DinucCovariate +@PG ID:bam_count_covariates.38 PN:GenomeAnalysisTK PP:bam_realignment_around_known_indels.38 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T CountCovariates -R $reference_fasta -I $bam_file -recalFile $bam_file.recal_data.csv -knownSites $known_sites_file(s) -l INFO -L '1;2;3;4;5;6;7;8;9;10;11;12;13;14;15;16;17;18;19;20;21;22;X;Y;MT' -cov ReadGroupCovariate -cov QualityScoreCovariate -cov CycleCovariate -cov DinucCovariate +@PG ID:bam_recalibrate_quality_scores PN:GenomeAnalysisTK PP:bam_count_covariates VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T TableRecalibration -R $reference_fasta -recalFile $bam_file.recal_data.csv -I $bam_file -o $recalibrated_bam_file -l INFO -compress 0 --disable_bam_indexing +@PG ID:bam_recalibrate_quality_scores.1 PN:GenomeAnalysisTK PP:bam_count_covariates.1 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T TableRecalibration -R $reference_fasta -recalFile $bam_file.recal_data.csv -I $bam_file -o $recalibrated_bam_file -l INFO -compress 0 --disable_bam_indexing +@PG ID:bam_recalibrate_quality_scores.2 PN:GenomeAnalysisTK PP:bam_count_covariates.2 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T TableRecalibration -R $reference_fasta -recalFile $bam_file.recal_data.csv -I $bam_file -o $recalibrated_bam_file -l INFO -compress 0 --disable_bam_indexing +@PG ID:bam_recalibrate_quality_scores.3 PN:GenomeAnalysisTK PP:bam_count_covariates.3 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T TableRecalibration -R $reference_fasta -recalFile $bam_file.recal_data.csv -I $bam_file -o $recalibrated_bam_file -l INFO -compress 0 --disable_bam_indexing +@PG ID:bam_recalibrate_quality_scores.4 PN:GenomeAnalysisTK PP:bam_count_covariates.4 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T TableRecalibration -R $reference_fasta -recalFile $bam_file.recal_data.csv -I $bam_file -o $recalibrated_bam_file -l INFO -compress 0 --disable_bam_indexing +@PG ID:bam_recalibrate_quality_scores.5 PN:GenomeAnalysisTK PP:bam_count_covariates.5 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T TableRecalibration -R $reference_fasta -recalFile $bam_file.recal_data.csv -I $bam_file -o $recalibrated_bam_file -l INFO -compress 0 --disable_bam_indexing +@PG ID:bam_recalibrate_quality_scores.6 PN:GenomeAnalysisTK PP:bam_count_covariates.6 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T TableRecalibration -R $reference_fasta -recalFile $bam_file.recal_data.csv -I $bam_file -o $recalibrated_bam_file -l INFO -compress 0 --disable_bam_indexing +@PG ID:bam_recalibrate_quality_scores.7 PN:GenomeAnalysisTK PP:bam_count_covariates.7 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T TableRecalibration -R $reference_fasta -recalFile $bam_file.recal_data.csv -I $bam_file -o $recalibrated_bam_file -l INFO -compress 0 --disable_bam_indexing +@PG ID:bam_recalibrate_quality_scores.8 PN:GenomeAnalysisTK PP:bam_count_covariates.8 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T TableRecalibration -R $reference_fasta -recalFile $bam_file.recal_data.csv -I $bam_file -o $recalibrated_bam_file -l INFO -compress 0 --disable_bam_indexing +@PG ID:bam_recalibrate_quality_scores.9 PN:GenomeAnalysisTK PP:bam_count_covariates.9 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T TableRecalibration -R $reference_fasta -recalFile $bam_file.recal_data.csv -I $bam_file -o $recalibrated_bam_file -l INFO -compress 0 --disable_bam_indexing +@PG ID:bam_recalibrate_quality_scores.10 PN:GenomeAnalysisTK PP:bam_count_covariates.10 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T TableRecalibration -R $reference_fasta -recalFile $bam_file.recal_data.csv -I $bam_file -o $recalibrated_bam_file -l INFO -compress 0 --disable_bam_indexing +@PG ID:bam_recalibrate_quality_scores.11 PN:GenomeAnalysisTK PP:bam_count_covariates.11 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T TableRecalibration -R $reference_fasta -recalFile $bam_file.recal_data.csv -I $bam_file -o $recalibrated_bam_file -l INFO -compress 0 --disable_bam_indexing +@PG ID:bam_recalibrate_quality_scores.12 PN:GenomeAnalysisTK PP:bam_count_covariates.12 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T TableRecalibration -R $reference_fasta -recalFile $bam_file.recal_data.csv -I $bam_file -o $recalibrated_bam_file -l INFO -compress 0 --disable_bam_indexing +@PG ID:bam_recalibrate_quality_scores.13 PN:GenomeAnalysisTK PP:bam_count_covariates.13 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T TableRecalibration -R $reference_fasta -recalFile $bam_file.recal_data.csv -I $bam_file -o $recalibrated_bam_file -l INFO -compress 0 --disable_bam_indexing +@PG ID:bam_recalibrate_quality_scores.14 PN:GenomeAnalysisTK PP:bam_count_covariates.14 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T TableRecalibration -R $reference_fasta -recalFile $bam_file.recal_data.csv -I $bam_file -o $recalibrated_bam_file -l INFO -compress 0 --disable_bam_indexing +@PG ID:bam_recalibrate_quality_scores.15 PN:GenomeAnalysisTK PP:bam_count_covariates.15 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T TableRecalibration -R $reference_fasta -recalFile $bam_file.recal_data.csv -I $bam_file -o $recalibrated_bam_file -l INFO -compress 0 --disable_bam_indexing +@PG ID:bam_recalibrate_quality_scores.16 PN:GenomeAnalysisTK PP:bam_count_covariates.16 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T TableRecalibration -R $reference_fasta -recalFile $bam_file.recal_data.csv -I $bam_file -o $recalibrated_bam_file -l INFO -compress 0 --disable_bam_indexing +@PG ID:bam_recalibrate_quality_scores.17 PN:GenomeAnalysisTK PP:bam_count_covariates.17 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T TableRecalibration -R $reference_fasta -recalFile $bam_file.recal_data.csv -I $bam_file -o $recalibrated_bam_file -l INFO -compress 0 --disable_bam_indexing +@PG ID:bam_recalibrate_quality_scores.18 PN:GenomeAnalysisTK PP:bam_count_covariates.18 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T TableRecalibration -R $reference_fasta -recalFile $bam_file.recal_data.csv -I $bam_file -o $recalibrated_bam_file -l INFO -compress 0 --disable_bam_indexing +@PG ID:bam_recalibrate_quality_scores.19 PN:GenomeAnalysisTK PP:bam_count_covariates.19 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T TableRecalibration -R $reference_fasta -recalFile $bam_file.recal_data.csv -I $bam_file -o $recalibrated_bam_file -l INFO -compress 0 --disable_bam_indexing +@PG ID:bam_recalibrate_quality_scores.20 PN:GenomeAnalysisTK PP:bam_count_covariates.20 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T TableRecalibration -R $reference_fasta -recalFile $bam_file.recal_data.csv -I $bam_file -o $recalibrated_bam_file -l INFO -compress 0 --disable_bam_indexing +@PG ID:bam_recalibrate_quality_scores.21 PN:GenomeAnalysisTK PP:bam_count_covariates.21 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T TableRecalibration -R $reference_fasta -recalFile $bam_file.recal_data.csv -I $bam_file -o $recalibrated_bam_file -l INFO -compress 0 --disable_bam_indexing +@PG ID:bam_recalibrate_quality_scores.22 PN:GenomeAnalysisTK PP:bam_count_covariates.22 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T TableRecalibration -R $reference_fasta -recalFile $bam_file.recal_data.csv -I $bam_file -o $recalibrated_bam_file -l INFO -compress 0 --disable_bam_indexing +@PG ID:bam_recalibrate_quality_scores.23 PN:GenomeAnalysisTK PP:bam_count_covariates.23 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T TableRecalibration -R $reference_fasta -recalFile $bam_file.recal_data.csv -I $bam_file -o $recalibrated_bam_file -l INFO -compress 0 --disable_bam_indexing +@PG ID:bam_recalibrate_quality_scores.24 PN:GenomeAnalysisTK PP:bam_count_covariates.24 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T TableRecalibration -R $reference_fasta -recalFile $bam_file.recal_data.csv -I $bam_file -o $recalibrated_bam_file -l INFO -compress 0 --disable_bam_indexing +@PG ID:bam_recalibrate_quality_scores.25 PN:GenomeAnalysisTK PP:bam_count_covariates.25 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T TableRecalibration -R $reference_fasta -recalFile $bam_file.recal_data.csv -I $bam_file -o $recalibrated_bam_file -l INFO -compress 0 --disable_bam_indexing +@PG ID:bam_recalibrate_quality_scores.26 PN:GenomeAnalysisTK PP:bam_count_covariates.26 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T TableRecalibration -R $reference_fasta -recalFile $bam_file.recal_data.csv -I $bam_file -o $recalibrated_bam_file -l INFO -compress 0 --disable_bam_indexing +@PG ID:bam_recalibrate_quality_scores.27 PN:GenomeAnalysisTK PP:bam_count_covariates.27 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T TableRecalibration -R $reference_fasta -recalFile $bam_file.recal_data.csv -I $bam_file -o $recalibrated_bam_file -l INFO -compress 0 --disable_bam_indexing +@PG ID:bam_recalibrate_quality_scores.28 PN:GenomeAnalysisTK PP:bam_count_covariates.28 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T TableRecalibration -R $reference_fasta -recalFile $bam_file.recal_data.csv -I $bam_file -o $recalibrated_bam_file -l INFO -compress 0 --disable_bam_indexing +@PG ID:bam_recalibrate_quality_scores.29 PN:GenomeAnalysisTK PP:bam_count_covariates.29 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T TableRecalibration -R $reference_fasta -recalFile $bam_file.recal_data.csv -I $bam_file -o $recalibrated_bam_file -l INFO -compress 0 --disable_bam_indexing +@PG ID:bam_recalibrate_quality_scores.30 PN:GenomeAnalysisTK PP:bam_count_covariates.30 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T TableRecalibration -R $reference_fasta -recalFile $bam_file.recal_data.csv -I $bam_file -o $recalibrated_bam_file -l INFO -compress 0 --disable_bam_indexing +@PG ID:bam_recalibrate_quality_scores.31 PN:GenomeAnalysisTK PP:bam_count_covariates.31 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T TableRecalibration -R $reference_fasta -recalFile $bam_file.recal_data.csv -I $bam_file -o $recalibrated_bam_file -l INFO -compress 0 --disable_bam_indexing +@PG ID:bam_recalibrate_quality_scores.32 PN:GenomeAnalysisTK PP:bam_count_covariates.32 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T TableRecalibration -R $reference_fasta -recalFile $bam_file.recal_data.csv -I $bam_file -o $recalibrated_bam_file -l INFO -compress 0 --disable_bam_indexing +@PG ID:bam_recalibrate_quality_scores.33 PN:GenomeAnalysisTK PP:bam_count_covariates.33 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T TableRecalibration -R $reference_fasta -recalFile $bam_file.recal_data.csv -I $bam_file -o $recalibrated_bam_file -l INFO -compress 0 --disable_bam_indexing +@PG ID:bam_recalibrate_quality_scores.34 PN:GenomeAnalysisTK PP:bam_count_covariates.34 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T TableRecalibration -R $reference_fasta -recalFile $bam_file.recal_data.csv -I $bam_file -o $recalibrated_bam_file -l INFO -compress 0 --disable_bam_indexing +@PG ID:bam_recalibrate_quality_scores.35 PN:GenomeAnalysisTK PP:bam_count_covariates.35 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T TableRecalibration -R $reference_fasta -recalFile $bam_file.recal_data.csv -I $bam_file -o $recalibrated_bam_file -l INFO -compress 0 --disable_bam_indexing +@PG ID:bam_recalibrate_quality_scores.36 PN:GenomeAnalysisTK PP:bam_count_covariates.36 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T TableRecalibration -R $reference_fasta -recalFile $bam_file.recal_data.csv -I $bam_file -o $recalibrated_bam_file -l INFO -compress 0 --disable_bam_indexing +@PG ID:bam_recalibrate_quality_scores.37 PN:GenomeAnalysisTK PP:bam_count_covariates.37 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T TableRecalibration -R $reference_fasta -recalFile $bam_file.recal_data.csv -I $bam_file -o $recalibrated_bam_file -l INFO -compress 0 --disable_bam_indexing +@PG ID:bam_recalibrate_quality_scores.38 PN:GenomeAnalysisTK PP:bam_count_covariates.38 VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T TableRecalibration -R $reference_fasta -recalFile $bam_file.recal_data.csv -I $bam_file -o $recalibrated_bam_file -l INFO -compress 0 --disable_bam_indexing +@PG ID:bam_calculate_bq PN:samtools PP:bam_recalibrate_quality_scores VN:0.1.17 (r973:277) CL:samtools calmd -Erb $bam_file $reference_fasta > $bq_bam_file +@PG ID:bam_calculate_bq.1 PN:samtools PP:bam_recalibrate_quality_scores.1 VN:0.1.17 (r973:277) CL:samtools calmd -Erb $bam_file $reference_fasta > $bq_bam_file +@PG ID:bam_calculate_bq.2 PN:samtools PP:bam_recalibrate_quality_scores.2 VN:0.1.17 (r973:277) CL:samtools calmd -Erb $bam_file $reference_fasta > $bq_bam_file +@PG ID:bam_calculate_bq.3 PN:samtools PP:bam_recalibrate_quality_scores.3 VN:0.1.17 (r973:277) CL:samtools calmd -Erb $bam_file $reference_fasta > $bq_bam_file +@PG ID:bam_calculate_bq.4 PN:samtools PP:bam_recalibrate_quality_scores.4 VN:0.1.17 (r973:277) CL:samtools calmd -Erb $bam_file $reference_fasta > $bq_bam_file +@PG ID:bam_calculate_bq.5 PN:samtools PP:bam_recalibrate_quality_scores.5 VN:0.1.17 (r973:277) CL:samtools calmd -Erb $bam_file $reference_fasta > $bq_bam_file +@PG ID:bam_calculate_bq.6 PN:samtools PP:bam_recalibrate_quality_scores.6 VN:0.1.17 (r973:277) CL:samtools calmd -Erb $bam_file $reference_fasta > $bq_bam_file +@PG ID:bam_calculate_bq.7 PN:samtools PP:bam_recalibrate_quality_scores.7 VN:0.1.17 (r973:277) CL:samtools calmd -Erb $bam_file $reference_fasta > $bq_bam_file +@PG ID:bam_calculate_bq.8 PN:samtools PP:bam_recalibrate_quality_scores.8 VN:0.1.17 (r973:277) CL:samtools calmd -Erb $bam_file $reference_fasta > $bq_bam_file +@PG ID:bam_calculate_bq.9 PN:samtools PP:bam_recalibrate_quality_scores.9 VN:0.1.17 (r973:277) CL:samtools calmd -Erb $bam_file $reference_fasta > $bq_bam_file +@PG ID:bam_calculate_bq.10 PN:samtools PP:bam_recalibrate_quality_scores.10 VN:0.1.17 (r973:277) CL:samtools calmd -Erb $bam_file $reference_fasta > $bq_bam_file +@PG ID:bam_calculate_bq.11 PN:samtools PP:bam_recalibrate_quality_scores.11 VN:0.1.17 (r973:277) CL:samtools calmd -Erb $bam_file $reference_fasta > $bq_bam_file +@PG ID:bam_calculate_bq.12 PN:samtools PP:bam_recalibrate_quality_scores.12 VN:0.1.17 (r973:277) CL:samtools calmd -Erb $bam_file $reference_fasta > $bq_bam_file +@PG ID:bam_calculate_bq.13 PN:samtools PP:bam_recalibrate_quality_scores.13 VN:0.1.17 (r973:277) CL:samtools calmd -Erb $bam_file $reference_fasta > $bq_bam_file +@PG ID:bam_calculate_bq.14 PN:samtools PP:bam_recalibrate_quality_scores.14 VN:0.1.17 (r973:277) CL:samtools calmd -Erb $bam_file $reference_fasta > $bq_bam_file +@PG ID:bam_calculate_bq.15 PN:samtools PP:bam_recalibrate_quality_scores.15 VN:0.1.17 (r973:277) CL:samtools calmd -Erb $bam_file $reference_fasta > $bq_bam_file +@PG ID:bam_calculate_bq.16 PN:samtools PP:bam_recalibrate_quality_scores.16 VN:0.1.17 (r973:277) CL:samtools calmd -Erb $bam_file $reference_fasta > $bq_bam_file +@PG ID:bam_calculate_bq.17 PN:samtools PP:bam_recalibrate_quality_scores.17 VN:0.1.17 (r973:277) CL:samtools calmd -Erb $bam_file $reference_fasta > $bq_bam_file +@PG ID:bam_calculate_bq.18 PN:samtools PP:bam_recalibrate_quality_scores.18 VN:0.1.17 (r973:277) CL:samtools calmd -Erb $bam_file $reference_fasta > $bq_bam_file +@PG ID:bam_calculate_bq.19 PN:samtools PP:bam_recalibrate_quality_scores.19 VN:0.1.17 (r973:277) CL:samtools calmd -Erb $bam_file $reference_fasta > $bq_bam_file +@PG ID:bam_calculate_bq.20 PN:samtools PP:bam_recalibrate_quality_scores.20 VN:0.1.17 (r973:277) CL:samtools calmd -Erb $bam_file $reference_fasta > $bq_bam_file +@PG ID:bam_calculate_bq.21 PN:samtools PP:bam_recalibrate_quality_scores.21 VN:0.1.17 (r973:277) CL:samtools calmd -Erb $bam_file $reference_fasta > $bq_bam_file +@PG ID:bam_calculate_bq.22 PN:samtools PP:bam_recalibrate_quality_scores.22 VN:0.1.17 (r973:277) CL:samtools calmd -Erb $bam_file $reference_fasta > $bq_bam_file +@PG ID:bam_calculate_bq.23 PN:samtools PP:bam_recalibrate_quality_scores.23 VN:0.1.17 (r973:277) CL:samtools calmd -Erb $bam_file $reference_fasta > $bq_bam_file +@PG ID:bam_calculate_bq.24 PN:samtools PP:bam_recalibrate_quality_scores.24 VN:0.1.17 (r973:277) CL:samtools calmd -Erb $bam_file $reference_fasta > $bq_bam_file +@PG ID:bam_calculate_bq.25 PN:samtools PP:bam_recalibrate_quality_scores.25 VN:0.1.17 (r973:277) CL:samtools calmd -Erb $bam_file $reference_fasta > $bq_bam_file +@PG ID:bam_calculate_bq.26 PN:samtools PP:bam_recalibrate_quality_scores.26 VN:0.1.17 (r973:277) CL:samtools calmd -Erb $bam_file $reference_fasta > $bq_bam_file +@PG ID:bam_calculate_bq.27 PN:samtools PP:bam_recalibrate_quality_scores.27 VN:0.1.17 (r973:277) CL:samtools calmd -Erb $bam_file $reference_fasta > $bq_bam_file +@PG ID:bam_calculate_bq.28 PN:samtools PP:bam_recalibrate_quality_scores.28 VN:0.1.17 (r973:277) CL:samtools calmd -Erb $bam_file $reference_fasta > $bq_bam_file +@PG ID:bam_calculate_bq.29 PN:samtools PP:bam_recalibrate_quality_scores.29 VN:0.1.17 (r973:277) CL:samtools calmd -Erb $bam_file $reference_fasta > $bq_bam_file +@PG ID:bam_calculate_bq.30 PN:samtools PP:bam_recalibrate_quality_scores.30 VN:0.1.17 (r973:277) CL:samtools calmd -Erb $bam_file $reference_fasta > $bq_bam_file +@PG ID:bam_calculate_bq.31 PN:samtools PP:bam_recalibrate_quality_scores.31 VN:0.1.17 (r973:277) CL:samtools calmd -Erb $bam_file $reference_fasta > $bq_bam_file +@PG ID:bam_calculate_bq.32 PN:samtools PP:bam_recalibrate_quality_scores.32 VN:0.1.17 (r973:277) CL:samtools calmd -Erb $bam_file $reference_fasta > $bq_bam_file +@PG ID:bam_calculate_bq.33 PN:samtools PP:bam_recalibrate_quality_scores.33 VN:0.1.17 (r973:277) CL:samtools calmd -Erb $bam_file $reference_fasta > $bq_bam_file +@PG ID:bam_calculate_bq.34 PN:samtools PP:bam_recalibrate_quality_scores.34 VN:0.1.17 (r973:277) CL:samtools calmd -Erb $bam_file $reference_fasta > $bq_bam_file +@PG ID:bam_calculate_bq.35 PN:samtools PP:bam_recalibrate_quality_scores.35 VN:0.1.17 (r973:277) CL:samtools calmd -Erb $bam_file $reference_fasta > $bq_bam_file +@PG ID:bam_calculate_bq.36 PN:samtools PP:bam_recalibrate_quality_scores.36 VN:0.1.17 (r973:277) CL:samtools calmd -Erb $bam_file $reference_fasta > $bq_bam_file +@PG ID:bam_calculate_bq.37 PN:samtools PP:bam_recalibrate_quality_scores.37 VN:0.1.17 (r973:277) CL:samtools calmd -Erb $bam_file $reference_fasta > $bq_bam_file +@PG ID:bam_calculate_bq.38 PN:samtools PP:bam_recalibrate_quality_scores.38 VN:0.1.17 (r973:277) CL:samtools calmd -Erb $bam_file $reference_fasta > $bq_bam_file +@PG ID:bam_merge PN:picard PP:bam_calculate_bq VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.1 PN:picard PP:bam_calculate_bq.1 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.2 PN:picard PP:bam_calculate_bq.2 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.3 PN:picard PP:bam_calculate_bq.3 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.4 PN:picard PP:bam_calculate_bq.4 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.5 PN:picard PP:bam_calculate_bq.5 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.6 PN:picard PP:bam_calculate_bq.6 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.7 PN:picard PP:bam_calculate_bq.7 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.8 PN:picard PP:bam_calculate_bq.8 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.9 PN:picard PP:bam_calculate_bq.9 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.10 PN:picard PP:bam_calculate_bq.10 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.11 PN:picard PP:bam_calculate_bq.11 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.12 PN:picard PP:bam_calculate_bq.12 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.13 PN:picard PP:bam_calculate_bq.13 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.14 PN:picard PP:bam_calculate_bq.14 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.15 PN:picard PP:bam_calculate_bq.15 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.16 PN:picard PP:bam_calculate_bq.16 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.17 PN:picard PP:bam_calculate_bq.17 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.18 PN:picard PP:bam_calculate_bq.18 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.19 PN:picard PP:bam_calculate_bq.19 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.20 PN:picard PP:bam_calculate_bq.20 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.21 PN:picard PP:bam_calculate_bq.21 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.22 PN:picard PP:bam_calculate_bq.22 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.23 PN:picard PP:bam_calculate_bq.23 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.24 PN:picard PP:bam_calculate_bq.24 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.25 PN:picard PP:bam_calculate_bq.25 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.26 PN:picard PP:bam_calculate_bq.26 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.27 PN:picard PP:bam_calculate_bq.27 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.28 PN:picard PP:bam_calculate_bq.28 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.29 PN:picard PP:bam_calculate_bq.29 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.30 PN:picard PP:bam_calculate_bq.30 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.31 PN:picard PP:bam_calculate_bq.31 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.32 PN:picard PP:bam_calculate_bq.32 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.33 PN:picard PP:bam_calculate_bq.33 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.34 PN:picard PP:bam_calculate_bq.34 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.35 PN:picard PP:bam_calculate_bq.35 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.36 PN:picard PP:bam_calculate_bq.36 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.37 PN:picard PP:bam_calculate_bq.37 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.38 PN:picard PP:bam_calculate_bq.38 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_mark_duplicates PN:picard PP:bam_merge VN:1.53 CL:java $jvm_args -jar MarkDuplicates.jar INPUT=$bam_file OUTPUT=$markdup_bam_file ASSUME_SORTED=TRUE METRICS_FILE=/dev/null VALIDATION_STRINGENCY=SILENT +@PG ID:bam_mark_duplicates.1 PN:picard PP:bam_merge.1 VN:1.53 CL:java $jvm_args -jar MarkDuplicates.jar INPUT=$bam_file OUTPUT=$markdup_bam_file ASSUME_SORTED=TRUE METRICS_FILE=/dev/null VALIDATION_STRINGENCY=SILENT +@PG ID:bam_mark_duplicates.2 PN:picard PP:bam_merge.2 VN:1.53 CL:java $jvm_args -jar MarkDuplicates.jar INPUT=$bam_file OUTPUT=$markdup_bam_file ASSUME_SORTED=TRUE METRICS_FILE=/dev/null VALIDATION_STRINGENCY=SILENT +@PG ID:bam_mark_duplicates.3 PN:picard PP:bam_merge.3 VN:1.53 CL:java $jvm_args -jar MarkDuplicates.jar INPUT=$bam_file OUTPUT=$markdup_bam_file ASSUME_SORTED=TRUE METRICS_FILE=/dev/null VALIDATION_STRINGENCY=SILENT +@PG ID:bam_mark_duplicates.4 PN:picard PP:bam_merge.4 VN:1.53 CL:java $jvm_args -jar MarkDuplicates.jar INPUT=$bam_file OUTPUT=$markdup_bam_file ASSUME_SORTED=TRUE METRICS_FILE=/dev/null VALIDATION_STRINGENCY=SILENT +@PG ID:bam_mark_duplicates.5 PN:picard PP:bam_merge.5 VN:1.53 CL:java $jvm_args -jar MarkDuplicates.jar INPUT=$bam_file OUTPUT=$markdup_bam_file ASSUME_SORTED=TRUE METRICS_FILE=/dev/null VALIDATION_STRINGENCY=SILENT +@PG ID:bam_mark_duplicates.6 PN:picard PP:bam_merge.6 VN:1.53 CL:java $jvm_args -jar MarkDuplicates.jar INPUT=$bam_file OUTPUT=$markdup_bam_file ASSUME_SORTED=TRUE METRICS_FILE=/dev/null VALIDATION_STRINGENCY=SILENT +@PG ID:bam_mark_duplicates.7 PN:picard PP:bam_merge.7 VN:1.53 CL:java $jvm_args -jar MarkDuplicates.jar INPUT=$bam_file OUTPUT=$markdup_bam_file ASSUME_SORTED=TRUE METRICS_FILE=/dev/null VALIDATION_STRINGENCY=SILENT +@PG ID:bam_mark_duplicates.8 PN:picard PP:bam_merge.8 VN:1.53 CL:java $jvm_args -jar MarkDuplicates.jar INPUT=$bam_file OUTPUT=$markdup_bam_file ASSUME_SORTED=TRUE METRICS_FILE=/dev/null VALIDATION_STRINGENCY=SILENT +@PG ID:bam_mark_duplicates.9 PN:picard PP:bam_merge.9 VN:1.53 CL:java $jvm_args -jar MarkDuplicates.jar INPUT=$bam_file OUTPUT=$markdup_bam_file ASSUME_SORTED=TRUE METRICS_FILE=/dev/null VALIDATION_STRINGENCY=SILENT +@PG ID:bam_mark_duplicates.10 PN:picard PP:bam_merge.10 VN:1.53 CL:java $jvm_args -jar MarkDuplicates.jar INPUT=$bam_file OUTPUT=$markdup_bam_file ASSUME_SORTED=TRUE METRICS_FILE=/dev/null VALIDATION_STRINGENCY=SILENT +@PG ID:bam_mark_duplicates.11 PN:picard PP:bam_merge.11 VN:1.53 CL:java $jvm_args -jar MarkDuplicates.jar INPUT=$bam_file OUTPUT=$markdup_bam_file ASSUME_SORTED=TRUE METRICS_FILE=/dev/null VALIDATION_STRINGENCY=SILENT +@PG ID:bam_mark_duplicates.12 PN:picard PP:bam_merge.12 VN:1.53 CL:java $jvm_args -jar MarkDuplicates.jar INPUT=$bam_file OUTPUT=$markdup_bam_file ASSUME_SORTED=TRUE METRICS_FILE=/dev/null VALIDATION_STRINGENCY=SILENT +@PG ID:bam_mark_duplicates.13 PN:picard PP:bam_merge.13 VN:1.53 CL:java $jvm_args -jar MarkDuplicates.jar INPUT=$bam_file OUTPUT=$markdup_bam_file ASSUME_SORTED=TRUE METRICS_FILE=/dev/null VALIDATION_STRINGENCY=SILENT +@PG ID:bam_mark_duplicates.14 PN:picard PP:bam_merge.14 VN:1.53 CL:java $jvm_args -jar MarkDuplicates.jar INPUT=$bam_file OUTPUT=$markdup_bam_file ASSUME_SORTED=TRUE METRICS_FILE=/dev/null VALIDATION_STRINGENCY=SILENT +@PG ID:bam_mark_duplicates.15 PN:picard PP:bam_merge.15 VN:1.53 CL:java $jvm_args -jar MarkDuplicates.jar INPUT=$bam_file OUTPUT=$markdup_bam_file ASSUME_SORTED=TRUE METRICS_FILE=/dev/null VALIDATION_STRINGENCY=SILENT +@PG ID:bam_mark_duplicates.16 PN:picard PP:bam_merge.16 VN:1.53 CL:java $jvm_args -jar MarkDuplicates.jar INPUT=$bam_file OUTPUT=$markdup_bam_file ASSUME_SORTED=TRUE METRICS_FILE=/dev/null VALIDATION_STRINGENCY=SILENT +@PG ID:bam_mark_duplicates.17 PN:picard PP:bam_merge.17 VN:1.53 CL:java $jvm_args -jar MarkDuplicates.jar INPUT=$bam_file OUTPUT=$markdup_bam_file ASSUME_SORTED=TRUE METRICS_FILE=/dev/null VALIDATION_STRINGENCY=SILENT +@PG ID:bam_mark_duplicates.18 PN:picard PP:bam_merge.18 VN:1.53 CL:java $jvm_args -jar MarkDuplicates.jar INPUT=$bam_file OUTPUT=$markdup_bam_file ASSUME_SORTED=TRUE METRICS_FILE=/dev/null VALIDATION_STRINGENCY=SILENT +@PG ID:bam_mark_duplicates.19 PN:picard PP:bam_merge.19 VN:1.53 CL:java $jvm_args -jar MarkDuplicates.jar INPUT=$bam_file OUTPUT=$markdup_bam_file ASSUME_SORTED=TRUE METRICS_FILE=/dev/null VALIDATION_STRINGENCY=SILENT +@PG ID:bam_mark_duplicates.20 PN:picard PP:bam_merge.20 VN:1.53 CL:java $jvm_args -jar MarkDuplicates.jar INPUT=$bam_file OUTPUT=$markdup_bam_file ASSUME_SORTED=TRUE METRICS_FILE=/dev/null VALIDATION_STRINGENCY=SILENT +@PG ID:bam_mark_duplicates.21 PN:picard PP:bam_merge.21 VN:1.53 CL:java $jvm_args -jar MarkDuplicates.jar INPUT=$bam_file OUTPUT=$markdup_bam_file ASSUME_SORTED=TRUE METRICS_FILE=/dev/null VALIDATION_STRINGENCY=SILENT +@PG ID:bam_mark_duplicates.22 PN:picard PP:bam_merge.22 VN:1.53 CL:java $jvm_args -jar MarkDuplicates.jar INPUT=$bam_file OUTPUT=$markdup_bam_file ASSUME_SORTED=TRUE METRICS_FILE=/dev/null VALIDATION_STRINGENCY=SILENT +@PG ID:bam_mark_duplicates.23 PN:picard PP:bam_merge.23 VN:1.53 CL:java $jvm_args -jar MarkDuplicates.jar INPUT=$bam_file OUTPUT=$markdup_bam_file ASSUME_SORTED=TRUE METRICS_FILE=/dev/null VALIDATION_STRINGENCY=SILENT +@PG ID:bam_mark_duplicates.24 PN:picard PP:bam_merge.24 VN:1.53 CL:java $jvm_args -jar MarkDuplicates.jar INPUT=$bam_file OUTPUT=$markdup_bam_file ASSUME_SORTED=TRUE METRICS_FILE=/dev/null VALIDATION_STRINGENCY=SILENT +@PG ID:bam_mark_duplicates.25 PN:picard PP:bam_merge.25 VN:1.53 CL:java $jvm_args -jar MarkDuplicates.jar INPUT=$bam_file OUTPUT=$markdup_bam_file ASSUME_SORTED=TRUE METRICS_FILE=/dev/null VALIDATION_STRINGENCY=SILENT +@PG ID:bam_mark_duplicates.26 PN:picard PP:bam_merge.26 VN:1.53 CL:java $jvm_args -jar MarkDuplicates.jar INPUT=$bam_file OUTPUT=$markdup_bam_file ASSUME_SORTED=TRUE METRICS_FILE=/dev/null VALIDATION_STRINGENCY=SILENT +@PG ID:bam_mark_duplicates.27 PN:picard PP:bam_merge.27 VN:1.53 CL:java $jvm_args -jar MarkDuplicates.jar INPUT=$bam_file OUTPUT=$markdup_bam_file ASSUME_SORTED=TRUE METRICS_FILE=/dev/null VALIDATION_STRINGENCY=SILENT +@PG ID:bam_mark_duplicates.28 PN:picard PP:bam_merge.28 VN:1.53 CL:java $jvm_args -jar MarkDuplicates.jar INPUT=$bam_file OUTPUT=$markdup_bam_file ASSUME_SORTED=TRUE METRICS_FILE=/dev/null VALIDATION_STRINGENCY=SILENT +@PG ID:bam_mark_duplicates.29 PN:picard PP:bam_merge.29 VN:1.53 CL:java $jvm_args -jar MarkDuplicates.jar INPUT=$bam_file OUTPUT=$markdup_bam_file ASSUME_SORTED=TRUE METRICS_FILE=/dev/null VALIDATION_STRINGENCY=SILENT +@PG ID:bam_mark_duplicates.30 PN:picard PP:bam_merge.30 VN:1.53 CL:java $jvm_args -jar MarkDuplicates.jar INPUT=$bam_file OUTPUT=$markdup_bam_file ASSUME_SORTED=TRUE METRICS_FILE=/dev/null VALIDATION_STRINGENCY=SILENT +@PG ID:bam_mark_duplicates.31 PN:picard PP:bam_merge.31 VN:1.53 CL:java $jvm_args -jar MarkDuplicates.jar INPUT=$bam_file OUTPUT=$markdup_bam_file ASSUME_SORTED=TRUE METRICS_FILE=/dev/null VALIDATION_STRINGENCY=SILENT +@PG ID:bam_mark_duplicates.32 PN:picard PP:bam_merge.32 VN:1.53 CL:java $jvm_args -jar MarkDuplicates.jar INPUT=$bam_file OUTPUT=$markdup_bam_file ASSUME_SORTED=TRUE METRICS_FILE=/dev/null VALIDATION_STRINGENCY=SILENT +@PG ID:bam_mark_duplicates.33 PN:picard PP:bam_merge.33 VN:1.53 CL:java $jvm_args -jar MarkDuplicates.jar INPUT=$bam_file OUTPUT=$markdup_bam_file ASSUME_SORTED=TRUE METRICS_FILE=/dev/null VALIDATION_STRINGENCY=SILENT +@PG ID:bam_mark_duplicates.34 PN:picard PP:bam_merge.34 VN:1.53 CL:java $jvm_args -jar MarkDuplicates.jar INPUT=$bam_file OUTPUT=$markdup_bam_file ASSUME_SORTED=TRUE METRICS_FILE=/dev/null VALIDATION_STRINGENCY=SILENT +@PG ID:bam_mark_duplicates.35 PN:picard PP:bam_merge.35 VN:1.53 CL:java $jvm_args -jar MarkDuplicates.jar INPUT=$bam_file OUTPUT=$markdup_bam_file ASSUME_SORTED=TRUE METRICS_FILE=/dev/null VALIDATION_STRINGENCY=SILENT +@PG ID:bam_mark_duplicates.36 PN:picard PP:bam_merge.36 VN:1.53 CL:java $jvm_args -jar MarkDuplicates.jar INPUT=$bam_file OUTPUT=$markdup_bam_file ASSUME_SORTED=TRUE METRICS_FILE=/dev/null VALIDATION_STRINGENCY=SILENT +@PG ID:bam_mark_duplicates.37 PN:picard PP:bam_merge.37 VN:1.53 CL:java $jvm_args -jar MarkDuplicates.jar INPUT=$bam_file OUTPUT=$markdup_bam_file ASSUME_SORTED=TRUE METRICS_FILE=/dev/null VALIDATION_STRINGENCY=SILENT +@PG ID:bam_mark_duplicates.38 PN:picard PP:bam_merge.38 VN:1.53 CL:java $jvm_args -jar MarkDuplicates.jar INPUT=$bam_file OUTPUT=$markdup_bam_file ASSUME_SORTED=TRUE METRICS_FILE=/dev/null VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.39 PN:picard PP:bam_mark_duplicates VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.1.39 PN:picard PP:bam_mark_duplicates.1 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.2.39 PN:picard PP:bam_mark_duplicates.2 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.3.39 PN:picard PP:bam_mark_duplicates.3 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.4.39 PN:picard PP:bam_mark_duplicates.4 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.5.39 PN:picard PP:bam_mark_duplicates.5 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.6.39 PN:picard PP:bam_mark_duplicates.6 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.7.39 PN:picard PP:bam_mark_duplicates.7 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.8.39 PN:picard PP:bam_mark_duplicates.8 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.9.39 PN:picard PP:bam_mark_duplicates.9 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.10.39 PN:picard PP:bam_mark_duplicates.10 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.11.39 PN:picard PP:bam_mark_duplicates.11 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.12.39 PN:picard PP:bam_mark_duplicates.12 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.13.39 PN:picard PP:bam_mark_duplicates.13 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.14.39 PN:picard PP:bam_mark_duplicates.14 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.15.39 PN:picard PP:bam_mark_duplicates.15 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.16.39 PN:picard PP:bam_mark_duplicates.16 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.17.39 PN:picard PP:bam_mark_duplicates.17 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.18.39 PN:picard PP:bam_mark_duplicates.18 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.19.39 PN:picard PP:bam_mark_duplicates.19 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.20.39 PN:picard PP:bam_mark_duplicates.20 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.21.39 PN:picard PP:bam_mark_duplicates.21 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.22.39 PN:picard PP:bam_mark_duplicates.22 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.23.39 PN:picard PP:bam_mark_duplicates.23 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.24.39 PN:picard PP:bam_mark_duplicates.24 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.25.39 PN:picard PP:bam_mark_duplicates.25 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.26.39 PN:picard PP:bam_mark_duplicates.26 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.27.39 PN:picard PP:bam_mark_duplicates.27 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.28.39 PN:picard PP:bam_mark_duplicates.28 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.29.39 PN:picard PP:bam_mark_duplicates.29 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.30.39 PN:picard PP:bam_mark_duplicates.30 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.31.39 PN:picard PP:bam_mark_duplicates.31 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.32.39 PN:picard PP:bam_mark_duplicates.32 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.33.39 PN:picard PP:bam_mark_duplicates.33 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.34.39 PN:picard PP:bam_mark_duplicates.34 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.35.39 PN:picard PP:bam_mark_duplicates.35 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.36.39 PN:picard PP:bam_mark_duplicates.36 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.37.39 PN:picard PP:bam_mark_duplicates.37 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.38.39 PN:picard PP:bam_mark_duplicates.38 VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +ERR013140.3521432 99 17 1 29 22S86M = 226 313 AGAGGTCCCCAACTTCTTTGCAAAGCTTCTCACCCTGTTCCTGCATAGATAATTGCATGACAATTGCCTTGTCCCTGCTGAATGTGCTCTGGGGTCTCTGGGGTCTCA @AEDGBHIIIIIFJGIKHGHIJJJEJKHJKJKGKLLIFHKLLCJJIDEFFHKHEHHJIIIDJEEEJEIKGJIHCGKHFKFE9BBDIAJAHF4?DE@I:DD48(86D=> MD:Z:86 RG:Z:ERR013140 AM:i:29 NM:i:0 SM:i:29 MQ:i:29 XT:A:M BQ:Z:@@@@@@@@@@@@@@@@@@@@@@iidijgijijfjkkhegjkkbiihcdeegjgdggihhhcidddidhjfihgbfjgejedXaach`i`geS^cd_hYccSWGWUc\] +ERR156632.12704932 163 17 1 29 36S64M = 195 293 TGGAGAAGGGGACAAGAGGTCCCCAACTTCTTTGCAAAGCTTCTCACCCTGTTCCTGCATAGATAATTGCATGACAATTGCCTTGTCCCTGCTGAATGTG BFAFGFEIGFEFHHEIDKJGHHHJIIE=@KKGGKJGIBLLMFKMDIIHJKKHFELLLKFIHMHIHHIHLKJFCHFJIJAID=JHKFGHJIHKKCH:@HD? MD:Z:64 RG:Z:ERR156632 AM:i:29 NM:i:0 SM:i:29 MQ:i:29 XT:A:M BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@hakklejlchhgijjgedkkkjehglghgghgkjiebgeihi`hc\igjefgihgjjbgY_gc^ +ERR156632.9601178 99 17 1 29 62S38M = 279 377 CTATGACAGGGAGGTCATGTGCAGGCTGGAGAAGGGGACAAGAGGTCCCCAACTTCTTTGCAAAGCTTCTCACCCTGTTCCTGCATAGATAATTGCATGA DEEEIIHHKIJILKHLHIKEKHHMKLKKJGKKKKLKLFIHEKIKL=KLJLKIILHKMH9LJJJJLHLHJJKJJKMLKJD>MJKLEHIGHIH=FFCHF>BE MD:Z:38 RG:Z:ERR156632 AM:i:29 NM:i:0 SM:i:29 MQ:i:29 XT:A:M BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@iikgkgiijiijlkjic]lijkdghfghg\eebge]ad +ERR162872.21706338 99 17 1 29 10S90M = 246 344 CTTCTTTGCAAAGCTTCTCACCCTGTTCCTGCATAGATAATTGCATGACAATTGCCTTGTCCCTGCTGAATGTGCTCTGGGGTCTCTGGGGTCTCACCCA BHBFHDKHGHJFJIFIDFDIJHHJHHIICKKKIJIHH?JJKEKGHGJCGGEHFIHJHFK;HGIHIJGICIEDH X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243011 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@J +ERR162875.9416595 163 17 23 60 100M = 239 314 ATAGATAATTGCATGACAATTGCCTTGTCCCTGCTGAATGTGCTCTGGGGTCTCTGGGGTCTCACCCACGACCAACTCCCTGGGCCTGGCACCAGGGAGC DBDIGHGHIBKJIIKIJJGJGKKIKILIKKLJLLKKJJILIJJLMKKIJJHIKLLKJKHDELMJHFKIKDKDKIHHILFKLHBMKGLJ7KGDJHBBFFGD X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162875 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162875.23732910 163 17 25 60 100M = 299 373 AGATAATTGCATGACAATTGCCTTGTCCCTGCTGAATGTGCTCTGGGGTCTCTGGGGTCTCACCCACGACCAACTCCCTGGGCCTGGCACCAGGGAGCTT DFEEGGHGJDIHKJIIHHHLKKLHIILLKKMILLKHKMIMMLJLLKLIGJFIKMJJKEMMLHKGDIJ?CILGIIJJLKLL6KMKLM7IIGJGJF?CFEG? X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162875 AM:i:25 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@B@ +ERR162872.5127873 113 17 28 37 100M * 0 0 TAATTGCATGACAATTGCCTTGTCCCTGCTGAATGTGCTCTGGGGTCTCTGGGGTCTCACCCACGACCAACTCCCTGGGCCTGGCACCAGGGAGCTTAAC .BDEFHG?AEFGHIFCEHLGIIFJIA@LCFKAFJDJDEIBHELKIJMH8FJJKHAMG>GHGKHAKFKHHGGEL=LIJJIILCJHJGHJIHEFIFI9DBGB X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162872 AM:i:37 NM:i:0 SM:i:37 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162872.19056012 113 17 32 37 100M * 0 0 TGCATGACAATTGCCTTGTCCCTGCTGAATGTGCTCTGGGGTCTCTGGGGTCTCACCCACGACCAACTCCCTGGGCCTGGCACCAGGGAGCTTAACAAAC DFGEGFDK;HFFHJJDJHFJJKILKDMIJFDKJMIMJKM@HAMIL=KKMHHLHM8GKKECMHJLHGM=BLMJIKKJLHJJKGHKIJJ@IHJFEEGHDBGB X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162872 AM:i:37 NM:i:0 SM:i:37 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR013140.19886608 177 17 33 37 108M * 0 0 GCATGACAATTGCCTTGTCCCTGCTGAATGTGCTCTGGGGTCTCTGGGGTCTCACCCACGACCAACTCCCTGGGCCTGGCACCAGGGAGCTTAACAAACATCTGTCCA %CCD@ACF?E@DBECDF@FHGFEDHEHGABBCC>@FFD>FCGKEELCIHLGKJJGCHHJDBCIIJJIFIJJGDGHCCGGEFFCAEGD: X0:i:1 X1:i:0 MD:Z:108 RG:Z:ERR013140 AM:i:37 NM:i:0 SM:i:37 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243079.1328786 177 17 33 37 100M * 0 0 GCATGACAATTGCCTTGTCCCTGCTGAATGTGCTCTGGGGTCTCTGGGGTCTCACCCACGACCAACTCCCTGGGCCTGGCACCAGGGAGCTTAACAAACA DEDDICIGFGFIJHGFJGG?KGJCHKCHFICIKEHGFHGJDJ@ICIFEAGKBKC@CHFBKFBHFEGEDEJHHHIFJEGHHEDGHDHJHHJFCDDGCADE? X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243079 AM:i:37 NM:i:0 SM:i:37 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243027.254838 177 17 36 37 100M * 0 0 TGACAATTGCCTTGTCCCTGCTGAATGTGCTCTGGGGTCTCTGGGGTCTCACCCACGACCAACTCCCTGGGCCTGGCACCAGGGAGCTTAACAAACATCT ?B.F)9:GCFJ=CGBD0DFG0AL5;;CHIH?8/F?C65G=E0=BBFD>BD? X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR156632 AM:i:37 NM:i:0 SM:i:37 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR016352.3774900 177 17 48 37 108M * 0 0 TTTCCCTGCTGAATGTGCTCTGGGGTCTCTGGGGTCTCACCCACGACCAACTCCCTGGGCCTGGCACCAGGGAGCTTAACAAACATCTGTCCAGCGAATACCTGCATC 4&4%4-<'CH>+GD8<6<<;85562@>C:>310155<+/4568-&,)8*7=6,9;D261>CG@6?@>/H=8@HB:FEFED@<>DB?-2?@=>BA9 X0:i:1 X1:i:0 MD:Z:1G106 RG:Z:ERR016352 AM:i:37 NM:i:1 SM:i:37 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR156632.8688512 113 17 48 37 100M * 0 0 TGTCCCTGCTGAATGTGCTCTGGGGTCTCTGGGGTCTCACCCACGACCAACTCCCTGGGCCTGGCACCAGGGAGCTTAACAAACATCTGTCCAGCGAATA DCF.AGFCKCGDBJILEK@CEKGHL9:B7GM<3F<:BH=FC0KC;HM:K;DKGCHLM?IG>@GMJFECHHGCDIIBEFI:GAHBCBDCD X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR156632 AM:i:37 NM:i:0 SM:i:37 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243063.860385 113 17 58 37 100M * 0 0 GAATGTGCTCTGGGGTCTCTGGGGTCTCACCCACGACCAACTCCCTGGGCCTGGCACCAGGGAGCTTAACAAACATCTGTCCAGCGAATACCTGCATCCC AA@@FADGFKI?HCHFE@IFI:?GGJHFIIJIEBHFFKGFHIIHJ@HJHCLGIKGDHJHHIIJJIGFGEIGBGIGHJGGEGHJH@IEHEFGIFHIEBB>A X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243063 AM:i:37 NM:i:0 SM:i:37 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A +ERR162872.19371403 99 17 64 60 100M = 413 448 GCTCTGGGGTCTCTGGGGTCTCACCCACGACCAACTCCCTGGGCCTGGCACCAGGGAGCTTAACAAACATCTGTCCAGCGAATACCTGCATCCCTAGAAG BDGFHHEEGFIIHKJIIJDJKKHIKKIJEIIJIIIKLKLMKKILLLKJKIJLJMLLIMKKEHEGJFJKGKLLMJKJIMLCJIHFKJKIJEDKEGIEHD?F X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162872 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@B +ERR162872.10929052 163 17 69 60 100M = 429 459 GGGGTCTCTGGGGTCTCACCCACGACCAACTCCCTGGGCCTGGCACCAGGGAGCTTAACAAACATCTGTCCAGCGAATACCTGCATCCCTAGAAGTGAAG E>EFFIJJKKIIJIHKKIJNLIIDKIHEKJLLMLLLKKJKJLJKGJNJIJKKMLIIIKGIKKKKHMKLHMKILLAJJJIKLJLLGILLJKJFDHDEGFD1 X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162872 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:F@CA@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162875.10099033 163 17 87 60 100M = 384 396 CCCACGACCAACTCCCTGGGCCTGGCACCAGGGAGCTTAACAAACATCTGTCCAGCGAATACCTGCATCCCTAGAAGTGAAGCCACCGCCCAAAGACACG D?DEGBHHIIIJKGHKKIGJKLJIBLJIGIFGJHGLEECAJIJCFJIKLGHI@KCFEJCJJJ3IJLGJKJLLIHHEGGJD?H4EHIADJE>D>7FCF@8* X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162875 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:C@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243007.753594 99 17 95 60 100M = 555 559 CAACTCCCTGGGCCTGGCACCAGGGAGCTTAACAAACATCTGTCCAGCGAATACCTGCATCCCTAGAAGTGAAGCCACCGCCCAAAGACACGCCCATGTC ?ECDFG9FGH8EIGFHAIEHFHJFGG@JF?DGGEDEGGEKHIAJGFJI@GGFEGIEHEFHJHGEDHHHE@>@EK>HFHC@JFFDI3CEHHGAGEEECF@B X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243007 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@D +ERR013140.20277196 163 17 97 29 34M74S = 339 349 ACTCCCCCGGCCCGGGGCCCGGGGGCTTTACAAAAAACTGTCCAGCGCATACCCGCATCCCCCCAAAAGAAGCCACCGCCCCAACACACACCCCCCACCCGCATAACC 824475'$-2)*#(/#%(/#(/-%-%-/%0/88800($,+3(*+..,%%+6%*#%2,/001)%%$2%%/$.%$00(,%+,1'*.%7(%&$&#'$$$#%#%#($+%+)" XC:i:35 MD:Z:6T0G4T2C0A2A3A4A5 RG:Z:ERR013140 AM:i:29 NM:i:8 SM:i:29 MQ:i:29 XT:A:M BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR013140.19887184 113 17 99 37 40S68M * 0 0 GTGTGTGTCGGGGGTGTCTGGGGTCTCACCCACGACCAACTCCCTGGGCCTGGCACCAGGGAGCTTAACAAACATCTGTCCAGCGAATACCTGCATCCCTAGAAGTGA %$($&$*+#%%#1'$$%2-'0&3*/$/$-73/69:7=1%2135??3C<6;:9@<46@G@EBB=FEBF<@95 X0:i:1 X1:i:0 MD:Z:108 RG:Z:ERR013140 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@A@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR013140.4461044 113 17 114 37 17S91M * 0 0 ACTCCCTGGGCCTGGCACCAGGGAGCTTAACAAACATCTGTCCAGCGAATCCCTGCATCCCTAGAAGTGAAGCCACCGCCCAAAGACACGCCCATGTCCAGCTTAACC /=1:/=44-348<0(910@955>D;??@=>>=<@DE?IIIHFJFJHGIHGHECCB@ X0:i:1 X1:i:0 XC:i:91 MD:Z:33A57 RG:Z:ERR013140 AM:i:37 NM:i:1 SM:i:37 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR245034.1618692 163 17 124 60 100M = 510 485 TAACAAACATCTGTCCAGCGAATACCTGCATCCCTAGAAGTGAAGCCACCGCCCAAAGACACGCCCATGTCCAGCTTAACCTGCATCCCTAGAAGTGAAG >ABDECDGFEHGHFHFFJF@GGGDGHHGJGFJHHHDKH@I@JGEGHGGJHBGHGHGCLGIHH@IGIFGKGHIAJIHHGEGHHIJFHIHHHEIECFCFBCE X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR245034 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@G +ERR245038.421367 177 17 131 37 100M * 0 0 CATCTGTCCAGCGAATACCTGCATCCCTAGAAGTGAAGCCACCGCCCAAAGACACGCCCATGTCCAGCTTAACCTGCATCCCTAGAAGTGAAGGCACCGC A>7EBHBFIGE>JEJFC/KFCKGEHGKFIJ@IEHD=JJJJCGACHEJGEHDFFFBGFFJHEGFIIKILHFFHHKGKJGFHHJEFJEHIGGEIGIIEE?C@ X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR245038 AM:i:37 NM:i:0 SM:i:37 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@B +ERR156632.396790 177 17 133 37 100M * 0 0 TCTGTCCAGCGAATACCTGCATCCCTAGAAGTGAAGCCACCGCCCAAAGACACGCCCATGTCCAGCTTAACCTGCATCCCTAGAAGTGAAGGCACCGCCC >FDAGAHKICK>IBHJMJD?IFKILGEKAEJKLE:LKLGGCL1@KHGHKDMGCIKII@DH:KKHGLFIGCFLIJIHHGKJGJJHHHHJEIHGIFB@FA@B X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR156632 AM:i:37 NM:i:0 SM:i:37 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@B +ERR243011.687269 177 17 133 37 100M * 0 0 TCTGTCCAGCGAATACCTGCATCCCTAGAAGTGAAGCCACCGCCCAAAGACACGCCCATGTCCAGCTTAACCTGCATCCCTAGAAGTGAAGGCACCGCCC ,G0I=C718G?2IB91/1FACI1?319I=IHADEF@DI5GBH5DJFHF=7;9G@G2DB5F?K2C;F.7G>7GCF9H=B<'GF?:BA1* X0:i:1 X1:i:0 MD:Z:71G28 RG:Z:ERR242939 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243083.1184095 177 17 168 37 100M * 0 0 GCCACCGCCCAAAGACACGCCCATGTCCAGCTTAACCTGCATCCCTAGAAGTGAAGGCACCGCCCAAAGACACGCCCATGTCCAGCTTATTCTGCCCAGT CFG1F@CBDD>9HICI:@F=HIHIGDHPJBDFFG@IFEHKBDIJICJIELH?DEFHEHCGA8:@GBIJELIJ@HLE:LHKHEL:FDLKHE8IJGHJHDDLJLJIKFJLLLLJIHLGMHJJLLKJBJ8MIK>GLKK6HLKHJG7IEHIG@FCD X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR156632 AM:i:29 NM:i:0 SM:i:29 MQ:i:29 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR156632.15310883 163 17 201 60 100M = 519 417 AACCTGCATCCCTAGAAGTGAAGGCACCGCCCAAAGACACGCCCATGTCCAGCTTATTCTGCCCAGTTCCTCTCCAGAAAGGCTGCATGGTTGACACACA BCDFGHGFFGIIJGKHFKGKIILIJIIKCHLHJIILIJIJENHMGHLGJKILLKHIHHLKJMKKJHIHLKLJKJMJHBFJMFLLKJIIKAHHFFGGFFDB X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR156632 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR245053.675620 163 17 213 60 90M1I9M = 408 294 TAGAAGTGAAGGCACCGCCCAAAGACACGCCCATGTCCAGCTTATTCTGCCCAGTTCCTCTCCAGAAAGGCTGCATGGTTGACACACAGTAGCCTGCGAC ?AHDDHEHEGJEIGGH@HHHGHGIFHGHBIIIHGHEIHHJJHGFFFGJLJGIEIFEKFJKHIHGKHEHHG=JJJGGJKFEJBHFJGGFICEHGCGGE=C8 X0:i:1 X1:i:0 MD:Z:99 RG:Z:ERR245053 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR013140.3521432 147 17 226 29 19S89M = 1 -313 CACCCCTAGAAGTGACGGCCCCGCCCAAAGACACGCCCATGTCCAGCTTATTCTGCCCAGTTCCTCTCCAGAAAGGCTGCATGGTTGACACACAGTGCCTGCGACAAA 71%??A9A792/7-2%(&:$::+BC@<=E>=EFCFHILHEDJNKHLFJFGGIMGGMMGKBKFMLELFMJJDEEJFJLIJIHIJFJHIHIFHEHIEGHJIFBGEJEFJIJGIDCFHICEEGDCA? X0:i:1 X1:i:0 MD:Z:99 RG:Z:ERR242975 AM:i:37 NM:i:1 SM:i:37 XT:A:U BQ:Z:@@A@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR242943.1259162 163 17 236 60 67M1I32M = 565 428 GACACGCCCATGTCCAGCTTATTCTGCCCAGTTCCTCTCCAGAAAGGCTGCATGGTTGACACACAGTAGCCTGCGACAAAGCTGAATGCTATCATTTAAA ED?HCII?>H76E;=CDG=FJHDEDIAE?AB9@ X0:i:1 X1:i:0 MD:Z:99 RG:Z:ERR242943 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@D@G +ERR245049.65948 113 17 237 37 66M1I33M * 0 0 ACACGCCCATGTCCAGCTTATTCTGCCCAGTTCCTCTCCAGAAAGGCTGCATGGTTGACACACAGTAGCCTGCGACAAAGCTGAATGCTATCATTTAAAA ?F@>HAHHFDBGGIGAIDCGFHJFKBDHHIHAMKGEGGDHIEEEHGJHJJHEHHGFJEJFHAGHJ@HIJJFIAJEJEEGJHHIEFGHHDFEIFCEBBA@? X0:i:1 X1:i:0 MD:Z:99 RG:Z:ERR245049 AM:i:37 NM:i:1 SM:i:37 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@DFFG +ERR162875.9416595 83 17 239 60 64M1I35M = 23 -314 ACGCCCATGTCCAGCTTATTCTGCCCAGTTCCTCTCCAGAAAGGCTGCATGGTTGACACACAGTAGCCTGCGACAAAGCTGAATGCTATCATTTAAAAAC 0?FGAHFHI?IKEHLFCK?DLH/?EBLIJEHKIMFKJLLHDFLJGJGLGHLFGKCHLILHIHJGHKBKJJCKGHHGGKJHJDEHIKGGGIFDEEDDCCFB X0:i:1 X1:i:0 MD:Z:99 RG:Z:ERR162875 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162872.21706338 147 17 246 29 100M = 1 -344 TGTCCAGCTTATTCTGCCCAGTTCCTCTCCAGAAAGGCTGCATGGTTGACACACAGTGCCTGCGACAAAGCTGAATGCTATCATTTAAAAACTCCTTGCT BB7EHGIKJJIJGFIIKFMKGIKKIILJBLKLEJ9IMMKKKJFLJGKKIHDLGMLHIMKMILEJILDGLLMKHIIKMMIJHLIDHJH>GHHKHIJFGEEB X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162872 AM:i:29 NM:i:0 SM:i:29 MQ:i:29 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243047.1018873 99 17 254 60 49M1I50M = 653 498 TTATTCTGCCCAGTTCCTCTCCAGAAAGGCTGCATGGTTGACACACAGTAGCCTGCGACAAAGCTGAATGCTATCATTTAAAAACTCCTTGCTGGTTTGA @=CDDGGGI@HGJEEIJGIIJGEJFHHKIKHJJGGKBDEGDJEHGIFHEFKGHIHKCGCDFFFLJGGHHIKGF@HEGFBEDFHC=DJFCEHFFHECBC:/ X0:i:1 X1:i:0 MD:Z:99 RG:Z:ERR243047 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243055.2002258 1187 17 254 29 49M1I50M = 653 496 TTATTCTGCCCAGTTCCTCTCCAGAAAGGCTGCATGGTTGACACACAGTAGCCTGCGACAAAGCTGAATGCTATCATTTAAAAACTCCTTGCTGGTTTGA A>A?DDH:HD>CGDBCE>65H9BGIK>JKFH<92.>J.;95FE3353+8839?/4H/.9CAE/ X0:i:1 X1:i:0 MD:Z:99 RG:Z:ERR243055 AM:i:29 NM:i:1 SM:i:29 MQ:i:29 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@G@C@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR245032.1218650 163 17 255 60 48M1I51M = 543 387 TATTCTGCCCAGTTCCTCTCCAGAAAGGCTGCATGGTTGACACACAGTAGCCTGCGACAAAGCTGAATGCTATCATTTAAAAACTCCTTGCTGGTTTGAG ?ACAFFGGFFFJDFJHHJIJIHKGGHKHHIJHHHJ7FFHGHFJHIGLEDIJIIIKBGIHGHIIJLGIFLJJEDKH@FBDHHHHJIJIHEKGHHIEACICE X0:i:1 X1:i:0 MD:Z:99 RG:Z:ERR245032 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@C +ERR243071.874302 177 17 262 37 100M * 0 0 CCCAGTTCCTCTCCAGAAAGGCTGCATGGTTGACACACAGTGCCTGCGACAAAGCTGAATGCTATCATTTAAAAACTCCTTGCTGGTTTGAGAGGCAGAA @EEIGGEEIEIGCJGJFEIFJIICKHGLG?GJ3JEIFEGDCB X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR156632 AM:i:29 NM:i:0 SM:i:29 MQ:i:29 XT:A:U BQ:Z:@I@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162872.6409758 163 17 293 60 100M = 651 457 GACACACAGTGCCTGCGACAAAGCTGAATGCTATCATTTAAAAACTCCTTGCTGGTTTGAGAGGCAGAAAATGATATCTCATAGTTGCTTTACTTTGCAT ECFGFHHHKFJJKLKJBIIKJCHKILFM>HHNKJF??IIHKHHLJNIEHHJJMFJILBIHHIEHIHMJJLJHEMCJIJJHLLIGJKLJLHHHJFKIIJILIHIHLJFHEKIHH?JGGGHIFEGCBCCA X0:i:1 X1:i:0 MD:Z:0C0A0G0T52G43 RG:Z:ERR162875 AM:i:25 NM:i:5 SM:i:25 MQ:i:60 XT:A:U BQ:Z:d^de@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@C +ERR162875.15521446 83 17 314 60 100M = 41 -372 AGCTGAATGCTATCATTTAAAAACTCCTTGCTGGTTTGAGAGGCAGAAAATGATATCTCATAGTTGCTTTACTTTGCATATTTTAAAATTGTGACTTTCA EEEEGEFHLKHCJLDIDHHBIGHMJDMIGJLIJJJAELMLKKLMMKIGHGFKHHJGMJLHIKJIJLLDIHHLHIIGLIIIHEHGGGFEGGGFHIHDDEGB X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162875 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162872.24509474 99 17 325 60 100M = 581 355 ATCATTTAAAAACTCCTTGCTGGTTTGAGAGGCAGAAAATGATATCTCATAGTTGCTTTACTTTGCATATTTTAAAATTGTGACTTTCATGGCATAAATA BDEEFDEEFGGFHKKJKGKKKKIGHHKJMJLBKJLJJHJHKHIJIKMLJJIMIIHJKIHHIMHIJMJIGJGHBHJHIJFLIKHJLFDKIJKIIFCCDBEB X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162872 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@D +ERR162875.16695705 163 17 332 60 100M = 647 414 AAAAACTCCTTGCTGGTTTGAGAGGCAGAAAATGATATCTCATAGTTGCTTTACTTTGCATATTTTAAAATTGTGACTTTCATGGCATAAATAATACTGG 79@(D+JGDCD7@KI&%=/HGC/BBA9<7>JH:1HI9=FFJI:;0,6H5D)A6IHH29EBAAB@DC( X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162875 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR013140.20277196 83 17 339 29 108M = 97 -349 CCTTGCTGGTTTGAGAGGCAGAAAATGATATCTCATAGTTGCTTTACTTTGCATATTTTAAAATTGTGACTTTCATGGCATAAATAATACTGGTTTATTACAGAAGCA 4AB@(8G1B?AFFFHJ>HGJJHH@HJHIGIHNIHHHLHKLHJKJIIJLKKGJHIHKKJIIIIHKKHKKIIKKLIGKKJIGHHHGHHGHHHJJFIIGFIFFGIHFFDA@ X0:i:1 X1:i:0 MD:Z:108 RG:Z:ERR013140 AM:i:29 NM:i:0 SM:i:29 MQ:i:29 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR013140.8214205 99 17 346 60 108M = 676 437 GGTTTGAGAGGCAGAAAATGATATCTCATAGTTGCTTTACTTTGCATATTTTAAAATTGTGACTTTCATGGCATAAATAATACTGGTTTATTACAGAAGCACTAGAAA @BCCFGIGIGHHIHJIJJGHKGHGJKJKGHIHHIJLIHHGLIIIJLHIHIIIIKFKIIIIJLHLIIKKHIKKKHILKHHJHHGKLMJHGGHEGDIGIHFEHCHDDFCB X0:i:1 X1:i:0 MD:Z:108 RG:Z:ERR013140 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@HHH +ERR243007.996298 1187 17 357 60 100M = 683 425 CAGAAAATGATATCTCATAGTTGCTTTACTTTGCATATTTTAAAATTGTGACTTTCATGGCATAAATAATACTGGTTTATTACAGAAGCACTAGAAAATG BDGEEFFFIFGEHKIKFHEKHEJIIAFFJIHDJIGFDHAFFEHHIIHJHJHHJDFIFFJIHHHFHHEEGJEJHIHGGDEHFFHHKHIKHHHIFIEGE?DD X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243007 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243027.1412318 163 17 357 60 100M = 683 425 CAGAAAATGATATCTCATAGTTGCTTTACTTTGCATATTTTAAAATTGTGACTTTCATGGCATAAATAATACTGGTTTATTACAGAAGCACTAGAAAATG ADGEFFGFJHHEGJIIHGEJFEIIJEFDIIEGIIIGEGEFEEJHGHFJFJFHHFEKHHIFJHGGEJGDIIFHIMHGGFEGIFHHKIHMJGJFFGDFDEBD X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243027 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162875.23475567 163 17 362 60 100M = 503 240 AATGATATCTCATAGTTGCTTTACTTTGCATATTTTAAAATTGTGACTTTCATGGCATAAATAATACTGGTTTATTACAGAAGCACTAGAAAATGCATGT B?DHGBAHGGDGCHGFEIIEIEIFLGH=7G:DACIIJJ>AJGBBAAD5JA8E=F(CEBDFBB>CEDGDGEC1CDB=DAFCFEFHJACEFFF>@ACCACG=BCDBBBC@9 X0:i:1 X1:i:0 MD:Z:108 RG:Z:ERR013140 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR013140.11659627 163 17 375 60 108M = 645 360 AGTTGCTTTACTTTGCATATTTTAAAATTGTGACTTTTATGGCATAAATAATACTGGTTTATTACAGAAGCACTAGAAAATGCATGTGGACAAAAGTTGGGATTAGGA :FD@CDEABEEHCCHIHGGGDDDGJJJHEIGIJGJEE/HIJMKJIIKKIILIIHKKMGFEJJFIHKMLLMLKHHINKLLLIHKJGKGJFFAJCH1GFBFBHGD>BDB; X0:i:1 X1:i:0 MD:Z:37C70 RG:Z:ERR013140 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR013140.7259970 163 17 378 60 108M = 660 377 TGCTTTACTTTGCATATTTTAAAATTGTGACTTTCATGGCATAAATAATACTGGTTTATTACAGAAGCACTAGAAAATGCATGTGGACAAAAGTTGGGATTAGGAGAG :DEE??CCGBCGHGGFGDDDGJJJHEIHIJGJEEIIIJLKJIHKKIIKIIHKKMDGFIJFJIJMKJMLJHJJMKHJLJHKKGJGIIIGJGDDGF>JFDHE?BCECEEE X0:i:1 X1:i:0 MD:Z:108 RG:Z:ERR013140 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ABE +ERR162875.10099033 83 17 384 60 100M = 87 -396 ACTTTGCATATTTTAAAATTGTGACTTTCATGGCATAAATAATACTGGTTTATTACAGAAGCACTAGAAAATGCATGTGGACAAAAGTTGGGATTAGGAG 6BD0@6?BH;6BCHFE>6JJHHAEMJBALKIM18KBCHJB?IFIMJLBDKIHBFDGGEFJIIDIJHKFHAIJKKBHFJJGCHHFF>HGCDEEGED>DFGB X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162875 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A@ +ERR156632.5355545 99 17 398 60 100M = 640 341 AAAATTGTGACTTTCATGGCATAAATAATACTGGTTTATTACAGAAGCACTAGAAAATGCATGTGGACAAAAGTTGGGATTAGGAGAGAGAAATGAAGAC C@C=FFJGGHHKGGLGHIJKJIHDJIIHIJJLNLHHHDFHIJDMFJLGMILHKGJKHILIJGJHLFJJJIJHLGIMMIHGGHLIKKHNJMIGFHIGEFBA X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR156632 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:D@A@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162872.15901000 83 17 399 60 100M = 175 -323 AAATTGTGACTTTCATGGCATAAATAATACTGGTTTATTACAGAAGCACTAGAAAATGCATGTGGACAAAAGTTGGGATTAGGAGAGAGAAATGAAGACA CBD7GGIKHKHH@KJJLJHJHFHJHHKJHMKLKJHJHIJIMLMHKLLLNGJKJIHJJKLIHKJLKHMGIILIIIIKLIIIKHJJJJJJHFEGFGDHFFGB X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162872 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:HGF@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR245053.675620 83 17 408 60 100M = 213 -294 CTTTCATGGCATAAATAATACTGGTTTATTACAGAAGCACTAGAAAATGCATGTGGACAAAAGTTGGGATTAGGAGAGAGAAATGAAGACATATGTCCAC FCEDHFEGGJGEEGEGFIFBKHFJIIGICEDJKKFHKKGLBJKGFDGEJKGHHGIKEHFEFGH:HIHKEGEIJKJJJJIJFEHGJGHIFIGEFGGECGCA X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR245053 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:A@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162875.15069550 99 17 412 60 100M = 742 429 CATGGCATAAATAATACTGGTTTATTACAGAAGCACTAGAAAATGCATGTGGACAAAAGTTGGGATTAGGAGAGAGAAATGAAGACATATGTCCACACAA AEEGDEFFAFCEEDH5HGHHDG>HIG7IJBCDBC?HI>F<@GJFAED@MGJILIHHII?JKHKHJGGGFGEJFGGGIGDEFGHB X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162872 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162872.7627281 99 17 434 60 100M = 618 283 TATTACAGAAGCACTAGAAAATGCATGTGGACAAAAGTTGGGATTAGGAGAGAGAAATGAAGACATATGTCCACACAAAAACCTGTTCATTGCAGCTTTC BCCDDEFIGGJIGIJHIFIIBGKGIGKILIIHIGJJMHIKIKIHHIMGJLJKCMGDIJLIIMIKGKIJJIMBIKJIJIHIIJILKKHK@IDGIGIGH?=D X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162872 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR013140.15927236 99 17 441 60 108M = 653 319 GAAGCACTAGAAAATGCATGTGGACAAAAGTTGGGATTAGGAGAGAGAAATGAAGACATATGTCCACACAAAAACCTGTTCATTGCAGCTTTCTACCATCACCAAAAA @CEDGIEJFGIIIIFHIJGHHHIKGGGGJIHHIJJLHHHIJKJLJLJLJKIJLKJLHLIIIJJKJLHKHKIHGJEGJJGFJLIEIKKFFJFGFIGC;HHEHACF@BB= X0:i:1 X1:i:0 MD:Z:108 RG:Z:ERR013140 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A@AC@ +ERR162872.257723 163 17 452 60 100M = 628 275 AAATGCATGTGGACAAAAGTTGGGATTAGGAGAGAGAAATGAAGACATATGTCCACACAAAAACCTGTTCATTGCAGCTTTCTACCATCACCAAAAATTG DAEFIIFGKHKIIJJIEGMJILKKIFIHNCJLHMJMHHJILJILJJHIEJKHMKJJILJIEEEEKLFIFKJGIMKJLLLIIKLJJKDFLEIJHC>FEEC> X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162872 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:IFG@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR242971.1689116 163 17 452 60 99M1S = 861 508 AAATGCATGTGGACAAAAGTTGGGATTAGGAGAGAGAAATGAAGACATATGTCCACACAAAAACCTGTTCAGTGCAGCTTTCTACCATCACCAAAACTTC :>9A>6CGE::3ADE?G>ECBHGA12.AKC;I;?C>;D6;+F8JFBH.C<=2F@H.AF)G7H@,*9I;$9000F>9;3;4)D@E8(?8?:EDD?;B*C%/ X0:i:1 X1:i:0 XC:i:99 MD:Z:71T24A2 RG:Z:ERR242971 AM:i:37 NM:i:2 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@C@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@PNLT@W@@ +ERR156632.4899095 99 17 457 60 100M = 835 477 CATGTGGACAAAAGTTGGGATTAGGAGAGAGAAATGAAGACATATGTCCACACAAAAACCTGTTCATTGCAGCTTTCTACCATCACCAAAAATTGCAAAC DEDGFJIHHGIIILEGJJJJHHHLKILHLGLGIJHHJILJJJGJJKHLJKKIJJKIHJKMMMHILJIELLIOLLFIKLFJLGHLJJKJHJFGFDIHFCD= X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR156632 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR242943.1830749 163 17 457 60 100M = 890 532 CATGTGGACAAAAGTTGGGATTAGGAGAGAGAAATGAAGACATATGTCCACACAAAAACCTGTTCATTGCAGCTTTCTACCATCACCAAAAATTGCAAAC ABCBGIFCFFFHHJEDIGGBFDELIBF>J0IGGHGJFI==GCCABKBKHIGHLG?H?BH@HJ;?JGH;IIGLJIGDJI>HFIAEHEGEFEFGF>EFCDC< X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR242943 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR013140.29762488 163 17 466 60 108M = 716 350 AAAAGTTGGGATTAGGAGAGAGAAATGAAGACATATGTCCACACAAAAACCTGTTCATTGCAGCTTTCTACCATCACCAAAAATTGCAAACAACCACACGCCCTTCAA 9@>:?A=BAA??7@AGBABCCBD?H@?EA@B;EDADEEABEFG:GAB>>::?>><@@HDDCIEGD:A)BD<>C< X0:i:1 X1:i:0 MD:Z:108 RG:Z:ERR013140 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR242979.1294369 163 17 468 60 100M = 781 412 AAGTTGGGATTAGGAGAGAGAAATGAAGACATATGTCCACACAAAAACCTGTTCATTGCAGCTTTCTACCATCACCAAAAATTGCAAACAACCACACGCC ?AGDCGFGEDCBIGFIFJGJEHCGIGCHFFDEADIEGHHGFJHGGGGGJJHFFJGGAJHHKJJEGKCBGIHHKGHJFBIEEEFGJGHFIFFHFCFE6EG9GGICC@;HHILIHIICFEKJ<9JI9I<3J7I=EKBDF?A2FHIK2BFFJJD(J5E@F697?@ X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162872 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@AE +ERR243011.373069 83 17 483 60 100M = 18 -564 GAGAGAAATGAAGACATATGTCCACACAAAAACCTGTTCATTGCAGCTTTCTACCATCACCAAAAATTGCAAACAACCACACGCCCTTCAACTGGGGAAC <8BFHA>DFDHIC:H;D?BHHGDAH:JAH>FDHHEHHFJGHIIIAJJGFGMCB;JFGI2HHFFFAECG9H9ECIEEEHEJBAIEGJDEIDEIFFCBEAB? X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243011 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@BB@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162872.18011293 163 17 488 60 100M = 748 359 AAATGAAGACATATGTCCACACAAAAACCTGTTCATTGCAGCTTTCTACCATCACCAAAAATTGCAAACAACCACACGCCCTTCAACTGGGGAACTCATC EAEFIHHKHIIHIIKHKLJJKJJJIJJKHLLHILJIIMLIMKMGILNJJKJJMIKMIHKIHJILLJKGJJJJKJJJIEKLLMHLGAJKLEJEHHHHGFDA X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162872 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:D@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162872.8507187 99 17 498 60 100M = 764 365 ATATGTCCACACAAATACCTGTTCATTGCAGCTTTCTACCATCACCAAAAATTGCAAACAACCACACGCCCTTCAACTGGGGCAGTCATCAACAACAAGC B>8C1E0+B,;BG5<-+);K0EI@AI,(HEI2C2+J+F<)9KL1DDHG-=#2F1G)E:9HA?DICAGDE)B X0:i:1 X1:i:0 MD:Z:15A66A1C13A1 RG:Z:ERR162872 AM:i:37 NM:i:4 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162875.23475567 83 17 503 60 100M = 362 -240 TCCACACAACATCCTGTTCATTGCAGCTTTCTGCCATCACCAAAAAGTGCAAACAACCACACGCCCTTCAACTGGGGAACTCATCAACAACAAACTTGTG C.=7?7F7C.A1<83K9D299HH?@CM12C=B6>DDEECA X0:i:1 X1:i:0 MD:Z:9A1A20A13T53 RG:Z:ERR162875 AM:i:37 NM:i:4 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@C +ERR162875.21460873 99 17 505 60 100M = 796 390 CACACAAAAACCTGTTCATTGCAGCTTTCTACCATCACCAAAAATTGCAAACAACCACACGACCTTCAACTGGGGAACTCATCAACAACAAACTTGTGGT 5E;:AD>BEF-7IJEF;6HBE3,IJGAG/J7I)GDKHF7B2;J;H2DICH1BBE(?>*4BB*@>L2>HG,,G*2:/87+8@21''.FDJ/AH;=*-C+6B*B70=IFD=D>E759'85?5<) X0:i:1 X1:i:0 MD:Z:99A0 RG:Z:ERR245028 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR245045.954816 163 17 517 60 100M = 913 495 TGTTCATTGCAGCTTTCTACCATCACCAAAAATTGCAAACAACCACACGCCCTTCAACTGGGGAACTCATCAACAACAAACTTGTGGTTTACCCACACAA >FDAFFCCGHGJGJEFIHEHHHGIFGIEHHHFGCILHHGJGGHIEGIDAHHIIEJFGGIKIJIFEHGFFGKGGEHIHH?FKHDEFHIFGCDGEHFFEEEC X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR245045 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A +ERR162872.2317332 163 17 518 60 100M = 701 282 GTTCATTGCAGCTTTCTACCATCACCAAAAATTGCAAACAACCACACGCCCTTCAACTGGGGAACTCATCAACAACAAACTTGTGGTTTACCCACACAAT DDCDGGGJJILJKHHJLGIKHJKJILKJJJJJGILJJJJIGJKJHJHDLKLJHLJCJKKIIKFKJLJHHKKJGJIGIHIKLHLFJJIHEDGBJGHFEFBB X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162872 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR245038.1576181 99 17 519 60 100M = 949 529 TTCATTGCAGCTTTCTACCATCACCAAAAATTGCAAACAACCACACGCCCTTCAACTGGGGAACTCATCAACAACAAACTTGTGGTTTACCCACACAATG ?@ECECHHFJHHFEIHDIHFFJGIGGGGGGGFGHGHGHEHJJGGFIAIHFKFLHHJIJCHFG7IJKGGJGGIHIHHH@EGDKEGG;ADFHEGDEEEDDCF X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR245038 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@H +ERR156632.15310883 83 17 519 60 100M = 201 -417 TTCATTGCAGCTTTCTACCATCACCAAAAATTGCAAACAACCACACGCCCTTCAACTGGGGAACTCATCAACAACAAACTTGTGGTTTACCCACACAATG BGFEFHHIJKMAJJLJIJLIJIGJLGHHIIHJLJDHILHHKJHMGEILJMKIKFHMJ=LLLGFLJMIIHHHKHHLHHHIJJHJJJJGHGIIJGIFIEDCD X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR156632 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@B@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@F +ERR245032.1218650 83 17 543 60 100M = 255 -387 CAAAAATTGCAAACAACCACACGCCCTTCAACTGGGGAACTCATCAACAACAAACTTGTGGTTTACCCACACAATGGAAGACCACTTAGCAACAAAAAGG EDBCBEFFKKFGFIFEGJEJFBLIILGIHDEJHIIHJFGLGJHIJGFLGFJEFFLFIKHEHIGFFGIKEJEJEHGGIEIKDGJFLIEIJIDFIDDEDFBA X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR245032 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243007.753594 147 17 555 60 100M = 95 -559 ACAACCACACGCCCTTCAACTGGGGAACTCATCAACAACAAACTTGTGGTTTACCCACACAATGGAAGACCACTTAGCAACAAAAAGGACCAAACTCCTG BE;A?IEHEAIIILADGFGAHGFIKFEIIIHHLFFJFDHEDDKGEIHIDHHEHIIHEIEIGGCHIFHI?EIGLHEJIJEFJFCEFIIJEHIECEIFEGC@ X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243007 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@B +ERR242939.81544 147 17 565 60 100M = 152 -512 GCCCTTCAACTGGGGAACTCATCAACAACAAACTTGTGGTTTACCCACACAATGGAAGACCTCTTAGCAACAAAAAGGACCAAACTCCTGGTACATGCAA +./6&=F=9A-0H1)GD:@:C(AD-ID=?/>7C)>0@B@(I7/HGH?46GBE8G9C-DBIGC<@IFDE49DG.B;BJC??JEDHCCF=FDDDG9E3AIAD4IEG;FDCCDAEEEH?? X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR242943 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162872.26172147 147 17 569 60 100M = 478 -190 TTCAACTGGGGAACTCATCAACAACAAACTTGTGGTTTACCCACACAATGGAAGACCACTTAGCAACAAAAAGGACCAAACTCCTGGTACATGCAACTGA (7=C87CDG?6BAFIH8JDGBLHJBHA;JE@2>;I/AI=0=LEMEMI;KDD7;E3'=I;?B<7GHI7HEE7L4K65GHGJH/BLFDJHHIIIHJDC;EF2H+8@IHIE@%/FEKGLFI8@?CHA6JIH?IBAFF@MF20L4IDBGHBDJIIJJB%)%>G@#/IGGJIHJL?8GJAGK6GJJJJG;HHEAHGCBD X0:i:1 X1:i:0 MD:Z:15A28A16A4C0A32 RG:Z:ERR156632 AM:i:25 NM:i:5 SM:i:25 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A +ERR162872.24509474 147 17 581 60 100M = 325 -355 ACTCATCAACAACAAACTTGTGGTTTACCCACACAATGGAAGACCACTTAGCAACAAAAAGGACCAAACTCCTGGTACATGCAACTGACAGATGAATCTC DGFGCGJGHMHHKHHHMJKKEKJDJIDJKNJLIKIIKLLIKMGLMJMAJMKLHJLKGJHMKMILLHIIMJKNILJJIKJKLLHIKJLHKKKHHJFFFHCE X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162872 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR245024.739014 163 17 584 29 20M1D80M = 935 450 CATCAACAACAAACTTGTGGTTACCCACACAATGGAAAACCACCTAGCAAAAAAAAGGACCCAAATCCTGGTACATGCAACTGACAGATGAATCTCAAAC ?CCEEDGGGHFG2>H/C6J8EE<:HH080=2G03I.G,,;E0()I(0&:H,,IJDJ0J.-H)G@*./I0>I;D6;/0*/G8;09+.<-./7I9...8DD9 MD:Z:20^T17G5T6C10A2C35 RG:Z:ERR245024 AM:i:29 NM:i:6 SM:i:29 MQ:i:29 XT:A:M BQ:Z:@@@@@@@@@@@@@@@@@@I@d_@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR242959.1635151 99 17 588 60 100M = 998 509 AACAACAAACTTGTGGTTTACCCACACAATGGAAGACCACTTAGCAACAAAAAGGACCAAACTCCGGGTACATGCAACTGACAGATGAATCTCAAACGCT @?EBE@G?DHCBA>E:;FBFGD=@ECHEE=@6:72GIGEIIA;EJE8FHH5F6K6:AHGA??EK5(:D0BCEFG2IIHI9?G7E5GHAAAA8EFC3><1( X0:i:1 X1:i:0 MD:Z:65T33A0 RG:Z:ERR242959 AM:i:37 NM:i:2 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR016352.14628028 163 17 612 60 108M = 865 360 CACAATGGAAGACCACTTAGCAACAAAAAGGACCAAACTCCTGGTACATGCAACTGACAGATGAATCTCAAACGCATTCCTCCGTGTGAAAGAAGCCGGACTCACAGG ;D@DDACFDGGHCFGDIEFHGHFDHIFIJIJEEHGJJCHEHJIHBHDGHII8HFIGI9J@IFIGKFFBHAJJF>GIAE8IF=B:EE@G4F@@9:EAH@C;BF?3C<9320E-DGDJ*>EA@DF8369I1:D>D/-6F,H;H0EC?,AJG?.I)=/I%=FE/C*%%1<06F)#GECD:,< X0:i:1 X1:i:0 MD:Z:26C28T15T12A1A13 RG:Z:ERR243015 AM:i:25 NM:i:5 SM:i:25 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162872.7627281 147 17 618 60 100M = 434 -283 GGAAGACCACTTAGCAACAAAAAGGACCAAACTCCTGGTACATGCAACTGACAGATGAATCTCAAACGCATTCCTCCGTGTGAAAGAAGCCGGACTCACA HKBLLHIHFEGJFIGHHHCIKFIDJKIIDIIGIMDHKJGDAKBLGHLJKHJEHJIJ@GHFGGJFFGIFGEGFCA X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR156632 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:A@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@C +ERR013140.11659627 83 17 645 60 17S91M = 375 -360 TTAGCAACAAAAAGGACCAAACTCCTGGTACATGCAACTGACAGATGAATCTCAAACGCATTCCTCCGTGTGAAAGAAGCCGGACTCACAGGGCAACACACTATCTGA %5?-$)89<=;9>(.144==2@>BD@>DBCDFIGFFIIEBF@HDFFFFCABDC@BC;CFFLCJGEJF15E*?:E2JCB(I/2)80DBH*G;K)**)-L0HCC?IGHBGFDLCEDDFBE8@KBC?FEC9?FECFFHFH>HAFI@FEHFHEHIEDG@GBJDF;GEHEHFIFBFJFFFBGBAFC? X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243047 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243055.2002258 1107 17 653 29 98M2S = 254 -496 TGGTACATGCATCTTACAGATGAATCTCAATCGCATGCCTCCGTGTGAAAGAAGCCGGACTCACAGGGCAACACACTATCTGACTATATCATGGGAAACT A)+5C7EF18?'9C,8H-<-GD2-59+EDG,;HI9GC0K,1)5F789A3.-4.)(4<,?=,GFIHI**<*4>EF2E2CF>0.4GE0)>E@110EGCBCD? MD:Z:11A2G15A5T48G1T10 RG:Z:ERR243055 AM:i:29 NM:i:6 SM:i:29 MQ:i:29 XT:A:M BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@D@@ +ERR013140.7259970 83 17 660 60 12S96M = 378 -377 ACGCCTGGTACATGCAACTGACAGATGAATCTCAAACGCATTCCTCCGTGTGAAAGAAGCCGGACTCACAGGGCAACACACTATCTGACTGTTTCATGGGAAAGTCTG 40&/81&8:/<<79BIILCEL:JKLIKGELFHIKJJJFJFJJLEMGIJLHHGOBGLL?CIJM;KLJEHGFGAFGCDB X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR156632 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR013140.8214205 147 17 676 60 108M = 346 -437 ATCTCAAACGCATTCCTCCGTGTGAAAGAAGCCGGACTCACAGGGCAACACACTATCTGACTGTTTCATGGGAAAGTCTGGAAACGGCAACACCATTGAGACAGAAAA :;A>;:9685?>@CCECD;@D@H@EDI>CGLJCLFFMIKFKHIKKFHJKCKFMDFHMJJFLJHGKGJIJJKJEEJGJLIJIEEHAJIIDHHEKHFIGGGFEDDC@@?: X0:i:1 X1:i:0 MD:Z:108 RG:Z:ERR013140 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243007.996298 1107 17 683 60 100M = 357 -425 ACGCATTCCTCCGTGTGAAAGAAGCCGGACTCACAGGGCAACACACTATCTGACTGTTTCATGGGAAAGTCTGGAAACGGCAACACCATTGAGACAGAAA ?>CE?D@HJF:?>EIFFFGGHEIKFBIKGJHJEJIJIHJFFJEIFKEGIJGJBJGIHJGJGGIHHEEIIFIGHIEGF@IIIFEIEGHGFGIGHDGFEA@? X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243007 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@CEE +ERR243027.1412318 83 17 683 60 100M = 357 -425 ACGCATTCCTCCGTGTGAAAGAAGCCGGACTCACAGGGCAACACACTATCTGACTGTTTCATGGGAAAGTCTGGAAACGGCAACACCATTGAGACAGAAA A7?E@DEIIEJ@GGIDFFEHJGJJHCJKGMIHGKHHIIJHFIFJFJGIFHEJEJIHICDIHGGBHGFIIFIFHHFFD@IHHAFIEEIGFFHHIDHGEA@? X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243027 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@CEE +ERR013140.3773682 99 17 697 29 108M = 1064 389 GTGAAAGAAGCCGGACTCACAGGGCAACACACTATCTGACTGTTTCATGGGAAAGTCTGGAAACGGCAACACCATTGAGACAGAAAACAGGTGAGTGGTTGCCTGGGG @ACFHHGIHGCJ?HJFKJJFKFDBIHJEHCEBHHHCHEFAJDF>DFFGFDEB?ADDBEEAFD@;;DDG@8A>:CB=DDBB:CCD@>D?HA42A>?8?/%3@,(=<986 X0:i:1 X1:i:0 MD:Z:108 RG:Z:ERR013140 AM:i:29 NM:i:0 SM:i:29 MQ:i:22 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162872.2317332 83 17 701 60 100M = 518 -282 AAGAAGCCGGACTCACAGGGCAACACACTATCTGACTGTTTCATGGGAAAGTCTGGAAACGGCAACACCATTGAGACAGAAAACAGGTGAGTGGTTGCCT CGD8BHH@AGFKCKHKLIKKG>ILFLJJIGGJILJJIJJIILHIL:LIEMJIIECKGHGCJGLIHMHJKHHIFKJDJKKGHGGKKHIHIIGFGEDEF@FB X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162872 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:EI@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR013140.29762488 83 17 716 60 7S101M = 466 -350 GGACTCACAGGGCAGCACACTATCTGACTGTTTCATGGGAAAGTCTGGAAACGGCAACACCATTGAGACAGAAAACAGGTGAGTGGTTGCCTGGGGCCAGGGAACTTT )/4/1429@99+@?%BBDD<;:;=:6?84=<7<=;?7G=?869::6?8B2C;==>0:841>.,5C0?7DB4@@2@FGCBBC5AFCHGAC?BC< X0:i:1 X1:i:0 XC:i:101 MD:Z:7A93 RG:Z:ERR013140 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A@ +ERR013140.11567710 163 17 728 60 108M = 984 356 CTATCTGACTGTTTCATGGGAAAGTCTGGAAACGGCAACACCATTGAGACAGAAAACAGGTGAGTGGTTGCCTGGGGCCAGGGAACTTTCTGGGGTCATACTCTCTAT :DCCCDDFCGGGCCHHGHKKDJJKFIJIHJKJG=FJIKGJGKJIEKKLKHJMHLHGCGIH?GFFBHDD7BAF>?BHFHFD>D66>7+AECC)CB?.BAB98G<(A9DMHDJI/&F@D&/H(861<:G6..2/39681K36EH2: X0:i:1 X1:i:0 MD:Z:59T32T5G1 RG:Z:ERR162872 AM:i:37 NM:i:3 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@I@@ +ERR162875.14341769 99 17 736 60 100M = 979 342 CTGTTTCATGGGAAAGTCTGGAAACGGCAACACCATTGAGACAGAAAACAGGTGAGTGGTTGCCTGGGGCCAGGGAACTTTCTGGGGTCATACTCTCTAT BGHFCDGGEIGHGHCJGJJKGHDJFCILHIJJJKHJELJLHKIJGGKKJJLI9LHJILJHHLHKLLGLIKJGLJJ2JJH9@D?GHGEKKLHGJGIKJIKKIL;JLJH44ILGI@KHJIJKII8CKMGJBHGAKLIIJ?HLCIILGDKKHIHIEHDIKGKHFHHDFDBD X0:i:1 X1:i:0 MD:Z:86T5G7 RG:Z:ERR162875 AM:i:37 NM:i:2 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@F +ERR162875.20069376 99 17 747 60 100M = 975 327 GAAAGTCTGGAAACGGCAACACCATTGAGACAGAAAACAGGTGAGTGGTTGCCTGGGGCCAGGGAACTTTCTGGGGTCATACTCTCTATGTTGATTCTGG ADCDHGGHIHGGHHCGIHHHIIKGHGLJLIJHMIIJIJJLMILFMILLHGLKJLKNKMIKJLKJJJJMJGJLKLJJHMHJFJKJGMKFJLGHJGGEHHFC X0:i:1 X1:i:0 MD:Z:81T5G12 RG:Z:ERR162875 AM:i:37 NM:i:2 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@AB +ERR162872.18011293 83 17 748 60 100M = 488 -359 AAAGTCTGGAAACGGCAACACCATTGAGACAGAAAACAGGTGAGTGGTTGCCTGGGGCCAGGGAACTTTCTGGGGTCATACTCTCTATGTTGATTCTGGT :BDFDI?JEG77D?LLH8KFJGJFHKKLIILIGIJIKCGFILLJCKJGDEIMFMLEKILKIHKIHLJIIMFKLKJIJIGHKILIKGGHGGGHGEEGEDDB X0:i:1 X1:i:0 MD:Z:80T5G13 RG:Z:ERR162872 AM:i:37 NM:i:2 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR156632.3225464 147 17 749 60 100M = 579 -269 AAGTCTGGAAACGGCAACACCATTGAGACAGAAAACAGGTGAGTGGTTGCCTGGGGCCAGGGAACTTTCTGGGGTCATATTCTCTGTGTTGATTCTGGTG =DD1HEG%@;?7HH28GFCGLD>GDDCCECKDHGGBLAJHEHDJC63AK.BHKFHGIIHH<<7FCE=FE?BDFA X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR156632 AM:i:25 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@F@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@C +ERR243083.371418 163 17 750 60 100M = 1106 455 AGTCTGGAAACGGCAACACCATTGAGACAGAAAACAGGTGAGTGGTTGCCTGGGGCCAGGGAACTTTCTGGGGTCATATTCTCTGTGTTGATTCTGGTGG ?EEFEGCF@EG@FFIFGHD X0:i:1 X1:i:0 MD:Z:64T5G29 RG:Z:ERR162872 AM:i:37 NM:i:2 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR242979.1294369 83 17 781 60 100M = 468 -412 AAACAGGTGAGTGGTTGCCTGGGGCCAGGGAACTTTCTGGGGTCATACTCTCTATGTTGATTCTGGTGGTGGAAACAAGACTGTCCCAGCCTGGGTGATA BBFHIIJHKIHJGJFDDIFMGJEGIJGHLGHFKGGIHGIGHKEFFHGILEJGIGHCJHHFJGGGGFGCA@ X0:i:1 X1:i:0 MD:Z:47T5G46 RG:Z:ERR242979 AM:i:37 NM:i:2 SM:i:37 MQ:i:60 XT:A:U BQ:Z:GG@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162875.21460873 147 17 796 60 100M = 505 -390 TGCCTGGGACCAGGCAACTTTCTGGGGTCATACTCTCTATGTTGATTCTGGTGGTGGAAACAAGACTGTCCCAGCCTGGGTGATACAGCGAGACCCCATC E0:ID<=A,5AF/F/H0BEE3LJ&:1EA*G4<:FKAJBC8@CJHH4ICD@,EJ9F4CIHFLH=LEM;AHBJIEKIMGDHDJDGFIJK1CDGCHH/HIEA= X0:i:1 X1:i:0 MD:Z:8G5G17T5G61 RG:Z:ERR162875 AM:i:37 NM:i:4 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR013140.14588577 147 17 807 60 108M = 571 -343 AGGGAACTTTCTGGGGTCATACTCTCTATGTTGATTCTGGTGGTGGAAACAAGACTGTCCCAGCCTGGGTGATACAGCGAGACCCCATCTCTACCAAAAAATTAAAAA BCCDGIKFF?HGEFAGGGKLJFJHLLHEIGFDFHHHIIKDGGEKDKKFMHHFFMJKKMLJKKGIJIHIJJJAIJIILLKIGIKIKGDKHCCCBBDEB?@@?: X0:i:1 X1:i:0 MD:Z:21T5G80 RG:Z:ERR013140 AM:i:37 NM:i:2 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR156632.18988851 147 17 822 60 100M = 667 -254 GTCATACTCTCTATGTTGATTCTGGTGGTGGAAACAAGACTGTCCCAGCCTGGGTGATACAGCGAGACCCCATCTCTACCAAAAAATTAAAAATTAGCTG ?CD@E?GAJILHIIIJHEJJH:FKKIACJGIHHFKGLLGMIKJKHHKLJLFJKJIKDICKIKDJKKGJJKKIHFFIGEKJFGFEFGHHEFDDFEEGFGF? X0:i:1 X1:i:0 MD:Z:6T5G87 RG:Z:ERR156632 AM:i:37 NM:i:2 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A +ERR156632.4899095 147 17 835 60 100M = 457 -477 TGTTGATTCTGGTGGTGGAAACAAGACTGTCCCAGCCTGGGTGATACAGCGAGACCCCATCTCTACCAAAAAATTAAAAATTAGCTGGGCATGGTGGTGC 2@FGIB?>JIKIJK*I9BEC=:HKLHKIJHKDFJJFLJIMIFKIHHKLKDKJKHGKLLHILILHEMKHGGIGHHHGFFEHGGJKKGJJIIFGFEGFDFDA X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR156632 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162875.21635478 99 17 854 60 100M = 1075 320 AACAAGACTGTCCCAGCCTGGGTGATACAGCGAGACCCCATCTCTACCAAAAAATTAAAAATTAGCTGGGCATGGTGGTGCATGCCTGTAGTCCCAGCTA BBEECHEFIIFIIFHKIAKKGJHJEAKKKJHILLLCKIHHCIH@JFDJIDJJCIIMLHLJKJIKJIIHFLEGIKELKJHGKGIHGDHEF? X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162875 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:DD@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR242971.1689116 83 17 861 60 100M = 452 -508 CTGTCCCAGCCTGGGTGATACAGCGAGACCCCATCTCTACCAAAAAATTAAAAATTAGCTGGGCATGGTGGTGCATGCCTGTAGTCCCAGCTATTCACAG 0>?=B,..4&.9D)B=A--EG97=I;;E1&'::7/:=@-;>3+5BCGGF=HB5I6-F6GGC*+D/1EG=-.2+@/?')?0.C@>E*=A@=2?E3A@:BC> X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR242971 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162875.1140280 163 17 863 60 100M = 1156 392 GTCCCAGCCTGGGTGATACAGCGAGACCCCATCTCTACCAAAAAATTAAAAATTAGCTGGGCATGGTGGTGCATGCCTGTAGTCCCAGCTATTCACAGTG DEFHIHJIIJJIIIKHIHIJMKDIMIJKGKKHHMMKJHKJJJHIIJGHJJKGICJMLLLCELJJMKFMIIJHIIJELLLFIEGKJMJMHKDGDHFCFCBD X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162875 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR016352.14628028 83 17 865 60 108M = 612 -360 CCCAGCCTGGGTGATACAGCGAGACCCCATCTCTACCAAAAAATTAAAAATTAGCTGGGCATGGTGGTGCATGCCTGTAGTCCCAGCTATTCACAGTGCTGAGGTGGG AB?E?D@A>>=DBGBGHFB?BHCAHEH>FIIEIFHCIHGGGGJLCEGDGIIFKBG@JJIGIHICJIFHIBIJEKJJEIKFBDKJKIJHIJJIIFJEIH@IGIGBECBA X0:i:1 X1:i:0 MD:Z:108 RG:Z:ERR016352 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A +ERR242943.1830749 83 17 890 60 100M = 457 -532 CCCATCTCTACCAAAAAATTAAAAATTAGCTGGGCATGGTGGTGCATGCCTGTAGTCCCAGCTATTCACAGTGCTGAGGTGGGAAGATGCTTGAGCCCAG B=D7EG5KCF>GEGBDDAHDFEFFF7FHIKEEEJJ=HIJHII:EDEI9E>GGBHHCLFCDIFCGAEKEIHIGCIHJGGGEGHGDGEFGHG8BB/4.?'BEH9.'HHIH9LIF9@%;AH(:A-0AJ=E=7A,EIF@=;IG<0KH6@F4)H9IG-E,2:G1E;GCAFIBHAGC6FHDGHGGF=CCDE,@A? X0:i:1 X1:i:0 MD:Z:63A36 RG:Z:ERR245028 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:A@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR245045.954816 83 17 913 60 100M = 517 -495 AATTAGCTGGGCATGGTGGTGCATGCCTGTAGTCCCAGCTATTCACAGTGCTGAGGTGGGAAGATGCTTGAGCCCAGGAGTTCAAGGCTGCAATGAGCTA AD>CGHAFFIKGIFIFHGJHIJAIIHJIGDHIGGJK=JDECHGIGKJHIILHKBIJFGIJEIFH>EK)=BI>)A8FAI1F@K@9FI1A>J9CC3@@2@E8CB)GGILA>+DK0BE-@8J<:I*97CCGD70D X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162872 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@F +ERR162875.20069376 147 17 975 60 100M = 747 -327 GATGCTTGAGCCCAGGAGTTCAAGGCTGCAATGAGCTATGATTGCGCCACTGCACTTTGGCCTGGACAACAGAGCAAAACCCTGTCTCTAAAAAAAGAAA BEGHGFHLLJKFLLMKLKIJLHLLLKIKJDIJMLLMIJJLIJJLDJKMHLKKKIMKIHKLKMKMMILIGMKKKKLIFHFLJKJJILJLHGGGGFFIHDAE X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162875 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@FFK +ERR162875.14341769 147 17 979 60 100M = 736 -342 CTTGAGCCCAGGAGTTCAAGGCTGCAATGAGCTATGATTGCGCCACTGCACTTTGGCCTGGACAACAGAGCAAAACCCTGTCTCTAAAAAAAGAAAAGAA DDFHJHH>JKKKIKJJLGMKKKJIMGIIKMLLJIKJJJJLAJKIIMKMJBKJIKHKKMIDLIJJJLLLJLKGGHIJJMAJILJLHHHHGFGKIFFFIFAD X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162875 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@CI +ERR162872.20029780 1171 17 981 60 2S98M = 736 -342 CGTGAGCCGAGGAGTTCAAGGCTGCAATGAGCTATGATTGCGCCACTGCACTTTGGCCTGGACAACAGAGCAAAACCCTGTCTCTAAAAAAAGAAAAGAA %2,G.I.6,B6H8@)):=8I3>F*0AAD6B?:=86/.BG5?5=L>DG6L=<64JJ6II-;;>FI>I>EE7DD58C5CM?IDFCL@HDHGFGECFFEHD@E X0:i:1 X1:i:0 XC:i:98 MD:Z:6C91 RG:Z:ERR162872 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@A@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@BJ +ERR243015.17606 83 17 982 60 100M = 618 -463 GAGCACAGGAGTTAAAGGCTGTAATGAGCTATGATTGCGCCACTGCACTTTGGCCTGGACAACAGAGCAAACCCCTGTCTCTAAAAAAAGAAAAGAAAAG :B@:.D9EBI53,(1:E3;E?74>*3+E=>B>B*-(@1*1H/1?GE+++0+,33:0C-,=BA9: X0:i:1 X1:i:0 MD:Z:4C8C7C49A28 RG:Z:ERR243015 AM:i:25 NM:i:4 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR013140.11567710 83 17 984 60 7S101M = 728 -356 TGCTTGAGCCCAGGAGTTCAAGGCTGCAATGAGCTATGATTGCGCCACTGCACTTTGGCCTGGACAACAGAGCAAAACCCTGTCTCTAAAAAAAGAAAAGAAAAGAAA /36>+5/+ABDF7EF9=DF>D;=C@9CCEIHGHGEBHCDFDH=?BE=A@AF=AGD@F;C>FJBDEFGHFEHFCBCCAFLHH@EJGEDEHGHGGEIGGFG8CBBI?=>? X0:i:1 X1:i:0 XC:i:101 MD:Z:101 RG:Z:ERR013140 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@CF +ERR242959.1635151 147 17 998 60 100M = 588 -509 GGCTGCAATGAGCTATGATTGCGCCACTGCACTTTGGCCTGGACAACAGAGCAAAACCCTGTCTCTAAAAAAAGAAAAGAAAAGAAAAACTCACTGGATA 6*?DFC8@>7.4ED9-DH=DB9)/I1:C6HC0BG:478)I8C=GDF1B/G*-GFC8+8H>9+D?I:8F2*,:DGIHDAFCC X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR156632 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@E +ERR162872.1587020 163 17 1024 60 100M = 1273 348 CTGCACTTTGGCCTGGACAACAGAGCAAAACCCTGTCTCTAAAAAAAGAAAAGAAAAGAAAAACTCACTGGATATGAATGATACAGGTTGAGGATCCATT EEGHGHJFGKIJKLLJIJIIJIMJNLKJKJJNMKLIJMMKHJKLLIJMKIJKMKJKJOIIKKGKLLKKLMMJGJJLJHILJIJJJLKHHKKLHGGHFCDA X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162872 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR156632.9494189 163 17 1031 60 100M = 1277 345 TTGGCCTGGACAACAGAGCAAAACCCTGTCTCTAAAAAAAGAAAAGAAAAGAAAAACTCACTGGATATGAATGATACAGGTTGAGGATNCATTATCTGAA BAFDFFHIFGGFHHGHHKHIHJGHKKJKIIKKLHIIIIIHNIJGILJIHKMIJIJJJLLILJLKKJIILJJIJJIIJGMCHHLELKIF!IHGGEGFED-E X0:i:1 X1:i:0 MD:Z:88C11 RG:Z:ERR156632 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:DC@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@J +ERR242943.1490060 99 17 1031 60 100M = 1433 501 TTGGCCTGGACAACAGAGCAAAACCCTGTCTCTAAAAAAAGAAAAGAAAAGAAAAACTCACTGGATATGAATGATACAGGTTGAGGATCCATTATCTGAA ?@G@FBGH>>DAFDEI>KGFDBBB97DH?=CIGE@FDED+K@776KDDEGGFGCIF7HDG7>JDFCBE@=CGBB X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR242943 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:AB@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@DG +ERR245038.1101322 1187 17 1055 60 100M = 1338 382 CCTGTCTCTAAAAAAAGAAAAGAAAAGAAAAACTCACTGGATATGAATGATACAGGTTGAGGATCCATTATCTGAAATGCTTGGACCAGATGTTTTGAAT @AGIEGIIGEGDGGGGKGFFHJGEIGGFHHGIGIIGEHHFGHEGKGFFKGGDHHKHEEJIJJGFJHHJDEIIJJFHHGKBIFJGHFJCJAEIEEDCCCCB X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR245038 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:BC@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@D +ERR245049.1671108 163 17 1055 60 100M = 1338 382 CCTGTCTCTAAAAAAAGAAAAGAAAAGAAAAACTCACTGGATATGAATGATACAGGTTGAGGATCCATTATCTGAAATGCTTGGACCAGATGTTTTGAAT A@FHEHHIHDGGGGGHJEGHGKGHHHHGHHHHJJJGJIJJFHEHJGHFJEHFJHJHE@JGKGHGIGIHEGFHIJFHHCIJJFHGHHHGKFEHCDCDGCDB X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR245049 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:CB@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@D +ERR013140.3773682 147 17 1064 22 85S23M = 697 -389 GAGCCCCGCTGAGCGCAGAGGTCGGCGCTGCATGGAGTGGTCCCCCCCCCCCCCGTGTTGGGAACGAAAAAAAAAAAAAACCCCCAAAAAAAAAAAAAAAAAAAAAAA %3%$$$3(+8$$$-&7526&%4=$''%+7.2*,"&1%,/1#$$###$##%%%$$%1$+%$"%$/'##########$$$$$$$$##$#$$&$67%%$$$#$#$#$$6*/ XC:i:35 MD:Z:7G4G4G5 RG:Z:ERR013140 AM:i:29 NM:i:3 SM:i:29 MQ:i:29 XT:A:M BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@CBCCECUVDDCCCBCBCBCCUIN +ERR243091.615703 99 17 1066 60 100M = 1497 530 AAAAAGAAAAGAAAAGAAAAACTCACTGGATATGAATGATACAGGTTGAGGATCCATTATCTGAAATGCTTGGACCAGATGTTTTGAATTTTGGATTTTT ?BB@CHEE@EICFGGJGGHFGGGKGIFJHDGEGIDHFIFGEDDJFBFGBHICDKGIGFEIJHIEHEFKGGEJHFIHHLHHJC?CEJFEEBHGFFEFCIFFF@FIHFGDGHECEGI>=>GAGKJGEGF: X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR156632 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@C@@ +ERR243003.852165 163 17 1147 60 100M = 1483 435 TTTTGAATTTTGGATTTTTTCATATTTTGTAATCTTTGCAGTATATTTACCAGTTCAGCATCCCTAACTCAAAAATTCAAAAATCTGAAATCCCAAACGC @?ACHFGFDEEIGGDFFGFFJGGDGFGFJFEGHKHFGKIHKEEGFHGFEIGHKGGJGKKHIKIJHGHIIHHDIHHIEKHG?IIHIFJGGHFGEHEEEF=A X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243003 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:A@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR013140.1880433 163 17 1154 60 108M = 1476 392 TTTTGGATTTTTTCATATTTTGTAATCTTTGCAGTATATTTACCAGTTCAGCATCCCTAACTCAAAAATTCAAAAATCTGAAATCCCAAACGCGCCAATAAGCATTCC :?@@CFEDBBCCCGHGGGDDDIEGJHIJEEJJILFHIBHEFHGKIMJFJJMKJIJLLKIHILKJLMLIJFLKLLLMIJKKLLHGJLLIKGGBH>JFJDFEGIGFC>CC X0:i:1 X1:i:0 MD:Z:108 RG:Z:ERR013140 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@EH +ERR162875.1140280 83 17 1156 60 100M = 863 -392 TTGGATTTTTTCATATTTTGTAATCTTTGCAGTATATTTACCAGTTCAGCATCCCTAACTCAAAAATTCAAAAATCTGAAATCCCAAACGCGCCAATAAG AA=GGFGHEHBIHDHJI==:?G???EJI@GK?BHIJJIIGJHHHJBBKKDCFLMDB@AILDCIEJJIFG@B@0A?:BC><9=C?@DAG<@;=>CCC>AABB:@=IIIIJAECEHGF@DCAEHIF6>9),<>B9<76$*)=2?5>8:7/*+2& X0:i:1 X1:i:0 XC:i:93 MD:Z:83T8T0 RG:Z:ERR013140 AM:i:37 NM:i:2 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162875.20797205 147 17 1190 60 100M = 895 -394 TATTTACCAGTTCAGCATCCCTAACTCAAAAATTCAAAAATCTGAAATCCCAAACGCGCCAATAAGCATTCCCTTTGAGCGTCATGTCGGTGCTTGGAAT @ECFEGHKJIFHHBJJCAKKLHHGNHMHEIIJEJMIIHFJHMJEIHHKLKMHHGEHDJKMIIEELLMJJHJJMEJLLLLEJHLIIJIDJIIIKEHIHDBE X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162875 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@B +ERR242939.1378819 99 17 1202 60 100M = 1582 479 CAGCATCCCTAACTCAAAAATTCAAAAATCTGAAATCCCAAACGCGCCAATAAGCATTCCCTTTGAGCGTCATGTCGGTGCTTGGAATGTTTGGGGTTTT =C6:EADGG?;FGCIGFHHGF5IG?H>GCICJD;G?DG9HHHE4@AJDCCEAGIAFD5I,6H=5JAHJ4EJCHK2DAG=JEEDK8836E@ECH///A?=* X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR242939 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243035.1352953 99 17 1224 60 100M = 1563 438 CAAAAATCTGAAATCCCAAACGCGCCAATAAGCATTCCCTTTGAGCGTCATGTCGGTGCTTGGAATGTTTGGGGTTTTGGATTTACAGCTTTGGGACGCT @D@EEFGHFIG?DGIHHHHFBAIBIFHHEFBJHHHEHIGGGEIDMBBFJGGFFEAGEMHHF> X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243035 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162872.18681977 147 17 1234 60 100M = 1084 -249 AAATCCCAAACGCGCCAATAAGCATTCCCTTTGAGCGTCATGTCGGTGCTTGGAATGTTTGGGGTTTTGGATTTACAGCTTTGGGACGCTCAACCTGTAC 0@75A@E9F:(18K.@;I@2L2E:B?DJHCEJJKL36IIIB7B?CK?*KJI+LGIJ9=JJAL?BJJGJCJGJJGHILGLJICB@AGDD<>ED?9@?DD/=>=0I>=:EA2L7;3ECK5;G=>@MKL/0A2>A89?<2>KF@>L<9;/7>I@4:5:AFD7I@5A@G6E X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR156632 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@G +ERR162872.9427750 163 17 1249 60 100M = 1421 271 CAATAAGCATTCCCTTTGAGCGTCATGTCGGTGCTTGGAATGTTTGGGGTTTTGGATTTACAGCTTTGGGACGCTCAACCTGTACCTCAATAAACCTGAT ECDFFGKJIHHJKLLHHLLLLDIMGILHMDKHLLLEKKHIIDGIILGKJDIIEIK@JHIHIKNMMJIMKJJJDLLLJDILLMI@HKIKF>FHCAFGGHBD X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162872 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@F +ERR162875.5181154 163 17 1266 60 100M = 1395 228 GAGCGTCATGTCGGTGCTTGGAATGTTTGGGGTTTTGGATTTACAGCTTTGGGACGCTCAACCTGTACCTCAATAAACCTGATTTTAAAAAAGTTTGGGG BCHHBGGFHIFJDDHJJLFJJ?DJMIHHKJGGGDGGHB9KGDBF@FKKHBJ6BI@DJJMIJC@IJIIKKLGAIKGHIHKJLIHHGGG=?GIFK8D:CA@= X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162875 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@EFGE +ERR162872.1587020 83 17 1273 60 100M = 1024 -348 ATGTCGGTGCTTGGAATGTTTGGGGTTTTGGATTTACAGCTTTGGGACGCTCAACCTGTACCTCAATAAACCTGATTTTAAAAAAGTTTGGGGGGATTCC @EED@HGGII@IJKIJIHIHILKKIJIIIKKKHJHFILLNGJJKJLDEMMILGJLLKIJHIMJJHJIGHGIMGKIIIHHHGGGGKIHHGHIHGGGFCE>B X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162872 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@G +ERR156632.9494189 83 17 1277 60 100M = 1031 -345 CGGTGCTTGGAATGTTTGGGGTTTTGGATTTACAGCTTTGGGACGCTCAACCTGTACCTCAATAAACCTGATTTTAAAAAAGTTTGGGGGGATTCCCCTA 3EDF/DGGHKHHJJEIJKMJJJJJKM/IKGKGH@LMGEJ1MLBHFG@EEEFIHEGFFEHHJKIGGJHGGI;JIJHHHIIIDEJHKJHGIEIHIHFJFGEEGGGFGIHIFE@HIDBFHGGIJHHHFDGFIFH@GECDC> X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR242963 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A@ +ERR156632.10697401 99 17 1297 29 54S46M = 1427 229 ACCCCAAACATTCCAAGCACCGACATGACGCTCAAAGGGAATGCTTATTGGCGCGTTTGGGATTTACAGCTTTGGGACGCTCAACCTGTACCTCAATAAA DAFCIHHGHHFGCKHFKGIJMDIIJHKGJALCKDDILKCCEHKLLGIJGLIKEIADIHLKLJFEHFJKLLMFGIK?IGEHLE@EIBGLGFDHIHHFCD:; MD:Z:4T41 RG:Z:ERR156632 AM:i:29 NM:i:1 SM:i:29 MQ:i:29 XT:A:M BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@NQVUYXY@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162872.17780862 147 17 1308 60 100M = 951 -456 ACAGCTTTGGGACGCTCAACCTGTACCTCAATAAACCTGATTTTAAAAAAGTTTGGGGGGATTCCCCTAAGCCCGCCACCCGGAGACAGCGGATTTCCTT 5EGFHJHIIDJJHEAFJKJHHGHJJGKKIFGGGFEHCIEEFDEIJJJJAHFFIFLLLLILJHHK>ILKHIL?DDFGA5DA;A7:DD?CFI:BAD@@B@B X0:i:1 X1:i:0 MD:Z:108 RG:Z:ERR013140 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR242951.1253490 99 17 1327 60 100M = 1717 489 CCTGTACCTCAATAAACCTGATTTTAAAAAAGTTTGGGGGGATTCCCCTAAGCCCGCCACCCGGAGACAGCGGATTTCCTTAGTTACTTACTATGCTCCT @BEFEDGGGIGFHFGGGJKJGHFFFFHGFHIJDEEKGFHJIDFEDKJIIEIJJDJAJJIIHIB@HJCJGJJBG?G=EGJGEAJKEEGHCEFH>BHCCFED X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR242951 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@F +ERR162875.7604876 99 17 1336 60 100M = 1673 436 CAATAAACCTGATTTTAAAAAAGTTTGGGGGGATTCCCCTAAGCCCGCCACCCGGAGACAGCGGATTTCCTTAGTTACTTACTATGCTCCTTGGCCATTT BECF-@EFHIIGHFGGGHHHHEMHHHKKDJIJCFCLKKKKGIJDK9AMJJAELCCJKBHIBCDFJ@IGJKKHBBIHDJKDFIK2IJFLJIGEFHDG8FB? X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162875 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A@@ +ERR245038.1101322 1107 17 1338 60 100M = 1055 -382 ATAAACCTGATTTTAAAAAAGTTTGGGGGGATTCCCCTAAGCCCGCCACCCGGAGACAGCGGATTTCCTTAGTTACTTACTATGCTCCTTGGCCATTTCT DAA>CEGGHFHHGDGHBFFKFHHCI>GEHIH5HGIHKDFIBHHAH=JCII?EEHGEJIKAGHGGCEEJCEGIGEEJ:DFIEGGIJFDJHGFEEHCECDE? X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR245038 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR245049.1671108 83 17 1338 60 100M = 1055 -382 ATAAACCTGATTTTAAAAAAGTTTGGGGGGATTCCCCTAAGCCCGCCACCCGGAGACAGCGGATTTCCTTAGTTACTTACTATGCTCCTTGGCCATTTCT CBBB@GICHFG?E7FEGFFIHHIIIJGLIKHHHJHKKFFHJHFAKIJFIHBGJHIGIIJAIJHGEDIJHDIHGEEKGDFIEGGIIGDJFHGHEHEDCEE? X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR245049 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR245041.487129 147 17 1368 60 100M = 1004 -463 ATTCCCCTAAGCCCGCCACCCGGAGACAGCGGATTTCCTTAGTTACTTACTATGCTCCTTGGCCATTTCTCTAGGTATTGGTATATTGTGTCTGCTGTGA ?DCEGGJCAHGHHAJHJEEHCKKHHEKIIBIINGGFDLIBJHHFGKHFFKEHHIKGJIHIHIJIGHGFKFLFIIHEGGFIIDEFGHGHGICJGHIGGEDA X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR245041 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@C +ERR162875.4511615 163 17 1375 60 100M = 1652 376 TAAGCCCGCCACCCGGAGACAGCGGATTTCCTTAGTTACTTACTATGCTCCTTGGCCATTTCTCTAGGTATTGGTATATTGTGTCTGCTGTGAACTGTCC EA9IHD>CAD6A>K+A=23J>5:?K+0G?17<+G;<79:F=?CCH;<6/J6KCG0JB@HH)EKIFDMBDDB@EKDDGADAABECFDFDHBHBDGFEBE?DEC>@=@:GB@96#E?:42<72%9764;2( X0:i:1 X1:i:0 XC:i:99 MD:Z:91T7 RG:Z:ERR013140 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR156632.4998889 83 17 1385 60 100M = 1122 -362 ACCCGGAGACAGCGGATTTCCTTAGTTACTTACTATGCTCCTTGGCCATTTCTCTAGGTATTGGTATATTGTGTCTGCTGTGAACTGTCCTTGGCCTGTT .@2AGHJG8EHJ?JJFHIC/MFGEBAG6J;?@MCKH@FIBHDID7J?E=I;I9=HGG@EGFFFF?CBB X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162875 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@B +ERR162875.16344032 99 17 1402 60 100M = 1670 367 TTCCTTAGTTACTTACTATGCTCCTTGGCCATTTCTCTAGGTATTGGTATATTGTGTCTGCTGTGAACTGTCCTTGGCCTGTTTGGTGACGGGTGAGGAG ABFDHDCIFEFGJFEGFFGHBKLKKCG=KKIJFHFLDIFJMCBJHG6GEIIIGLHLGLKKKM@GL4JEKKDLKMEJCJJFIGI>CLFC X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR245032 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@B@C +ERR162872.9427750 83 17 1421 60 100M = 1249 -271 GCTCCTTGGCCATTTCTCTAGGTATTGGTATATTGTGTCTGCTGTGAACTGTCCTTGGCCTGTTTGGTGACGGGTGAGGAGCAGGGACAGAAGGGTCCTG ;FA@GAFJJHF;>:GMIEHLKIIJHJLKIJIHHJKJKIMKKMHJJMIIIHJJJJCEKFKLHIGJFNJGKICLLIGKKJKJIKKJJKGIIIEIGGFECGDB X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162872 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162872.25752000 99 17 1426 60 100M = 1789 462 TTGGCCATTTCTCTAGGTATTGGTATATTGTGTCTGCTGTGAACTGTCCTTGGCCTGTTTGGTGACGGGTGAGGAGCACGGACAGAAGGCCCCTGCGTGC B@=>FC/=CEF>G<5CE+HHECIGCHHEFICHH9J/C9><.=;3H.G79M>D/=K.8CFHNB:BEA9G/8:&7E3K9C)8JDH2C2:-H,&.(>./(BG; X0:i:1 X1:i:0 MD:Z:78G10G0T9 RG:Z:ERR162872 AM:i:37 NM:i:3 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR242963.327784 163 17 1426 60 100M = 1781 454 TTGGCCATTTCTCTAGGTATTGGTATATTGTGTCTGCTGTGAACTGTCCTTGGCCTGTTTGGTGACGGGGGAGGAGCAGGGACAGAAGGGTCCTGCGTGC @GGDBGCGFIED>EJ@DIFDJAEGG?EKG>?J(JIIHBEEJ:D0F,?FG#G9J.FIFHGGF?HEGAH/F82-H9AB98== X0:i:1 X1:i:0 MD:Z:69T30 RG:Z:ERR242963 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR156632.10697401 147 17 1427 29 100M = 1297 -229 TGGCCATTTCTCTAGGTATTGGTATATTGTGTCTGCTGTGAACTGTCCTTGGCCTGTTTGGTGACGGGTGAGGAGCAGGGACAGAAGGGTCCTGCGTGCC CEF=8DGGHHIKEKKHHIGELJFHDGGIHJJDKJMKJKKKH=LGJJJKADKJJMFJKBHIFDEGCKDGIKIK;JKCJK2FGJJHFHEIHFGHFG@BFE@B X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR156632 AM:i:29 NM:i:0 SM:i:29 MQ:i:29 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@BG +ERR245024.1107845 99 17 1428 60 100M = 1785 456 GGCCATTTCTCTAGGTATTGGTATATTGTGTCTGCTGTGAACTGTCCTTGGCCTGTTTGGTGACGGGTGAGGAGCAGGGACAGAAGGGTCCTGCGTGCCC @:EDEFDEHHHIDJGDDGDIE>EEDF?JDHEKIIIIFCIE@H=CCFH>EDHJIGG>EAGI<-FF?FD9A@CD8 X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR245024 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@B@ +ERR242943.1490060 147 17 1433 60 100M = 1031 -501 TTTCTCTAGGTATTGGTATATTGTGTCTGCTGTGAACTGTCCTTGGCCTGTTTGGTGACGGGTGAGGAGCAGGGACAGAAGGGTCCTGCGTGCCCTGCCT BADGDG?HGIFFDHIGDHGEGJFGHFKHGADIIJIILHJHGJJEE;BEEFDLIILKB:EIEEHK>IG;AM5FAKKKDKIFK@KBGKKIFFHKICFKFFBDFHC@@GFBGCA X0:i:1 X1:i:0 MD:Z:11T88 RG:Z:ERR156632 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:EG@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR156632.10970255 147 17 1440 60 100M = 1238 -301 AGGTATTGGTATATTGTGTCTGCTGTGAACTGTCCTTGGCCTGTTTGGTGACGGGTGAGGAGCAGGGACAGACGGGTCCTGCGTGCCCTGCCTTCACAAG +>DC7>>0HE,A+37HHA9HIDBA?H.A1A.F8?N5HKDJ9FJ54:D>EK2C2)>I9:=FD=<8IH=GH)/1EF@>;FA X0:i:1 X1:i:0 MD:Z:72A27 RG:Z:ERR156632 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR156632.9078489 99 17 1452 60 100M = 1710 357 ATTGTGTCTGCTGTGAACTGTCCTTGGCCTGTTTGGTGACGGGTGAGGAGCAGGGACAGAAGGGTCCTGCGTGCCCTGCCTTCACAAGCCCCTGGAAGGA C@BGFJGJJJJKHGHIJIKLIKJKHJHKKJLGHGIJ=MKHEKF>HJGJKMLIKMKDHDMFINLLBEIGIEGBIBHEFEDI@JEI>JIFKBJHEKJFIIHDGHAGGHIJBIIIKIBDJDHHJIKI>5GGCGGJJHHFHEBFDKFE@;IC=G?= X0:i:1 X1:i:0 MD:Z:9C90 RG:Z:ERR242983 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@AB +ERR245034.324906 163 17 1469 60 100M = 1786 416 CTGTCCTTGGCCTGTTTGGTGACGGGTGAGGAGCAGGGACAGAAGGGTCCTGCGTGCCCTGCCTTCACAAGCCCCTGGAAGGAAAGTTGTTTTGGGATCT ?DGCFDFDHFHGGICEGJCEJFIABG=GBJIFKHGJI@GFFHDGKHH3LHHJJABHHFKGMKKICEFGHGJGHHKFKF9FKI@HHB=FJA2D;:C@DC7@ X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR245034 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR013140.1880433 83 17 1476 60 37S71M = 1154 -392 TGGGTATTGGTATGTGGTGTCTGCTGTGACCTGTCCTTGGCCTGTTTGGTGACGGGTGAGGAGCAGGGACAGAAGGGTCCTGCGTGCCCTGCCTTCACAAGCCCCTGG 0%.*1%?0+(3+7%;#'2%8=44222;76%51(02/+5B/:C@<>CA6CA=I8JELF8F.G18.3F)GDEDAE70G--DJJGHK@)+=B0= X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162872 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:A@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243003.852165 83 17 1483 60 100M = 1147 -435 TTTGGTGACGGGTGAGGAGCAGGGACAGAAGGGTCCTGCGTGCCCTGCCTTCACAAGCCCCTGGAAGGAAAGTTGTTTTGGGATCTCTGCACCCTCAGCC 9DBGG@F; X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR242947 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@B@ +ERR242999.1133728 163 17 1503 60 100M = 1901 495 AGGGACAGAAGGGTCCTGCGTGCCCTGCCTTCACCAGCCCCTGGAAGGAAAGTTGTTTTGGGATCTCTGCACCCTCAGCCTGGACAACTTGTGCCCATCT >F7ABHDH;F?FAFD08&@L>0HIG5IH=JFHI8?58F58A62;>G) X0:i:1 X1:i:0 MD:Z:34A65 RG:Z:ERR242999 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162872.15752406 163 17 1509 60 100M = 1804 394 AGAAGGGTCCTGCGTGCCCTGCCTTCACAAGCCCCTGGAAGGAAAGTTGTTTTGGGATCTCTGCACCCTCAGCCTGGACAACTTGTGCCCATCTGGTGAC EEEFIDIGJJKKKCIKKKLKKLLLIL:IKJMGMLLLLKHIMFIIJMJHLIIIJIKHIKLKMLKKKKLLMKINLLLLKFIEJKJ?JIIKKJIDJJIFBDBC X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162872 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@E +ERR013140.17777881 83 17 1524 60 46S62M = 1188 -397 GCGTGTTGGGAGGGGGGGGGGGAGCGGGGACAGAGGGGCCCGGGGTGCCCTGCCTTCACAAGCCCCTGGAAGGAAAGTTGTTTTGGGATCTCTGCACCCTCAGCCTGG &)%%*$$$%##%#(##$$#%$*#-%$01-893-%#11$$2##$"&1*86>=<FGIGJHHIFHHJEIJHEJD4JCIJDJGDHFG9G=HCIB:FGBA8;9E@JFJBHBB8IBBCEC=EJ@B;8;C;@CC6 X0:i:1 X1:i:0 MD:Z:108 RG:Z:ERR016352 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR013140.28180864 163 17 1536 60 108M = 1849 387 CAAGCCCCTGGAAGGAAAGTTGTTTTGGGATCTCTGCACCCTCAGCCTGGACAACTTGTGCCCATCTGGTGACCCCTCACTCAGCCACTCGACTTCCACGACAGCCTC :B?>=595B?<==??CA>BA=BC4@9B==?A0:C>EB=@AB@>8=>8E;?A@E7;CF;B@=?.GADBA<@9$'17.?2B3C66@386&298 X0:i:1 X1:i:0 MD:Z:88C0A14G3 RG:Z:ERR013140 AM:i:37 NM:i:3 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR156632.18201416 99 17 1557 60 100M = 1954 496 GTTTTGGGATCTCTGCACCCTCAGCCTGGACAACTTGTGCCCATCTGGTGACCCCTCACTCAGCCACCAGACTTCCACGACAGGCTCCAGCCTCGGCACC DDCEEJF;HFILHKHLJJIKLLHHLIMJJGIDGIJGLHK9LHJDELM@HLKILMMKIFKLLJELGJJGDEHHKHM;IJAJIGL.BLKDHMIHIIA5GFA? X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR156632 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243035.1352953 147 17 1563 60 100M = 1224 -438 GGATCTCTGCCCCCTCAGCCTGGACAACTTGTGCCCATCTGGTGACCCCTCACTCAGCCACCAGACTTCCACGACAGGCTCCAGCCTCGGCACCTTCAGC D986>>D=2B&HFI6I/D/A8EB@I3EA5GHG*FEH=C:;HIDD1/G;IFD3EFJ0D?D44I<:=FG;2H3<=@HIH;@>@JIIGH>?EII5CDDDGDD? X0:i:1 X1:i:0 MD:Z:10A89 RG:Z:ERR243035 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:F@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A +ERR242939.1378819 147 17 1582 60 100M = 1202 -479 CTGGGCAACTTGTGCCCATTTGGTGACCCCTCACTCAGCCACCAGACTTCCACGACAGGCTCCAGCCTCGGCACCTTCAGCCATGGACAGTTCCGCCAGC 0>D/&9C98=AG73#/8.4+0H?H,0'10K@=2G(+<:'C1(20.207D?C2+B?11H&==79J@B:A8>2GH)4@F;H7BB4F=GGHCE0FAGHCBH?JGGE=F;==;1@9<5:.>>0'/,6<=*0;<4:2?=@<>D@B1:<=:?@E@F?BD>8GHBHF;DGGEIBHEECBCD: X0:i:1 X1:i:0 XC:i:75 MD:Z:75 RG:Z:ERR013140 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162872.25518652 83 17 1632 60 100M = 1387 -344 CACGACAGGCTCCAGCCTCGGCTCCTTCAGCCATGGACAGTTCCGCCAGCGTTGCCCTCTGTTCTGCTGTTTTCTCTACCAGAAGTGCCCTTCCCTCCTC ;C0C/;)@F7,:KK@KGH(CJ<03-G;J.JFF@DC5/:8?GE@DF.A.EA3FI2AGMIMI?E3;F4JBJ@JGEBCK8EIKFHGJ@FDEH=FE7,405,0?GG%E1:D.8115<='E&82A6*IJE53:,*C:)HII:H#D;:D3FKC*8I;368?<0GMHHH?:.-GCJ3<8<-5'+/+BA X0:i:1 X1:i:0 MD:Z:57A42 RG:Z:ERR162875 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A +ERR242959.484376 99 17 1656 60 100M = 1972 415 CTTCAGCCATGGACAGTTCCGCCAGCGTTGCCCTCTGTTCTGCTGTTTTCTCTACCAGAAGTGCCCTTCCCTCCTCACCTGACCACTCTGGGGAAATCCC ADBGGJGIFGJGGCGKEFJH@KGGJKAGFHHGGIGFIEEIJHIFLGGEFIJGJEGHGKIELFLFECHEIHIHHJGIIHHJGFGIGHHJGIHDGGFDEFB6 X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR242959 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A@@ +ERR162875.16344032 147 17 1670 60 100M = 1402 -367 AGTTCCGCCAGCGTTGCCCTCTGTTCTGCTGTTTTCTCTACCAGAAGTGCCCTTCCCTCCTCACCTGACCACTCTGGGGAAATCCCTCAGCACCCTCCCT AC=@>A8:IJKBGJEJIIJFLHJIGKEKMHIEEE9(4986(1$75&8+B:?>EBD>FHFFIGGIFHBIIJMFGIBHHEEGFGCBHDLJHLEGFCJFC?GGEDFGDF@ELFECFEBFFHDJJJIGGFIHHGIFFDA@ X0:i:1 X1:i:0 XC:i:89 MD:Z:89 RG:Z:ERR013140 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162875.7604876 147 17 1673 60 100M = 1336 -436 TCCGCCAGCGTTGCCCTCTGTTCTGCTGTTTTCTCTACCAGAAGTGCCCTTCCCTCCTCACCTGACCACTCTGGGGAAATCCCTCAGCACCCTCCCTGAG DE?E:IFD7JGIK>KKJMHJIGDHHKGJEKDJMJMJHKLLKILIJLKLLFDJILFEM?L@KGI4DC=EHIGABH=?9G6F8JFGG@<8? X0:i:1 X1:i:0 MD:Z:73A26 RG:Z:ERR242963 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR156632.9078489 147 17 1710 60 100M = 1452 -357 CCAGAAGTGCCTTTCCCTCCTCACCTGACCACTCTGGGGAAATCCCTCAGCACCCTCCCTGAGCATACCCTACTCTGGCACAAGCCCACCCTGCAAAGCC CFHD9DDHIJF"*6JJMJJKEAFLMFLBKHCMFJELEEIFHA:KKMFLKFFBJKLCLJLIKLKKHHGJJLFFLGIGJKKFKGIHIIJGHHIGH@CCFE@B X0:i:1 X1:i:0 MD:Z:11C88 RG:Z:ERR156632 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:AA@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@BG +ERR245032.1136878 147 17 1713 60 100M = 1416 -396 GAAGTGCCCTTCCCTCCTCACCTGACCACTCTGGGGAAATCCCTCAGCACCCTCCCTGAGCATACCCTACTCTGGCACAAGCCCACCCTGCAAAGCCCCT ?BFAE@FF@FABDHABKGKCHIHFDIDHHKDIHKGHGJJFECIHKFEKF? X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR245032 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR242951.1253490 147 17 1717 60 100M = 1327 -489 TGCCCTTCCCTCCTCACCTGACCACTCTGGGGAAATCCCTCAGCACCCTCCCTGAGCATACCCTACTCTGGCACAAGCCCACCCTGCAAAGCCCCTGAGG B4EFFE5FAI7?K5JAHHFJDBKAJGIEIIHHG?ADIGCFIHJK1BJLEGJKG=H@KFDBFIIEAKFHEHIJEFDHGF?IAGFJGIIEEGGEFEHFEFB? X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR242951 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR242991.1183757 163 17 1719 60 100M = 2047 427 CCCTTCCCTCCTCACCTGACCACTCTGGGGAAATCCCTCAGCACCCTCCCTGAGCATACCCTACTCTGGCACAAGCCCACCCTGCAAAGCCCCTGAGGCC ?=?FDI@@HHGFJEHGIIGGGDHEHFJDHBEHIEEHHJHFBIHHJFHJDFHJFGGHC@IDHIEJJJIJCKHFJKEGDL@DIHHADF5 X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR156632 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162872.9045126 163 17 1733 60 100M = 1981 347 CCTGACCACTCTGGGGAAATCCCTCAGCACCCTCCCTGAGCATACCCTACTCTGGCACAAGCCCACCCTGCAAAGCCCCTGAGGCCCGCCCTGTGGCGTC EBHHGHJHIKKKKIKIIKNJLKKJMHJKHJLNLLLLKMJLLJKILKLLJJMLMLKLJLKILLLMKKILKILJIJLKLLKLKIMKKKKDKJIKGGGFF@DB X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162872 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:C@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR156632.16941332 163 17 1735 60 100M = 2041 405 TGACCACTCTGGGGAAATCCCTCAGCACCCTCCCTGAGCATACCCTACTCTGGCACAAGCCCACCCTGCAAAGCCCCTGAGGCCCGCCCTGTGGCGTCTC BFFDE4EHIHHHGJHHFHJHJKKHKKHGKKKKLKKKILKIIHJMJKGIJLHKLJHHJJMFMIJJMILLLJJBLLKKJLLHMKILLEKEJIGBIII@FEGA X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR156632 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@C@ +ERR162872.10053578 99 17 1777 60 100M = 1965 287 CCCTACTCTGGCACAAGCCCACCCTGCAAAGCCCCTGAGGCCCGCCCTGTGGCGTCTCTCCCTCCCTTGCTGTCAGGACAGTGGTCCTGGCCTCCCGGGC BADGDEGEHIBGFFGHIAJKGIJJIJKHGHL7KFKKIJ=GJFJBCKJKADLBBEBJGMKJ;GLHLMECMLLLHH>BEBDI;H=38EEKCB?EK;H(===, X0:i:1 X1:i:0 MD:Z:92A2G4 RG:Z:ERR162872 AM:i:37 NM:i:2 SM:i:37 MQ:i:60 XT:A:U BQ:Z:A@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@RBO@DDD@ +ERR242963.327784 83 17 1781 60 100M = 1426 -454 ACTCTGGCACAAGCCCACCCTGCAAAGCCCCTGAGGCCCGCCCTGTGGCGTCTCTCCCTCCCTTGCTGTCAGGACAGTGGTCCTGGCCTCCGGGGCTCAC 4:<9CC1GEHC?69HI0?FD<713E9EFDH=B=HFEGDJ/E9FEE/DDFC? X0:i:1 X1:i:0 MD:Z:88A11 RG:Z:ERR242963 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR245024.1107845 147 17 1785 60 100M = 1428 -456 TGGCACAAGCCCACCCTGCAAAGCCCCTGAGGCCCGCCCTGTGGCGTCTCTCCCTCCCTTGCTGCCAGGACAGTGGTCCTGGCCACCGGGGCTCACGGAG 6DEGCEDF>HJC1BBIGHIE4;DHB>FGIHHICGBB>GFEGIDHD?ADD? X0:i:1 X1:i:0 MD:Z:64T35 RG:Z:ERR245024 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR156632.3514928 99 17 1786 60 100M = 2012 325 GGCACAAGCCCACCCTGCAAAGCCCCTGAGGCCCGCCCTGTGGCGTCTCTCCCTCCCTTGCTGTCAGGACAGTGGTCCTGGCCACCGGGGCTCACGGAGC C?EFGFFIGJEHFKLKJKIJJLDKLLKKIKHGHM6GLK9C@:>GJEMELI1EL:-6IE>L>B>3'2E/BBECJ;DDKINKDG:0H+3BM6@KNJH7B X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162872 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A +ERR243039.1277921 163 17 1809 60 100M = 2171 461 CCCTGAGGCCCGCCCTGTGGCGTCTCTCCCTCCCTTGCTGTCAGGACAGTGGTCCTGGCCTCCGGGGCTCACGGAGCCGCCCTGTGCCGTGTACCTCTGA <<=GGB40FE;BA>HHI7K:F4AIIABJHGGI:IHD?IHBACCDF@AD<>GADI&ED:)I<9AB10;I/IB6?EF:>3;AGGAHEEI9@9/051EEG@?? X0:i:1 X1:i:0 MD:Z:60A39 RG:Z:ERR243039 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:AA@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR013140.8706087 163 17 1811 60 41M67S = 2105 373 CTGAGGCCCGCCCTGTGGCGCCTCTCCCTCCCTTGCTGTCAAGACAGGGGTCCTGGCCTCCGGGGCCCATGGTGCCCCCCTTTGCCCAGGAACCCCTGGCTCGCTCCG 8C>@?>=;;4;>40465.<986B1?<5*:%'%).%".,#23$%*+0'$#%"%#)%+,$/.+(#&)#,%&%%'$,)$5$($'%%,&/%.%/5)%( X0:i:1 X1:i:0 XC:i:41 MD:Z:20T20 RG:Z:ERR013140 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243007.241318 163 17 1823 60 100M = 2171 447 CTGTGGCGTCTCTCCCTCCCTTGCTGTCAGGACAGTGGTCCTGGCCACCGGGGCTCACGGAGCCGCCCTGTGCCGTGTACCTCTGAGCCCTCTGCACAGT =EHCIEH@EICJHK@IHJHHIEFI@EFIIK4AGGKEIBEJ7EC;:IHJF=1?KD.IHG8IGCJ>FHCIHHHFDDF6 X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243007 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243015.41290 163 17 1834 17 100M = 2189 454 CTCCCTCCCTTGCTGTCAGGACAGTGGTCCTGGCCACCGGGGCTCACGGAGCCGCCCTGTGCCGGGCACCTCTGAGCCCTCCTCACAGTGCCTTCTTCTT <@BB3:GC>H>9II>1FGF26GB.B5:/>93?2&GD<8A2G3:EB3@*B:=8G)A652K40%?6&'&CGBDIHHJJ;FLIGFIIGIIGHBJGJJIJDLGIIGBEHGFJB@DEF@>D X0:i:1 X1:i:0 MD:Z:22A77 RG:Z:ERR243031 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR013140.28180864 83 17 1849 60 33S75M = 1536 -387 GCCGGCCCTGCGCCGTCTCCCCCGCCCTTTCTGTCAGGACAGTGGTCCTGGCCACCGGGGCTCACGGAGCCGCCCTGTGCCGTGTACCTCTGAGCCCTCTGCACAGTG '&1$$/-6%'((&,*%+%$$%.(%/36/+%1;06>?168<>2<;;:@D:79=>;@C9A:D=E9CBAAEACDE9?DCEDFCDEEGIADCBADEHGCGE?C@ X0:i:1 X1:i:0 XC:i:75 MD:Z:75 RG:Z:ERR013140 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR242983.836867 83 17 1849 60 100M = 1460 -488 TCAGGACAGTGGTCCTGGCCACCGGGGCTCACGGAGCCGCCCTGTGCCGTGTACCTCTGAGCCCTCTGCACAGTGCCTTCTGCTTGCCTGTGGCTTTGAG AFE@?CGHGBF@F2I-D4HED@@HD7BDGEEB>GDHBCJI5IHGEHE>HGCFEDEFHGEFG=EKGGDFGBAFCGCHJDGCFEHGGHEGCFF@:>@ACH7D@EB@BDDC;BD=?;7D>FDCF?3@%=?;8B@5?8?59@A5B@5D39?::9A?>1%$,-#9.1 X0:i:1 X1:i:0 MD:Z:15A92 RG:Z:ERR013140 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR016352.7109038 83 17 1854 60 108M = 1534 -427 GCAGTGGTCCTGGCCTCCGGGGCTCACGGAGCCGCCCTGTGCCGTGTACCTCTGAGCCCTCTGCACAGTGCCTTCTGCTTGCCTGTGGCTTTGAGAAGAAACCCCTTC $>;0776;FECG5GGJIJJJFJIIJGDJHJ;FJCFEFCCF@ECA X0:i:1 X1:i:0 MD:Z:0A14A92 RG:Z:ERR016352 AM:i:37 NM:i:2 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR242947.484791 83 17 1858 60 100M = 1499 -458 TGGTCCTGGCCACCGGGGCTCACGGAGCCGCCCTGTGCCGTGTACCTCTGAGCCCTCTGCACAGTGCCTTCTGCTTGCCTGTGGCTTTGAGAAGAAACCC 2EED@IGEHGJFHBHGJHMGLFAGJDJC?KG9LHHIIGCIHHFEJJIIGII9AJLEKHJICHIHFIFJIHKGJKHFFFKGIHDIJHFHJGIEGHCDEB?A X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR242947 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@DDG +ERR162872.17554044 99 17 1863 60 100M = 2053 289 CTGGCCACCGGGGCTCACGGAGCCGCCCTGTGCCGTGTACCTCTGAGCCCTCTGCACAGTGCCTTCTGCTTGCCTGTGGCTTTGAGAAGAAACCCCTTCT BFHBFFFFGCCGJJJIHHCGIKDI>KHKKIHLKKCDLHGIJJKKKILLKMJLLJIIJGMHKKIKHLLKIL@LLJJKGLHJIHGL?JIIKBDGEGHCECGE X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162872 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR242975.1004165 163 17 1881 60 100M = 2290 508 GGAGCCGCCCTGTGCCGTGTACCTCTGAGCCCTCTGCACAGTGCCTTCTGCTTGCCTGTGGCTTTGAGAAGAAACCCCTTCTGGTTATACATAAGACAGC @>EHGAAIHGHIEIJGAFIFEIGHJHJFKJGGIFIJKHJGLFJIFIGJKKJJFKJIHLFJIKJGFIHKIGIGFGIIIIIFJKHJGGEEDHGDBGIDFDGB X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR242975 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@D +ERR243031.1705886 99 17 1881 60 100M = 2179 397 GGAGCCGCCCTGTGCCGTGTACCTCTGAGCCCTCTGCACAGTGCCTTCTGCTTGCCTGTGGCTTTGAGAAGAAACCCCTTCTGGTTATACATAAGACAGC ?@DGFDAHGGHIEIIHAEIEFGHHIIIGKIHHJHGIJGIIKFJIHHEJKIIIGJJIJIFGIFJGCHIKIDJDBHEIIHJEJHIIEFGFDFCHCEGEFDFB X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243031 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@D +ERR162875.23402552 163 17 1882 60 100M = 2021 238 GAGCCGCCCTGTGCCGTGTACCTCTGAGCCCTCTGCACAGTGCCTTCTGCTTGCCTGTGGCTTTGAGAAGAAACCCCTTCTGGTTATACATAAGACAGCC DCHHICIIIJKHLJKDIKHIJKLJIKJLLKLJKHMLIKJNILJKLIMKLMMHKLLLMILLLLHIMIMAILKJIKILLLGKLMLIIIIGIGIIGKCGFGF< X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162875 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A@ +ERR162875.5605685 1187 17 1882 60 100M = 2021 238 GAGCCGCCCTGTGCCGTGTACCTCTGAGCCCTCTGCACAGTGCCTTCTGCTTGCCTGTGGCTTTGAGAAGAAACCCCTTCTGGTTATACATAAGACAGCC BAHEIAIIJJJGKKFCIKHGJLLJLK7LLKLFLJKJGHIKCLJKJGLKLKMFMLKJIEK05FFIJ@MD@N5E;III3IGKLMLECJAFGHHDDKCGD9C< X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162875 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR242971.738250 163 17 1883 60 100M = 2315 531 AGCCGCCCTGTGCCGTGTACCTCTGAGCCCTCTGCACAGTGCCTTCTGCTTGCCTGTGGCTTTGAGAAGAAACCCCTTCTGGTTATACATAAGACAGCCA AEDA@HEHHIDIIIAEIGEHHGIIJGLIHIKIHIKIBILGJJHGIJIJIIGJIIGJFJEHIFFLHLHGKGHGIIIIHEIJJJCF?GEAGFDHKGDEHED? X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR242971 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR242999.1133728 83 17 1901 60 2S98M = 1503 -495 GTTCCTCTGAGCCCTCTGCTCTGTGCCTTCTGCTTGCCTGTGGCTTTGAGAAGAAACCCCTTCTGGTTATACATAAGACAGCCAGAGAAGGGAGTTGCCC )+,7@CDG8F4'0>6066E%?/@;9>;5:?.816IK)2//DIBL97;EHC+@0,+2)4?1DG4GC<-E?D442EE3JB6H-%CHBCB;7G,,7F@C12*/ X0:i:1 X1:i:0 XC:i:98 MD:Z:0A16A1A78 RG:Z:ERR242999 AM:i:37 NM:i:3 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR242955.454193 163 17 1904 60 100M = 2322 517 TCTGAGCCCTCTGCACAGTGCCTTCTGCTTGCCTGTGGCTTTGAGAAGAAACCCCTTCTGGTTATACATAAGACAGCCAGAGAAGGGAGTTGCCCAGGGT ABFFDIBGDHCGHGHFGGDJJIFFHGHIDEHJHHJGHJJFHFJBIFHJHHAI9DAHGHIKHGDAH9CHHAILAJ?JLAFJEJGHIHAFGF9HEG9GG7GHJCE;CBGFGC X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243079 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162872.17357143 163 17 1931 60 100M = 2079 247 CTTGCCTGTGGCTTTGAGAAGAAACCCCTTCTGGTTATACATAAGACAGCCAGAGAAGGGAGTTGCCCAGGGTGGCACAGCACGTTGCTGCCAGTTACTG BEDHHIJJHH5J>HEKHLHIIIHEILKLJHLKKLGHHIJIJDEIMIKJMKDKNGM@IIKIKMIILHGEGED?ACDBG5>GG=.E@J8CHEFC?KFIK7HG2&E>D0IIJ=>9D-6FE>ACHIE0<649FC X0:i:1 X1:i:0 MD:Z:90G9 RG:Z:ERR243011 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@C +ERR242975.806680 163 17 1953 60 100M = 2127 273 AACCCCTTCTGGTTATACATAAGACAGCCAGAGAAGGGAGTTGCCCAGGGTGGCACAGCACGTTGCTGCCAGTTACTGCCATTTTCACAGGCATGAAATG @AEDFGHEIHJHEFFGEIGGEHLHIHLIIHJFJGGJHIEKDGJIIHILEJFKIJHJGMJIIBFGJJFJKGGKFEFIJKKHEJDGFKBHHJGHGHIDDEDF X0:i:1 X1:i:0 MD:Z:88G11 RG:Z:ERR242975 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:BC@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@H +ERR242991.1140440 1187 17 1953 60 100M = 2127 273 AACCCCTTCTGGTTATACATAAGACAGCCAGAGAAGGGAGTTGCCCAGGGTGGCACAGCACGTTGCTGCCAGTTACTGCCATTTTCACAGGCATGAAATG @@EEHFGEHHJHFEEIDHHGHGKGIGJJHGKGLFHLGIGIFAIJHIGKJDEJGKGIHKJIHBHEKJIJJGJJFFFIDJLIHHEEDJHKGKDJEDIDCEDD X0:i:1 X1:i:0 MD:Z:88G11 RG:Z:ERR242991 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:BB@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@F +ERR156632.18201416 147 17 1954 60 100M = 1557 -496 ACCCCTTCTGGTTATACATAAGACAGCCAGAGAAGGGAGTTGCCCAGGGTGGCACAGCACGTTGCTGCCAGTTACTGCCATTTTCACAGGCATGAAATGG 36DEAGCKDKIIIIHHJFJGLL7KKH?K;LLH?IIMKLHIGHK0:LKJ?KA7KBJIIK>EFIIFMHHBEGBIFGLIIBKCIDHHJ@HHCCH>FFDCCEBA X0:i:1 X1:i:0 MD:Z:87G12 RG:Z:ERR156632 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR245038.798432 99 17 1958 60 100M = 2312 453 CTTCTGGTTATACATAAGACAGCCAGAGAAGGGAGTTGCCCAGGGTGGCACAGCACGTTGCTGCCAGTTACTGCCATTTTCACGGGCATGAAATGGAGAT ?DAEFG9CCCFCGFFEFHEGIIHEEHBJCEHGGFHBEDIG7DJEF3HHIFIHHIHFAFFIIJGJIF;EDEGHBFH9CDBGHFC>G/E:??FC@FBC@BCB X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR245038 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243087.1122947 99 17 1960 60 100M = 2366 505 TCTGGTTATACATAAGACAGCCAGAGAAGGGAGTTGCCCAGGGTGGCACAGCACGTTGCTGCCAGTTACTGCCATTTTCACAGGCATGAAATGGAGATAA ?DGFBC?D?DFGGDF>FIFGIHFK@KLGFGGEJDDFFFDFAFAG<><7I8>HG?AKEFEFFILCAHF<6B;IAIHCGBK@<5GIABDDAB5DC X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR245024 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@E +ERR162872.10053578 147 17 1965 60 100M = 1777 -287 TTATACATAAGACAGCCAGAGAAGGGAGTTGCCCAGGGTGGCACAGCACGTTGCTGCCAGTTACTGCCATTTTCACAGGCATGAAATGGAGATAACAACA .>@@DJHGBMKCHIK.LJKHHALILLFJDILHBBILGF>JKLIGDJFDCKIGGKEL;LEKIJIKJLBMGJAJJJFIIKKMHIDHGGIKJKIHFGGI:FFD X0:i:1 X1:i:0 MD:Z:76G23 RG:Z:ERR162872 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR242959.484376 147 17 1972 60 100M = 1656 -415 TAAGACAGCCAGAGAAGGGAGTTGCCCAGGGTGGCACAGCACGTTGCTGCCAGTTACTGCCATTTTCACGGGCATGAAATGGAGATAACAACAGGAGCGA 6BEFBHFHCGCIHKEIAJJJJGGIEIIFGHEEDICEJKIKF?IJHKFHIILGHGBGDEKHIHGGHFICBHHIHHGIEEEECIHIIEEEIDEIGFFFE>D@ X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR242959 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162875.2168867 99 17 1981 60 100M = 2205 323 CAGAGAAGGGAGTTGCCCAGGGTGGCACAGCACGTTGCTGCCAGTTACTGCCATTTTCACGGGCATGAAATGGAGATAACAACAGGAGCGACCGCACAGG AEGEHEEIGIGJGFJJIKIKJECLCFFJFLLHJDIILKILMLFMHFHKKLMKICIJIMJIDMKLJIJKIIILIIMDHIHHGJKILEJLH@HFCAJFFDGC X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162875 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@BA +ERR162872.9045126 83 17 1981 60 100M = 1733 -347 CAGAGAAGGGAGTTGCCCAGGGTGGCACAGCACGTTGCTGCCAGTTACTGCCATTTTCACGGGCATGAAATGGAGATAACAACAGGAGCGACCGCACAGG EC?HEBIEDELDIIJIJJKKEIGKJLHMLLLHCJJJDMJKGLKJJIIKJKLDKIJHJKFCIJJLIILGHJJKLKJHEGHIGFKIJKJHBIFEAGHFHGAB X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162872 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243003.755522 99 17 1982 60 100M = 2281 398 TGAGAAGGGAGTTGCCCAGGGTGGCACAGCACGTTGCTGCCAGTTACTGCCATTTTCACGGGCATGAAATGGAGATAACAACAGGAGCGACCGCACAGGC ?FDGE>GFDFFFECIIHGKHI4HCHDHDKJEHAFFHIAIGHGHFCEHGHJBGGGDEJFHB5IJGGJFFCGFHHFBGECFIGHGKCEK@?@G?@IFE@;E5 X0:i:1 X1:i:0 MD:Z:0A99 RG:Z:ERR243003 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:ZQ@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR156632.15198869 99 17 1987 60 100M = 2229 341 AGGGAGTTGCCCAGGGTGGCACAGCACGTTGCTGCCAGTTACTGCCATTTTCACGGGCATGAAATGGAGATAACAACAGGAGCGACCGCACAGGCTGCTG DD:=GKGFJJJHHJKKHIHKI>HLLGIDHHKLLJJMFLIIGJDJJKIJGGHKDKDJBLHFLJJJGLLGJJ?JDIAKJKMLJL=CIIJEC>IHLGHIEAED X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR156632 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243059.1079565 83 17 1995 60 100M = 1638 -456 GCCCAGGGTGGCACAGCACGTTGCTGCCAGTTACTGCCATTTTCACAGGCATGAAATGGAGATAACAACAGGAGCGACCGCACAGGCTGCTGAGCGCGTC @DCGFEHG?EHJCJJIJB?HGHGJHIIHIJGEEKGHGIGIHG@ICGJGKKIHIEGFFIHCJGDEEJD?GHHFIKAIEGAHHDIGGIIFHJFHHG?E?DB@ X0:i:1 X1:i:0 MD:Z:46G53 RG:Z:ERR243059 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162875.4987821 163 17 1996 60 100M = 2242 345 CCCAGGGTGGCACAGCACGTTGCTGCCAGTTACTGCCATTTTCACAGGCATGAAATGGAGATAACAACAGGAGCGACCGCACAGGCTGCTGAGCGCGTCA DBDFJHHGJIKHIJMKJJDIEKKLLLKJMHIJJLKJMFIIGJJIKINIKKJLKFJJMBJNKJIJKKJKJKKJNJBKKKCKFKHLJMLLBKIHJIBGABFC X0:i:1 X1:i:0 MD:Z:45G54 RG:Z:ERR162875 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:C@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR245024.420543 163 17 1999 60 100M = 2317 417 AGGGTGGCACAGCACGTTGCTGCCAGTTACTGCCATTTTCACAGGCATGAAATGGAGATAACAACAGGAGCGACCGCACAGGCTGCTGAGCGCGTCACAC ?D@@EH@FGFFBHGG@ECAJFIJH@GDEEGEEIG?GFFGHGHFJIIHGKGHGEKFFJGHDHGGIIFJICEIA:HH;IHIGGHCHHHE:@:C9??BGE>A9 X0:i:1 X1:i:0 MD:Z:42G57 RG:Z:ERR245024 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR156632.3514928 147 17 2012 60 100M = 1786 -325 ACGTTGCTGCCAGTTACTGCCATTTTCACGGGCATGAAATGGAGATAACAACAGGAGCGACCGCACAGGCTGCTGAGCGCGTCACACGCAGCCATCGCGC 34F=D2JFAJF*>BBHKGKIEDEIAI@H@LKHJDKCHIGJKHLKHIGGKCHJCLGJIBK=KAKFHEHLKLGKLGEKI?I?GHIGFGBHHHHFFEG@F?DB X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR156632 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR156632.9766143 147 17 2017 60 100M = 1732 -384 GCTGCCAGTTACTGCCATTTTCACGGGCATGAAATGTAGATAACAACAGGAGCGACCGCACAGGCTGCTGAGCGCGTCACACGCAGCCATCGCGCAGCTC HHKGGEFE5FBIHLHHEAFIGGHJEFAH@DFGFGFB X0:i:1 X1:i:0 MD:Z:36G63 RG:Z:ERR156632 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR013140.21458070 99 17 2020 29 90M18S = 2301 388 GCCAGTTACTGCCATTTTCACAGGCATGAAATGGAGATAACAACAGGAGCGACCGCACAGGCTGCTGAGCGCGGCACACGCAGCCCTCGCCGCGCCCCGGGGGAGTAC @BEFFFFFEJGCJJFGGHIJGJHIIKGIFJFGICCIKHHGEHKFIJJGJJALHLAGIDJEDFGHABFC>>1*128CBC:/1-=&1$1*'($('92%$#(7&%$%,%1. MD:Z:21G51T11A4 RG:Z:ERR013140 AM:i:29 NM:i:3 SM:i:29 MQ:i:29 XT:A:M BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR242983.1365156 163 17 2021 60 100M = 2397 475 CCAGTTACTGCCATTTTCACAGGCATGAAATGGAGATAACAACAGGAGCGACCGCACAGGCTGCTGAGCGCGTCACACGCAGCCATCGCGCAGCTCAGGG AAEHDDDGHIJHHGEDFJHHHKFIHGIDHGGGHHLHGEIJFHIILIGLGADHG@JGJHLILGJK>JGKKBJBEJFIHEAJHJIFFFIAJAHCJ=GHBEFB X0:i:1 X1:i:0 MD:Z:20G79 RG:Z:ERR242983 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@DB +ERR162875.23402552 83 17 2021 60 100M = 1882 -238 CCAGTTACTGCCATTTTCACAGGCATGAAATGGAGATAACAACAGGAGCGACCGCACAGGCTGCTGAGCGCGTCACACGCAGCCATCGCGCAGCTCAGGG :BFFBFBKIJKLHIIIFMDLKJKLIGEHHIIMMMMJIHIHHINLLLFJDLEJCKL;LHLILJCMJKJKCJCIILGKEDIHKIJJGHBIBHHIGIFHHCBB X0:i:1 X1:i:0 MD:Z:20G79 RG:Z:ERR162875 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@B +ERR162875.5605685 1107 17 2021 60 100M = 1882 -238 CCAGTTACTGCCATTTTCACAGGCATGAAATGGAGATAACAACAGGAGCGACCGCACAGGCTGCTGAGCGCGTCACACGCAGCCATCGCGCAGCTCAGGG CFH>B6BII68FHC>B@@GLFJKFHCA?FIDIKLMJDC:LH9HLKGHFAM;JC2LHJHLILHIMFIKFADCFEKHKIE?HKKDJHHBIBHIIGFEHGCBB X0:i:1 X1:i:0 MD:Z:20G79 RG:Z:ERR162875 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:AA@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@B +ERR156632.16941332 83 17 2041 60 100M = 1735 -405 GGGCATGAAATGGAGATAACAACAGGAGCGACCGCACAGGCTGCTGAGCGCGTCACACGCAGCCATCGCGCAGCTCAGGGATATTACGTGTAACTCGACA ?EEGEHIEFHCJKKJIGGFLHHLKLKILELHCEIHHLJLCMJLMKNLJDLEKKI=IHEKLKJKLIKCLDLLKKNILLLLLHHIJIHDIJHHGFIHAHFED X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR156632 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@C@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243059.892087 147 17 2042 60 100M = 1719 -422 GGCATGAAATGGAGATAACAACAGGAGCGACCGCACAGGCTGCTGAGCGCGTCACACGCAGCCATCGCGCAGCTCAGGGATATTACGTGTAACTCGACAT DFGDEHEDHEHJHJHFGFJEFKGIKKIBKEDAJIDIJJJJHIJHJIHAIAFIKFG>@JFJJHJGFBJAJIJJHHJHHGLIFHIFF@GGHEGEJF@IDGB@ X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243059 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:FH@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR242991.1183757 83 17 2047 60 100M = 1719 -427 GAAATGGAGATAACAACAGGAGCGACCGCACAGGCTGCTGAGCGCGTCACACGCAGCCATCGCGCAGCTCAGGGATATTACGTGTAACTCGACATGTCAG EB?CDGDKK?KHJGKE:KFJHBBGBJEJ?J?BJK>IHJDH@H?GDDHGEHIHHHD>CADE@EHHEDEJFADFIEEEDGD? X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR242991 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR242991.1577744 1107 17 2047 60 100M = 1719 -427 GAAATGGAGATAACAACAGGAGCGACCGCACAGGCTGCTGAGCGCGTCACACGCAGCCATCGCGCAGCTCAGGGATATTACGTGTAACTCGACATGTCAG 0@?C7GAGIE@FHAC?HJGK X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR242991 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243031.1324865 147 17 2047 60 100M = 1847 -299 GAAATGGAGATAACAACAGGAGCGACCGCACAGGCTGCTGAGCGCGTCACACGCAGCCATCGCGCAGCTCAGGGATATTACGTGTAACTCGACATGTCAG ECCE@GEIJGEFBIFFJHKHJHAIHIBKJFILIGKIKKHJKJBJAIFIGKEAJKJIKIHGAIAJLKLKGKIIHIHDHGFF@GGHEFDKGAIEIFFGEHDA X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243031 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162872.17554044 147 17 2053 60 100M = 1863 -289 GAGATAACAACAGGAGCGACCGCACAGGCTGCTGAGCGCGTCACACGCAGCCATCGCGCAGCTCAGGGATATTACGTGTAACTCGACATGTCAGCGATTG EGGEE?GJIIKLKKLLDLIKEKLJLLLLNKKMK?JLEMBIIMEMGELMJLJLIJDLDMLMKKIKLJLLJIIJJICIJJIEHLICKIK=HFIKJJCHFECD X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162872 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162872.360692 99 17 2070 60 100M = 2206 235 GACCGCACAGGCTGCTGAGCGCGTCACACGCAGCCATCGCGCAGCTCAGGGATATTACGTGTAACTCGACATGTCAGCGATTGTCACAGGCACTGCTACT 8DDB5DF:E=?BH;GKDFK5B?)GAF6@H2CIL?KF;J>JC3E8GHK?@.42I4BGHE7AC. X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162872 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162872.10955775 99 17 2073 60 100M = 2419 445 CGCACAGGCTGCTGAGCGCGTCACACGCAGCCATCGCGCAGCTCAGGGATATTACGTGTAACTCGACATGTCAGCGATTGTCACAGGCACTGCTACTCCT B?EEDEHEFHHHHIHIECJCHGHDIFACGKI7CGAD62LHLCHH6?IG3@CJCHF@K@:HIFLH8G@IHG1KEE@CG58@/HHJ@JJF@C@5JCFAHGF; X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162872 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR242979.559120 99 17 2075 60 100M = 2431 455 CACAGGCTGCTGAGCGCGTCACACGCAGCCATCGCGCAGCTCAGGGATATTACGTGTAACTCGACATGTCAGCGATTGTCACAGGCACTGCTACTCCTGG @CEEIGHHIIGIEJIBIBFJHGEGAIGOJDGHIBJAIDKJHKHJGJFGDHHEJCGIFEJGKLBFJHGJFHGKJCEHGHGLGIHKIKGMIKHHDGGEFDEG X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR242979 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@GL +ERR162872.17357143 83 17 2079 60 100M = 1931 -247 GGCTGCTGAGCGCGTCACACGCAGCCATCGCGCAGCTCAGGGATATTACGTGTAACTCGACATGTCAGCGATTGTCACAGGCACTGCTACTCCTGGGGTT AGFFIIFKH5=?DIJI>JBCKJLLIDHGDLEIMLEMGLIKJLIHHKIDCHIKJIFMJ?JHMIHJJMLBEI@IGBGJGKKJIKGKHIKHF>CBIFFEEE?B X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162872 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@B@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@AG +ERR243063.1642219 1123 17 2084 60 100M = 2462 477 CTGAGCGCGTCACACGCAGCCATCGCGCAGCTCAGGGATATTACGTGTAACTCGACATGTCAGCGATTGTCACAGGCACTGCTACTCCTGGGGTTTTCCA AEDEIGEAFECKHI-ACAGHI=HHHEFKB@HH1..F8=;76D4 X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243063 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243063.246578 99 17 2084 60 100M = 2462 477 CTGAGCGCGTCACACGCAGCCATCGCGCAGCTCAGGGATATTACGTGTAACTCGACATGTCAGCGATTGTCACAGGCACTGCTACTCCTGGGGTTTTCCA AEGFIB@H@IJEHGICJGKIHHGJAI@JBHJDKDJEHHCE>B?HBAKFEHIGIAFHHHH@JHJHAFEEIFKFIHIGDIJJJHHEJIIHCIEFBAFABF=B X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243063 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR013140.8706087 83 17 2105 60 28S80M = 1811 -373 CGGGCGGGTGGGCGCTGCACACGCAGGCGTCGCGCAGCTCAGGGATATTACGTGTAACTCGACATGTCAGCGATTGTCACAGGCACTGCTACTCCTGGGGTTTTCCAT $$$&$$%&%%#(1-5-(4.=5:C=.&%8%C:F?CFH=GFCG@G?DAFFCB;=G5?.@BDGHACAGGDGCJGDECJHHDHHHFABA= X0:i:1 X1:i:0 XC:i:80 MD:Z:0A79 RG:Z:ERR013140 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR242999.1001077 99 17 2110 60 100M = 2438 427 GCAGCTCAGGGATATTACGTGTAACTCGACATGTCAGCGATTGTCACAGGCACTGCTACTCCTGGGGTTTTCCATCAAACCCTCAAGAGCTGGGCCTGGG @CEGFFGFIGGEFEGDEIAEIEEFIJJBGHFEJFJHKJBGGEJCI=IFLDHHHJJKJDIKLIIIFIID>G7DIHGIGJIIEIIJHGJFKKHGHGDGFFF= X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR242999 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@HKC +ERR013140.30331713 163 17 2120 60 108M = 2444 431 GATATTACGTGTAACTCGACATGTCAGCGATTGTCACAGGCACTGCTACTCCTGGGGTTTTCCATCAAACCCTCAAGAGCTGGGCCTGGGGTCAACTTCCGGCCTGGG :DCCA?CC9FEDCGEI@@CFHGIBIEDB?EBDDEIIDIL=>FGE>DCDBFH;@ADBBC;=ADAC==CBBBC1;;A?BC>?FD>BF:DD8>/47=:AB:94;?@9DC?B X0:i:1 X1:i:0 MD:Z:108 RG:Z:ERR013140 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@EDH +ERR242975.806680 83 17 2127 60 100M = 1953 -273 CGTGTAACTCGACATGTCAGCGATTGTCACAGGCACTGCTACTCCTGGGGTTTTCCATCAAACCCTCAAGAGCTGGGCCTGGGGTCAACTTCCAGCCTGG ;CC>7<34<7=;.9??EECCH=FABGGFHHLJIIFHIHILJJJLLLLKIIHIKLLKJIHKGHGKHHIHKJKJGJIJHGIHFEFFFCB@@ X0:i:1 X1:i:0 MD:Z:58G49 RG:Z:ERR013140 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243007.241318 83 17 2171 60 100M = 1823 -447 CTGGGGTTTTCCATCAAACCCTCAAGAGCTGGGCCTGGGGTCAACTTCCGGCCTGGGGAAACTGGGGCAAGTATCACCAGAGATGAGCTTTATAAAAATA CADB=EDBCB,H8GG2:08@HHFAI1;DCGG1HG=@CLAA?IG>GEFG=GHF?EH@>HGFGEDAHIEF9FDECDCCIBAHI>MGF3<0GFFA;6HC==;@6:H950BCG6>:E?BE:CGDFH?CDACDH2HJ;>HGA>CH:I>BD@BC=4ADA? X0:i:1 X1:i:0 MD:Z:49G50 RG:Z:ERR243039 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:B@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A +ERR243031.1705886 147 17 2179 60 100M = 1881 -397 TTCCATCAAACCCTCAAGAGCTGGGCCTGGGGTCAACTTCCAGCCTGGGGAAACTGGGGCAAGTATCACCAGAGATGAGCTTTATAAAAATAATGGTGCT @D:EFEGCFEI@KHJDJIJHKHHGKIKFHIJIHKFELHGFJJJHKHGIIKEDFKIGHJJJFKIGJIJCIKIJIIHGIIIKFGEGEFEDGHEEFHGGFFEA X0:i:1 X1:i:0 MD:Z:41G58 RG:Z:ERR243031 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:CF@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243007.1719649 99 17 2188 60 100M = 2533 444 ACCCTCAAGAGCTGGGCCTGGGGTCAACTTCCAGCCTGGGGAAACTGGGGCAAGTATCACCAGAGATGAGCTTTATAAAAATAATGGTGCTAGCTGGGCA ?CC@FGEFIFIHHH>EHGIHH?CEIGCHIBJGEJHIHIHDFGFHGFCEGHHGHKEEGIGDHHJGLGGJIDJJCE=GGGG?IHC@HEDAIIGDIHFGGED@ X0:i:1 X1:i:0 MD:Z:32G67 RG:Z:ERR243007 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243015.41290 83 17 2189 17 100M = 1834 -454 CCCTCAAGACCTGGGCCTGGCCACAACTTCCGTCCTGGGCAAACTGGGGCAATTATCACCAGAGACGAGCTTTATAAAAATAATGGTGCTAGCTGGGCAT @9>7D(.@B&.A111//.(4':-E4=/7,.),'DB=;0)1E<-E<<=3*1$B%'C/D-JH>H1-4*=1+>8DHCEHHHFH9GIJBIHGFDFF>GFJFKAG>IIKKK=GHJGAICEB@ X0:i:1 X1:i:0 MD:Z:14G85 RG:Z:ERR162872 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@B +ERR013140.20581831 99 17 2212 60 108M = 2526 421 CAACTTCCGGCCTGGGGAAACTGGGGCAAGTATCACCAGAGATGAGCTTTATAAAAATAATGGTGCTAGCTGGGCATGGTGGCTTGCACCTGTAATCCCAGCACTTTG @CEBIFHI>HHJJHIIIJJJGKHIIJIKJIGHGJKHLKIJJKHILJJLFIFGFDFEHJEGHJHGJKLIJFIGEFGLHJKGJJGHBGGG>AHGFCBB?99=EBC=C70> X0:i:1 X1:i:0 MD:Z:108 RG:Z:ERR013140 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR156632.15198869 147 17 2229 60 100M = 1987 -341 AAACTGGGGCAAGTATCACCAGAGATGAGCTTTATAAAAATAATGGTGCTAGCTGGGCATGGTGGCTTGCACCTGTAATCCCAGCACTTTGGGAGGCCGA @BAHGDDDIKBKJ7HDJEKKHLLJIIJKGLHFJHHIHFFIEGCGCEILLHKJBBFKKIIIKIIKJLEJEKGJLFGFFFGIIJJJJFJGHGGIFHEDD?DB X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR156632 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162875.4987821 83 17 2242 60 100M = 1996 -345 TATCACCAGAGATGAGCTTTATAAAAATAATGGTGCTAGCTGGGCATGGTGGCTTGCACCTGTAATCCCAGCACTTTGGGAGGCCGAGCTAGGAGGATCG DCDFHFIIHJIHIKJKKDIGIHGGHIJBIIDMKHKMIKKMIKLILHJLIJLJNKIKLFKJJGIHJHJHLJKLFLIHIJKJKIKHCHJIJFIHGIEFFE?A X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162875 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243011.1711788 83 17 2265 60 100M = 1951 -413 AAAATAATGGTGCTAGCTGGGCATGGTGGCTTGCACCTGTAATCCCAGCACTTTGGGAGGCCGAGCTAGGAGGATCGTTTGAGTCCAGCAGTTTGAGACC ?2B=,;EB04@BJ=:D9.40=I;:497E12=JHA;9:00>JA12FB@1D;: X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243011 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:F@G@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243079.862248 147 17 2274 60 100M = 1921 -452 GTGCTAGCTGGGCATGGTGGCTTGCACCTGTAATCCCAGCACTTTGGGAGGCCGAGCTAGGAGGATCGTTTGAGTCCAGCAGTTTGAGACCAGCCTGGCC CCC@?GEF4H:IE8G0JD269>G6H@/EFE6EGE?=DBII;;A2-G@;GJ7?8H;HGEJGLIFDF@>,H=ADDH:=EF;?F;@FFIG?EGGHF>FDCF9? X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243079 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162872.7043507 163 17 2276 60 100M = 2525 348 GCTAGCTGGGCATGGTGGCTTGCACCTGTAATCCCAGCACTTTGGGAGGCCGAGCTAGGAGGATCGTTTGAGTCCAGCAGTTTGAGACCAGCCTGGCCAA ECHBIJJJIJKHI?HILJJKGILGKLHIGJJJILGHKJEIMHHM?JJMJK5B*ILLINGILKJGKDFIDFEHILEJG=JMCEHAAIJ2JIJ@K8JFFG<( X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162872 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR245024.1210272 83 17 2280 60 100M = 1962 -417 GCTGGGCATGGTGGCTTGCACCTGTAATCCCAGCACTTTGGGAGGCCGAGCTAGGAGGATCGTTTGAGTCCAGCAGTTTGAGACCAGCCTGGCCAATACG 6FCDCGI:FF@@HGAI@IEE&<@:E@;GE;JJKF2GIJHHGJBH7I@F=IDAIH;BHFAG@BIFFGHBB@F?F@IE:HGEH@:CEDHBFF@FFEGCAH;GDFFGDGDBF?C;IFIFFGB?EAA>?I?;H8DAHHAH7GBA2DIH6HHDEBA>EFE=C X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243019 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@GBI +ERR242975.1004165 83 17 2290 60 100M = 1881 -508 GTGGCTTGCACCTGTAATCCCAGCACTTTGGGAGGCCGAGCTAGGAGGATCGTTTGAGTCCAGCAGTTTGAGACCAGCCTGGCCAATACGGCAAAACCCA DCCD;BFHHDHIGGF@D@IGIIIJEBEHGHIJJFJIBIHFLFIHJJHHGGAIHHFIKICIJKJHHGGGEIIIEIIIHHKGHHDIEGDDAGHGCCBEABD? X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR242975 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243019.556608 83 17 2294 60 100M = 1851 -542 CTTGCACCTGTAATCCCAGCACTTTGGGAGGCCGAGCTAGGAGGATCGTTTGAGTCCAGCAGTTTGAGACCAGCCTGGCCAATACGGCAAAACCCAGTCT D?DEEBFEEECF9DHDIGJIEC;BHHAADIK;@KJIKFIFLHJKGD@HGHHFFJEGHCCJGGGGHKDH>GIFHIJGGHIFEFEGAHHHDDDFBEFGDDF? X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243019 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR013140.21458070 147 17 2301 29 108M = 2020 -388 CTGTAATCACAGCACTTTGGGAGGCGGAGCTAGGAGGATCGTTTGAGTCCAGCAGTTTGAGACCAGCCTGGCCAATACGGCAAAACCCAGTCTCTACAAAAAATACAA 920<'/7<1>?48/307$9C721:2$2A/9<226;<66=5?@?:6?AC=>=3DD?-?@E9BB@CBA@;?FDCDC:DEFCACC@FCCC?BBA=ABB@?: X0:i:1 X1:i:0 MD:Z:8C16C82 RG:Z:ERR013140 AM:i:29 NM:i:2 SM:i:29 MQ:i:29 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A@ +ERR162872.23671856 163 17 2311 60 100M = 2618 406 AGCACTTTGGGAGGCCGAGCTAGGAGGATCGTTTGAGTCCAGCAGTTTGAGACCAGCCTGGCCAATACGGCAAAACCCAGTCTCTACAAAAAATACAAAA BEGGFJGFLJIHLILKDGKKMIMKGMJHHLEHIGLJKJMKJMMIMHJHLIKKKLJLKMLKILLICHJKEJGFJJIGLLEMFKJLLHJJHIIHC?DFEFDD X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162872 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@GKKL +ERR245038.798432 147 17 2312 60 100M = 1958 -453 GCACTTTGGGAGGCCGAGCTAGGAGGATCGTTTGAGTCCAGCAGTTTGAGACCAGCCTGGCCAATACGGCAAAACCCAGTCTCTACAAAAAATACAAAAA BE?GE3FEGGDGE9>KI5HDFGIGI6:EAIG4IID9:GG@J;HHH@EIHJ?@F=JCFFHIJHDEE5>IKJFDDEFHIBHGHFGEEHEFECEGEEID@B?> X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR245038 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@FEHGG +ERR242971.738250 83 17 2315 60 100M = 1883 -531 CTTTGGGAGGCCGAGCTAGGAGGATCGTTTGAGTCCAGCAGTTTGAGACCAGCCTGGCCAATACGGCAAAACCCAGTCTCTACAAAAAATACAAAAAACA ECAAEGDGDHG=6DIKAIIJHHIE7@9FH;JHGHIEDKGJGHGFAEFEHJEIJJGJHIJFGECAHIFFFAEHIJIHEIGIDEHFFDEAECEHDCDBBEE? X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR242971 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A +ERR245024.420543 83 17 2317 60 100M = 1999 -417 TTGGGAGGCCGAGCTAGGAGGATCGTTTGAGTCCAGCAGTTTGAGACCAGCCTGGCCAATACGGCAAAACCCAGTCTCTACAAAAAATACAAAAAACAAC DCEEHEC?F?FEC:88FAA X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR245024 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:FE@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR242955.454193 83 17 2322 60 100M = 1904 -517 AGGCCGAGCTAGGAGGATCGTTTGAGTCCAGCAGTTTGAGACCAGCCTGGCCAATACGGCAAAACCCAGTCTCTACAAAAAATACAAAAAACAACTAGCC :D)8=CE3J??7E+:9I59BEI5H<@E8A?GD2HJHHFHFFHFJFCACAE+IEFD>HIHF=DJDFB?I8A@AFGDEIEFECDDICCHAEE;? X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR242955 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243059.1325819 99 17 2332 60 100M = 2706 473 AGGAGGATCGTTTGAGTCCAGCAGTTTGAGACCAGCCTGGCCAATACGGCAAAACCCAGTCTCTACAAAAAATACAAAAAACAACTAGCCAGGCGTGGTG ?E@CH@E@G@ECBGGHEIGFIIFI?FCIE?CDBEIIHBI:@>F@F@D:IGHHGAJHJF9HFEE8GGC:0?2;2073>C@=@B7980@<8;:=82?2=?;3+>=D??34$1C#%*3<&4)67;39, X0:i:1 X1:i:0 MD:Z:83T7A16 RG:Z:ERR013140 AM:i:37 NM:i:2 SM:i:37 MQ:i:60 XT:A:U BQ:Z:ABC@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162875.5601349 163 17 2389 60 100M = 2710 420 AGTCTCTACAAAAAATACAAAAAACAACTAGCCAGGCGTGGTGGTGCACACCTGTAGTCCCAGCTACTCAGGAGGCTGAGGGGGAAGGACTGCTTGAGCC BFFHJIJHIIIIHIEIIJIJJIJHJJIJNIKLKHNKMEIMLGMKFILIJIKKMMIIMIMLLJNLLEJLKILIINHLLLALKKBIHILKJIKJHIFHFFFC X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162875 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@HH +ERR242983.1365156 83 17 2397 60 100M = 2021 -475 CAAAAAATACAAAAAACAACTAGCCAGGCGTGGTGGTGCACACCTGTAGTCCCAGCTACTCAGGAGGCTGAGGGGGAAGGACTGCTTGAGCCCAGGAGTT ;BABAEE>DJEFECBDBC:CE>A8C>C>7DBA=BEDDB4=9;:@=;@D@@=B@E.3?972<>6@8=>?1$0:95%5%*1=8;0%4<228% X0:i:1 X1:i:0 XC:i:88 MD:Z:88 RG:Z:ERR013140 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:EHG@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243035.1445358 99 17 2405 60 100M = 2748 442 ACAAAAAACAACTAGCCAGGCGTGGTGGTGCACACCTGTAGTCCCAGCTACTCAGGAGGCTGAGGGGGAAGGACTGCTTGAGCCCAGGAGTTTGAGGCTG @CFEEFGFGGGIGEJIHHKFKADLGAJFELIEIHJIHJEELFJIIGKHIHGJJIKGFKJKJJGLHGJHHHLHHIEJJJEIFMKJIHJFFLFEEIAHGF@> X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243035 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162872.22794881 99 17 2407 60 100M = 2639 331 AAAAAACAACTAGCCAGGCGTGGTGGTGCACACCTGTAGTCCCAGCTACTCAGGAGGCTGAGGGGGAAGGACTGCTTGAGCCCAGGAGTTTGAGGCTGCT @BCCDBEFCFHAIGFHI@JAHK2>F:E;C>HIIKFF>CLCK;&+B2M4CLG=EHE+FH(+(F/'60.JB+),FB04 MD:Z:16T3G14C6T3G2G2G13G3G0A2C3G0A6G6G1G4 RG:Z:ERR162872 AM:i:29 NM:i:16 SM:i:29 MQ:i:29 XT:A:M BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162875.10770274 163 17 2415 60 100M = 2690 374 ACTAGCCAGGCGTGGTGGTGCACACCTGTAGTCCCAGCTACTCAGGAGGCTGAGGGGGAAGGACTGCTTGAGCCCAGGAGTTTGAGGCTGCTGTGAGCTG ECHFJHIHLIKEIKJIKIHLKIJIKJKLFIMGLIMKNILHJIJINKJL@KMLIMKJKKIKM?JJFMKLHKKLKJIKNKGLFJIIJMJHLKKJIGJEIGFB X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162875 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162872.10955775 147 17 2419 60 100M = 2073 -445 GCCATGCGTGGTTGTGCACACCTGTAGTCCCAGCTACTCAGGAGGCTGAGGGGGAAGGACTGCTTGAGCCCAGGAGTTTGAGGCTGCTGTGAGCTGTGAT '9DA,J8DDL:>+JIILCKCKLJ6>LCJBCIKLAEHII;MJJKKEI?KJLKLELIGDMGLIJKHJLGDKKLJ6KLGIJIFJJHLIJKFIIFKJHHFEFAE X0:i:1 X1:i:0 MD:Z:4G7G87 RG:Z:ERR162872 AM:i:37 NM:i:2 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR242979.559120 147 17 2431 60 100M = 2075 -455 GGTGCACACCTGTAGTCCCAGCTACTCAGGAGGCTGAGGGGGAAGGACTGCTTGAGCCCAGGAGTTTGAGGCTGCTGTGAGCTGTGATCGCATCACTGCA @ADGG@H2ILDCEIH7HIHGKKEDJFGJIKJHIJGKHHIFHJEIJJCKJIJJGJGHJGIIGJIFIHHKIGKJGDJGGFJIHJGIFJGF@HIFEHCHEEF? X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR242979 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243027.576419 99 17 2434 60 100M = 2778 443 GCACACCTGTAGTCCCAGCTACTCAGGAGGCTGAGGGGGAAGGACTGCTTGAGCCCAGGAGTTTGAGGCTGCTGTGAGCTGTGATCGCATCACTGCATTC >DB@DDFIEFD;BH;?BHFEF?:JECGBHE1;9EIK.F1:G-DAH9I,.=>EF9D@E X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243027 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@G +ERR242999.1001077 147 17 2438 60 100M = 2110 -427 ACCTGTAGTCCCAGCTACTCAGGAGGCTGAGGGGGAAGGACTGCTTGAGCCCAGGAGTTTGAGGCTGCTGTGAGCTGTGATCGCATCACTGCATTCCAGC 5CJDGDHGCIHIBJJDEGEJIJHKHJLIIIHJHGFGHHJEMJBKHIHIKHNKDGIKIIFIIJIJJIJKHIFKGKKHIGJGHBIIFGJEHGIIDFGDGFCA X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR242999 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@C +ERR013140.30331713 83 17 2444 60 108M = 2120 -431 AGTCCCAGCTACTCAGGAGGCTGAGGGGGAAGGACTGCTTGAGCCCAGGAGTTTGAGGCTGCTGTGAGCTGTGATCGCATCACTGCATTCCAGCCCGGTGACAGAGTG 938:(A@??<8>>>GBGIEFFIGDHLGKJDLIKGFJIGKLKJKCIEJ@LJDIELKLLKJLJFLHKKLJIKGKKHK@GIGKIDIJIHGJJIHKIIF?JEIHFGIHFAC@ X0:i:1 X1:i:0 MD:Z:108 RG:Z:ERR013140 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162872.474429 99 17 2447 60 100M = 2812 464 CCCAGCTACTCAGGAGGCTGAGGGGGAAGGACTGCTTGAGCCCAGGAGTTTGAGGCTGCTGTGAGCTGTGATCGCATCACTGCATTCCAGCCCGGTGACA BAD5=FHEGHFFHIBC;HFJGKD1JIFGHIHJKJIKGKGK2F?BMHE9,HEDK9HFKJFELHJ2BJL.0@FHC1K3DE3ELE=GGBEBIFB6BA9CE9?1 X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162872 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:A@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162872.12579188 83 17 2456 60 100M = 2147 -408 TCAGGAGGCTGAGGGGGAAGGACTGCTTGAGCCCAGGAGTTTGAGGCTGCTGTGAGCTGTGATCGCATCACTGCATTCCAGCCCGGTGACAGAGTGAGTC ;DGGIIGJKILJGKJJHGKKJHM?JLEIKMMKGLMLMLKIGJMKJLMELIIJIMIKMIHIJJHEKKGILHKGLKIIJIKKIJJCJIHIGIIHIFFFHDCB X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162872 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243063.1642219 1171 17 2462 60 100M = 2084 -477 GGCTGAGGGGGAAGGACTGCTTGAGCCCAGGAGTTTGAGGCTGCTGTGAGCTGTGATCGCATCACTGCATTCCAGCCCGGTGACAGAGTGAGTCACTGTC DF8AH9?GHHCGCHJBKAIK>HJDC=HCIIJFGGAEJGIJKCADDIAI:IC8H9HDB?IG@GC=;87GAHB=G>H;2@GEHIFGHBGGFFFFDGDHDDB: X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243063 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:BA@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243063.246578 147 17 2462 60 100M = 2084 -477 GGCTGAGGGGGAAGGACTGCTTGAGCCCAGGAGTTTGAGGCTGCTGTGAGCTGTGATCGCATCACTGCATTCCAGCCCGGTGACAGAGTGAGTCACTGTC A@G;HFFFFF9CHHHFDEE@3HJHI/HIIDJJH?DGDFIJJHIKEIGIHDKEGCCDE?EGEGHBK?IFFABEGJCH2@GEHIEGHHGGF>HFGDDB? X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243063 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162872.7043507 83 17 2525 60 100M = 2276 -348 ACTGCATTCCAGCCCGGTGACAGAGTGAGTCACTGTCTCGAAAAAGAAAGGAAGAAATAAAGAAAACAAATAAAAATAATAGTGCAGACAAAAGGCCTTG KCJIE;J@>LIKJLLIJMKIFLHKJLEJIEKHHBHKKIGLLKILMIGKDHGMMGGHGHGGJHHGHHJHDHFLIIJJGJFIFEEIGGBHCDB X0:i:1 X1:i:0 MD:Z:39A60 RG:Z:ERR162872 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR013140.20581831 147 17 2526 60 108M = 2212 -421 CTGCATTCCAGCCCGGTGACAGAGTGAGTCACTGTCTCAAAAAAGAAAGGAAGAAATAAAGAAAACAAATAAAAATAATAGTGCAGACAAAAGGCCTTGACCCATCTA @EBBBAC@DG@C@6FCHEEDEBH=B>EECCFDGBCC@FFFHGGKDFGLEKFKDFFI@FFHFFFEIJFFIAEEEEHDDHHGGFJIIIHIDDDIIIJJHGFEHGCBEFB: X0:i:1 X1:i:0 MD:Z:108 RG:Z:ERR013140 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243007.1719649 147 17 2533 60 100M = 2188 -444 CCAGCCCGGTGACAGAGTGAGTCACTGTCTCGAAAAAGAAAGGAAGAAATAAAGAAAACAAATAAAAATAATAGTGCAGACAAAAGGCCTTGACCCATCT DEFHGFAGHHJDJGGJIHKIIFH>LHHF<9CFEGFEJKFEJJJHKIFBGFFHIKFHEEIFGGFEEFEICDHFJHHJIIJFJEFEJIIEJFGIEEEIEDF@ X0:i:1 X1:i:0 MD:Z:31A68 RG:Z:ERR243007 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:B@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR156632.5990783 163 17 2544 60 100M = 2843 398 ACAGAGTGAGTCACTGTCTCGAAAAAGAAAGGAAGAAATAAAGAAAACAAATAAAAATAATAGTGCAGACAAAAGGCCTTGACCCATCTAGCTTTGGCCC BCFGFHFHGGFIGHJIGJIIBIHHIILGIFLJGIKIIIFIEGHJIIKIHIJHJIJJJIIIHGLHMCJMKJJHIILFKKLHLKJJ?FHLKHLIKF=D=GED X0:i:1 X1:i:0 MD:Z:20A79 RG:Z:ERR156632 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@BCD +ERR243019.804639 83 17 2558 60 100M = 2190 -467 TGTCTCAAAAAAGAAAGGAAGAAATAAAGAAAACAAATAAAAATAATAGTGCAGACAAAAGGCCTTGACCCATCTAGCTTTGGCCCTCAGCATCAACCGC DEDIAFDFFFCHJCBCGKDJMFGGAFHCLFDDEKFGH@FGGHHFEIDIHIICIJCJGFFIGJGJGCK@HGIGFHEIIHEGGHIGGJGHIHIFFCBEA>D? X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243019 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162872.17163139 163 17 2564 60 100M = 2828 363 AAAAAAGAAAGGAAGAAATAAAGAAAACAAATAAAAATAATAGTGCAGACAAAAGGCCTTGACCCATCTAGCTTTGGCCCTCAGCATCAACCGCTAGATA EACFFGJHHIHI3IMIGIJI>>GJIJKKJ?JKBJIJHIJIHIMHMJJMKJJAFKMJKMNHMKJM=GKMKINLLIHI>LKGKMJIKGIHJIJGCIJ?HFD- X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162872 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:GCDEDB@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243019.1623189 83 17 2569 60 100M = 2285 -383 AGAAAGGAAGAAATAAAGAAAACAAATAAAAATAATAGTGCAGACAAAAGGCCTTGACCCATCTAGCTTTGGCCCTCAGCATCAACCGCTAGATACGTCC EA?C?F>=D@;FBFBGFD?B?AH8H?6@G4JDIIGEFFF:C9@@CDGHCCE X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243019 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@C +ERR243091.852212 163 17 2575 60 100M = 2967 491 GAAGAAATAAAGAAAACAAATAAAAATAATAGTGCAGACAAAAGGCCTTGACCCATCTAGCTTTGGCCCTCAGCATCAACCGCTAGATACGTCCCTCCCT ACDHFEFGDGEJGDIHHHDIHDEGIHCFHHD7=:@<&I4L;C?/AJ9JK>J2DHKAK5,H29=,=0,E9?H.GKJGE78&,6A X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR156632 AM:i:29 NM:i:0 SM:i:29 MQ:i:29 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162875.20693133 99 17 2588 60 100M = 2892 403 AAACAAATAAAAATAATAGTGCAGACAAAAGGCCTTGACCCATCTAGCTTTGGCCCTCAGCATCAACCGCTAGATACGTCCCTCCCTTTCTTCTGGGGCA A:CEECDFEDGGHGF@GE<=D2F?BF?>HICFH7EJIKHHCIGFEF@BJHFKJGEHDCLGEHHIFGGHHIGIFDKDIJGEJJHJGJHFKHFDF>JEE?GDCEB X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243007 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR156632.12418699 163 17 2634 60 100M = 2962 427 GCTTTGGCCCTCAGCATCAACCGCTAGATACGTCCCTCCCTTTCTTCTGGGGCACAGGTCACACTCTCTTCCAGGTCTAGGATGCAGCTGAGGGGTGCCC BDGBCGEHGHHIGJGHFJHIIKDIHHIGIIICHKJKFKLKKF@KMDKJJKJJLIEHMK=KIJJEMMJKIHLJJKJILKJJKHHJJJFHKIIJAIGFH9E> X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR156632 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@JD +ERR013140.12984374 147 17 2636 60 108M = 2382 -361 TTTGGCCCTCAGCATCAACCGCTAGATACGTCCCTCCCTTTCTTCTGGGGCACAGGTCACACTCTCTTCCAGGTCTAGGATGCAGCTGAGGGGTGCCCCTCTTACCAT '??98:CD@B<CDI@CCF;>DEFCACDD?@BDCFBFFEAB?>BDGACDDECDCEDFAADDFBB@CHFJICIJIEECDFEADGDHHCAJBDBDA>CA@9 X0:i:1 X1:i:0 MD:Z:108 RG:Z:ERR013140 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162872.22794881 147 17 2639 60 100M = 2407 -331 GGCCCTCAGCATCAACCGCTAGATACGTCCCTCCCTTTCTTCTGGGGCACAGGTCACACTCTCTTCCAGGTCTAGGATGCAGCTGAGGGGTGCCCCTCTT 6?.97*GGD:-:810C?IIEJKBCFDJ>HCFFGEIFIGJ:JCJJE@:2>@2+4B>E>BBDDDAD@DE:=D9CGD;'A X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162875 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@B +ERR242943.312088 163 17 2694 60 100M = 3037 442 ACACTCTCTTCCAGGTCTAGGATGCAGCTGAGGGGTGCCCCTCTTACCATCTAATCTGTGCCCTTATTTCCTCTGCTTTAGTGAGGAAGAGGCCCCTGGT ABEEHHIIGEIHGL9FIIEMEFGKJHJIGKEJGEHDKJIDFDIHEGIGFGLKEIGHJJEGJIACGDHGFJHCHIIIIFDELGIF9HFD;EKFHFFEEFC. X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR242943 AM:i:25 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162875.5443750 99 17 2699 60 100M = 3006 406 CTCTTCCAGGTCTAGGATGCAGCTGAGGGGTGCCCCTCTTACCATCTAATCTGTGCCCTTATTTCCTCTGCTTTAGTGAGGAAGAGGCCCCTGGTCCATG AAFG?FE9<3/IDDJIHBDEIL5;JHGH:/>LJHD?JH@F*CJ8H@.GII>IHB:EJL82B81I7?BA?E;8H>;J:CHK@2(HDH.7C/47.48A(+8; X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162875 AM:i:25 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243059.1325819 147 17 2706 60 100M = 2332 -473 AGGTCTAGGATGCAGCTGAGGGGTGCCCCTCTTACCATCTAATCTGTGCCCTTATTTCCTCTGCTTTAGTGAGGAAGAGGCCCCTGGTCCATGAAGGGGC 2DDDGDFFH?DIIIGHGJAHGJJ;JJ8HJ>IIBBIJIIJE@GGJHIGIHI>FFDJIEHJFKHJJIH@IHFJIIKFIGICHIHBHHHGFHJFGHDHFFAB@ X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243059 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@B +ERR162875.5601349 83 17 2710 60 100M = 2389 -420 CTAGGATGCAGCTGAGGGGTGCCCCTCTTACCATCTAATCTGTGCCCTTATTTCCTCTGCTTTAGTGAGGAAGAGGCCCCTGGTCCATGAAGGGGCCTTT D@HHHEGEJJJKGKDKJLIJKIJHMGLIIIKKIJMIIJJMIJKJKKOHHGJI@MMIHJIJIGILKHKLKJGLKKKKKJKLIKIHJJGHIEIHGFGDHCBA X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162875 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A +ERR243019.480835 99 17 2711 60 100M = 3135 523 TAGGATGCAGCTGAGGGGTGCCCCTCTTACCATCTAATCTGTGCCCTTATTTCCTCTGCTTTAGTGAGGAAGAGGCCCCTGGTCCATGAAGGGGCCTTTC ??GADDHDFIHIHFJGDDEHIHHGHIHEFHGDEGF?GEHGJEEGHGGFFBFEEFEIIJHH@FFKEIHKIEHHGKHGBIHIHFFIHGHKCGKDHFFEFBCD X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243019 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162872.13634813 147 17 2713 29 100M = 2414 -398 GGATGCAGCTGAGGGGTGCCCCTTTTACCATCTAATCTGTGCCATTATTTCCTCTGCTTTAGTGAGGAAGAGGCCCCTGGTCCATGAAGGGGCCTTTCAG F,7?1D.JK>H@80DJA3.K6LJ%7IHJH85ADIDFB8K8300(66AAGK;;:EEE X0:i:1 X1:i:0 MD:Z:23C19C56 RG:Z:ERR162872 AM:i:29 NM:i:2 SM:i:29 MQ:i:29 XT:A:U BQ:Z:D@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@B +ERR245049.1543898 99 17 2735 60 100M = 3077 441 TCTTACCATCTAATCTGTGCCCTTATTTCCTCTGCTTTAGTGAGGAAGAGGCCCCTGGTCCATGAAGGGGCCTTTCAGAGACGGGGACCCCTGAGGAGCC ?DFABEFFFHHEGGJHIHJIHHHEFGEEJHHIHJIJEF@IGGGJFFFKHKCFHIIIKFFJGHHJIHEMAJJGIGAKIJHGFE5EII76IDG>;?FEAHGIIFFGFE@? X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243035 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243027.576419 147 17 2778 60 100M = 2434 -443 GGAAGAGGCCCCTGGTCCATGAAGGGGCCTTTCAGAGACGGGGCCCCCTGAGGAGCCCCGAGCAGCAGCCGTCGTGTCTCACCCAGGGTGTCTGAAACAG :DCC@>DCC1HBEEBE=>/;:4;>*E?FBGB-IGEC@>BIHH9#F0H+2?@FCI4A>HAGHBEDFIJDHDEDDDJGI>BAECA X0:i:1 X1:i:0 MD:Z:43A56 RG:Z:ERR243027 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162875.1633327 83 17 2786 60 100M = 2618 -267 CCCCTGGTCCATGAAGGGGCCTTTCAGAGACGGGGACCCCTGAGGAGCCCCGAGCAGCAGCCGTCGTGTCTCACCCAGGGTGTCTGAAACAGATGTGGAG =DBCJ@DHEHGJHBIEHHFA':'>:;BHHLKJKJ6=BH7FII->G9DF5?.;*7A0?== X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243067 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:BB@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@B +ERR162872.17163139 83 17 2828 60 100M = 2564 -363 AGGAGCCCCGAGCAGCAGCCGTCGTGTCTCACCCAGGGTGTCTGAAACAGATGTGGAGGTCTCGGGTGAGGCGTGGCTCAGATACAGGGAGTGGCCCACA 4CGHB?HDB8CJDKHLJJJBJHDJHJJMIKAFIEMLKJJJIMJKGIILLMJFJIKJMGJIMGDIKKJHLLHEGFKJLHGKKHGGKJIII?EEGGCCGDEB X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162872 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162872.20228886 99 17 2837 60 100M = 3084 346 GAGCAGCAGCCGTCGTGTCTCACCCAGGGTGTCTGAAACAGATGTGGAGGTCTCGGGTGAGGAGTGGCTCAGATACAGGGAGGGGCCCACAGCTCGGCCT @CG8DHF:=7?5GBAGDGAL9I9JB,BIHHH=5B,8;4M./MK7E/.GL(B.*.88J1FBFJA6CDB;H57L&K:)(GI1B405B.-17) X0:i:1 X1:i:0 MD:Z:62C19T17 RG:Z:ERR162872 AM:i:37 NM:i:2 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR156632.5990783 83 17 2843 60 100M = 2544 -398 CAGCCGTCGTGTCTCACCCAGGGTGTCTGAAACAGATGTGGAGGTCTCGGGTGAGGCGTGGCTCAGATACAGGGAGTGGCCCACAGCTCGGCCTGTCTTT DFEEAFH@HGJHLHKFKJLJLLJKKIMKJFHGIJLIEJJJLGLKDNHCKJKJLKLLEAILHLHJHKIFHLLKLJLEHLKKKKHJJKKICJJGIGEGIEBD X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR156632 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@D +ERR162875.26247502 83 17 2858 60 100M = 2581 -376 ACCCAGGGTGTCTGAAACAGATGTGGAGGTCTCGGGTGAGGCGTGGCTCAGATACAGGGAGTGGCCCACAGCTCGGCCTGTCTTTGAAAGGCCACGTGAC HGGAGICIHGJJEHGJ@E>?ICJAJ@EIIDBIHLBF@IHKI2DKF=EIHKFIHLJDK=CHHDDJ@G:>@C?F;,CGI8G;HDHBJ:BJDGHJ>LIKA*@GIIF@BF::FF1JJBLCJDKGBJJJIFFJIFIIJDJ:IDJJHJGDFB X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162875 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:DE@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162875.13732136 163 17 2900 60 100M = 3298 497 GTGGCTCAGATACAGGGAGTGGCCCACAGCTCGGCCTGTCTTTGAAAGGCCACGTGACCTGGCCCACGGCTGGCAGGTGGGACCCAGCTGCAGGGGTCCA DDHBIJIHLHIHJJLIJIMILKKJLGJ:JKLMBKLJLM?AHFJGIGALJKLHIEIFIEHC94ACB X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR245038 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@D +ERR162872.24480599 99 17 2922 60 100M = 3229 406 CCCACAGCTCGGCCTGTCTTTGAAAGGCCACGTGACCTGGCCCACGGCTGGCAGGTGGGACCCAGCTGCAGGGGTCCAGCAGCACCCACAGCAGCCACCG BADEEEIHHFADFGJKEJHHGCHEBGJHIIECGFKJLLIBJFJGE<.KFA;JHMHBGCFCJMKC7;LKI49J@>1KD2G)BC1AC>KAHF77+4HC3:@$ X0:i:1 X1:i:0 MD:Z:99T0 RG:Z:ERR162872 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:A@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243007.1511398 147 17 2951 60 100M = 2622 -428 ACGTGACCTGGCCCACGGCTGGCAGGTGGGACCCAGCTGCAGGGGTCCAGCAGCACCCACAGCAGCCACCTGTGGCAGGGAGGAGCTTGTGGTACAGTGG -;EDIBBIHHFEEHC?DIJ:IIHJIHCHJB2G:HIELHJIJHI?HCHEIDJGDJFIHHEFGIJIIHIEIIHJGHIJHHHJIIIHHKIHHHGGDEHFFE>@ X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243007 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243039.1477734 147 17 2955 60 100M = 2595 -459 GACCTGGCCCACGGCTGGCAGGTGGGACCCAGCTGCAGGGGTCCAGCAGCACCCACAGCAGCCACCTGTGGCAGGGAGGAGCTTGTGGTACAGTGGACAG @BCHBEAED@C8EIH7EJICIIIGFH0GGKJIJGLGAEIIGGFHEGDA X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243039 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@C +ERR156632.12418699 83 17 2962 60 100M = 2634 -427 CCCACGGCTGGCAGGTGGGACCCAGCTGCAGGGGTCCAGCAGCACCCACAGCAGCCACCTGTGGCAGGGAGGAGCTTGTGGTACAGTGGACAGGCCCTGC 6:FFAGIJHKKLMLJKLKL;9KLIGIGLJIJKK>JKLFDMMKLHJKFHKLLLJMJLHLMFJKKLNKMKLLMKNJ>JIKJIJHH5KIHFLH=JJJIHIECD X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR156632 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@A@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@F +ERR243091.852212 83 17 2967 60 100M = 2575 -491 GGCTGGCAGGTGGGACCCAGCTGCAGGGGTCCAGCAGCACCCACAGCAGCCACCTGTGGCAGGGAGGAGCTTGTGGTACAGTGGACAGGCCCTGCCCAGA AFBAE<@GIG@H7I@5=?HCIEFJDHG?DBFAJDHJIFE0IDCFJIJFI@HAGJIGDCHIHGGJFCEGIEFHHGFHE?G>GGBGDIEFG=B>GHA=FFE? X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243091 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@A@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243043.1629476 163 17 2977 29 100M = 3421 543 TGGGACCCAGCTGCAGGGGTCCAGCAGCACCCACAGCAGCCACCTGTGGCAGGGAGGAGCTTGTGGTACAGTGGACAGGCCCTGCCCAGATGGCCCCCCC ?E?>CEEFDIGHHFGG>FFGJEGJGFJHFHGECHG=FGJHHFGIFI@K>IEHFC8DAGLIF>JBHE:AJHH:I:G*>BCDCDB8GHF6.5@FF10;@E92 X0:i:1 X1:i:0 MD:Z:99G0 RG:Z:ERR243043 AM:i:29 NM:i:1 SM:i:29 MQ:i:29 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@C@BOU[PL +ERR156632.1508798 83 17 3006 29 1S4M1D95M = 2587 -518 CCCCAAGCAGCAGCCGGGGGCAGGGAGGAGCTTGTGGTACAGTGGACAGGCCCTCCCCAGATGCCCCCCCGCCTGCCTGTGGAAGTTGACCAGACCATCT <'&*(-+/?*88'-%%(((+KB/N.G)9.5E39>/;,FBHLI?CKH=BJ?FEE==DA MD:Z:4^C6C0A2T1T36G8G36 RG:Z:ERR156632 AM:i:29 NM:i:7 SM:i:29 MQ:i:29 XT:A:M BQ:Z:@FEIG@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162875.5443750 147 17 3006 60 100M = 2699 -406 CCCACAGCCCCCACCTGGGGCAGGGAGGAGCTTGGGGTACAGTGCACAGGCCCTGCCCAGATGGCCCCCCGCCTGCCTGTGGAAGTTGACCAGACCATCT @6F1-8/B%#K/,H/4A3EA9@KI7.1F049E82))G61;/,-H*C<)9*JB;.*E=;;9/.E8IGG>H*K3GJ6F256:D6:AGJ6H:CA;L5KK;@5IGBKB;:>5KHJLKDGHMDLJJKIJJLGLJJJLIKKKKHIKHIKIHHJGIHDD X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162875 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR242943.897194 147 17 3015 60 100M = 2661 -453 GCCACCTGTGGCAGGGAGGAGCTTGTGGTACAGTGGACAGGCCCTGCCCAGATGGCCCCCCGCCTGCCTGTGGAAGTTGACCAGACCATCTGTCACAGCA +EF0D..G8E:D9FIA?GB;3;ECG:HG@2DBJ/F;;;CG?GFC;7H@*DFA=I+FGGJE?IILHIGJGKIGJEJIIGHEFJIJFHKGGJGFGHEIGEEA X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR242943 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162872.25542568 99 17 3017 60 100M = 3110 192 CACCTGTGGCAGGGAGGAGCTTGTGGTACAGTGGACAGGCCCTGCCCAGATGGCCCCCCGCCTGCCTGTGGAAGTTGACCAGACCATCTGTCACAGCAGG BDDCHHFFEEGJHBEII0KGKEGEECF?D4?H9GGHH@:I;EFHB=GBI6GGE<+AIEGJBDI:9IGDJAKEHEJHCBIGHJDGHGFJFHIGHFAIFFJGHGIEIGHHGFEBBD? X0:i:1 X1:i:0 MD:Z:62T37 RG:Z:ERR242971 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243039.71589 147 17 3030 60 100M = 2654 -475 GAGCGGCTTGGGGTCCAGGGGACAGGCCCTGCCCAGATGGCCCCCCGCCTGCCTGTGGAAGTTGACCAGACCATCTGTCACAGCAGGTAAGACTCTGCTT .2*D-E;*DH>GCHF

    ,+@3IEA;IBAJKHHDKFHJIKDJJDFKI;IKIIAIHIKIIBKGLJKLJIJHHIGGJGKIDKEHHJGHGHIEEBAGHB X0:i:1 X1:i:0 MD:Z:9A90 RG:Z:ERR162872 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243063.161207 99 17 3057 60 100M = 3124 166 CCTGCCCAGATGGCCCCCCGCCTGCCTGTGGAAGTTGACCAGACCATCTGTCACAGCAGGTAAGACTCTGCTTTCTGGGCAACCCAGCAGGTGACCCTGG AAFHGFFFIFGIGIGFHHHAJHIHGHIJFKGFHICDJGHIGMFHGBIJEKEHIIFJJHLHBGIIGJJIIJKHABIIKHJHFFHIHIMIGJEDJFEFFBFB X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243063 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:CC@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A@ +ERR243007.788439 147 17 3067 60 100M = 2789 -377 TGGCCCCCCGCCTGCCTGTGGAAGTTGACCAGACCATCTGTCACAGCAGGTAAGACTCTGCTTTCTGGGCAACCCAGCAGGTGACCCTGGAATTCCTGTC >=4EGDHEACGIHKIKHHHHJKGIIHJCIIIJHIJG;LIHHKGLKIJJHIEJKLFMGJGJKGGGJGHIJJFEFHJJIJHHIHIEIHKHHJEFFFGIFEC@ X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243007 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@B +ERR245049.1543898 147 17 3077 60 100M = 2735 -441 CCTGCCTGTGGAAGTTGACCAGACCATCTGTCACAGCAGGTAAGACTCTGCTTTCTGGGCAACCCAGCAGGTGACCCTGGAATTCCTGTCCATCTGGCAG CF@GAHEHDEJFHHGHJFJKHHG=KFDKHHIIFKIKEHACHDJJFJEJBJKIIHJHHHJIFDFJIGGJIHIFJHAIKGIJFHHFIKIHGHIGFIGGHGDA X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR245049 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:AA@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@C +ERR243031.650799 99 17 3080 60 100M = 3507 526 GCCTGTGGAAGTTGACCAGACCATCTGTCACAGCAGGTAAGACTCTGCTTTCTGGGCAACCCAGCAGGTGACCCTGGAATTCCTGTCCATCTGGCAGGTG ?DBFHDH?DFIBCIEGEGDFHAGCIIIE=GHGGFHIDD@IHCHHJDFEADDE>C8EGG6:JIEL?GG8BI@G2EGIHGI=GIHEIDKJDGJIFEFC@>BD X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243031 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@F +ERR162872.20228886 147 17 3084 60 100M = 2837 -346 GTGGAAGTTGGCCAGACCATCTGTCACAGCAGGTAAGACTCTGCTTTCTGGGCAACCCAGCAGGTGACCCTGGAATTCCTGTCCATCTGGCAGGTGGGCA 6+0GEG;HD?)'@8K0/GJ89>B=:GILFGD3HB<LG>GC5GBGD?7CIEECAHADBFDCBDAKFGEEGFDEFC@AED?DDDD'>>>CKGBF?HE@EB@CF>FGDED>@ X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243051 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162875.1328730 99 17 3121 60 100M = 3494 472 ACTCTGCTTTCTGGGCAACCCAGCAGGTGACCCTGGAATTCCTGTCCATCTGGCAGGTGGGCATTGAAACTGGTTTAAAAATGTCACACCATAGGCCGGG BDHEHHGIDEIHHAHJDDEFIHIDAKI<<5IJ;JKEB3F=CFCJHIJHEJIKCLFLBECD2GIEH5A4FCH53= X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162875 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243063.161207 147 17 3124 60 100M = 3057 -166 CTGCTTTCTGGGCAACCCAGCAGGTGACCCTGGAATTCCTGTCCATCTGGCAGGTGGGCATTGAAACTGGTTTAAAAATGTCACACCATAGGCCGGGCAC EDFGEDEJGH@HIBCMHKJIICHGGIFIGKDGIGIFGCKGIHGIHFJCHIJJHHFICJIGGDJDFDKGHIEGEFFFFGCHEIEIEGHDEGGGC?EEEFC? X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243063 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:A@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243027.47729 99 17 3134 60 100M = 3547 512 GGCAACCCAGCAGGTGACCCTGGAATTCCTGTCCATCTGGCAGGTGGGCATTGAAACTGGTTTAAAAATGTCACACCATAGGCCGGGCACAGTGGCTCAC >?FEDFFGGIHGJGAJEHHFHIHFIGFJHHJEJIDHKCIIJFKIFJHFJBGCIEFIHIGJGFEAGGJFFLHJHGAIIBIFKGIEAGG?IIFFDHCFDE9C X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243027 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@A@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243019.480835 147 17 3135 60 100M = 2711 -523 GCAACCCAGCAGGTGACCCTGGAATTCCTGTCCATCTGGCAGGTGGGCATTGAAACTGGTTTAAAAATGTCACACCATAGGCCGGGCACAGTGGCTCACG EFB;GBGHGKIHHFJBHEBIGJGHHHJLIG?BFGGDEHGB@:H?>?=H@CGHEBJDHDFCEEGH98AJHB?GAGEEJ9EDGHBE736? X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR245041 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162875.19273677 99 17 3143 29 99M1S = 3488 443 GCAGGTGACCCTGGAAATCCAGTCCAACTGGCAGGAGGGCATTGAAACTGGCTTAACAATAACAAACCATAGGCCCAGCACAGTGGCTCACTCCTGTAAA A.<='.HF8B@>I45)D3I.,8&;J;(174HBHEE). XC:i:99 MD:Z:16T3T5T8T15T4A3G0T2C10G0G14G7 RG:Z:ERR162875 AM:i:29 NM:i:12 SM:i:29 MQ:i:29 XT:A:M BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@Q@@ +ERR243031.386955 163 17 3144 60 100M = 3511 466 CAGGTGACCCTGGAATTCCTGTCCATCTGGCAGGTGGGCATTGAAACTGGTTTAAAAATGTCACACCATAGGCCGGGCACAGTGGCTCACGCCTGTAATC ADHDDHGGGGIKIGEGDIGHJEIGGHKIJDJHKIBLIGIHHFKHFIHJJGDGEDHHEHHJCJBDFDHIEDGGBH:JCGGIHIEJHEGEFHAGC=D@C3=B X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243031 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@D +ERR243091.881299 163 17 3174 60 100M = 3491 416 CAGGTGGGCATTGAAACTGGTTTAAAAATGTCACACCATAGGCCGGGCACAGTGGCTCACGCCTGTAATCCCAGCCCTTTGGGAGGCCAGGGTGGGTGGA ACHCFJFGHGEFJFIHHJIJGEFEIHHFDJDKHIGHHGGEKIIGAJJIHJHNCKHJJJHJCKIHJAGJHJIHGKJGHJEEEIGFJIIHHHDGDHEDBGEA X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243091 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243067.1030440 147 17 3191 60 100M = 2824 -466 TGGTTTAAAAATGTCACACCATAGGCCGGGCACAGTGGCTCACGCCTGTAATCCCAGCCCTTTGGGAGGCCAGGGTGGGTGGATCACTTGAGGTCAGGAG @?BD=<9$=>-74&CI@7FIE8AHA5E>HFIDFKJ8H0BCDHJFGHHH=ACHEGGDHEDD@ X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243067 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162872.18600710 163 17 3209 60 100M = 3375 265 CCATAGGCCGGGCACAGTGGCTCACGCCTGTAATCCCAGCCCTTTGGGAGGCCAGGGTGGGTGGATCACTTGAGGTCAGGAGTTCAAGACCAGCCTGGCC EBFFFKIJJCIIKIHILILKLLLJIDKJGHIIGJLLJCKKLKLGIKGKKLKLLIKJLEKIL2LJKBLKHLIHJIJIMJLKILEHLIFLJILFGJJEHGF3 X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162872 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:C@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A@ +ERR156632.13236661 147 17 3218 60 100M = 2887 -430 GGGCACAGTGGCTCACGCCTGTAATCCCAGCCCTTTGGGAGGCCAGGGTGGGTGGATCACTTGAGGTCAGGAGTTCAAGACCAGCCTGGCCAACATGGTG >ECDFFGGBKJKGK@CLKJHJJF;F< X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162872 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162872.24480599 147 17 3229 60 100M = 2922 -406 CTCACGCCTGTAATCCCAGCCCTTTGGGAGGCCAGGGTGGGTGGATCACTTGAGGTCAGGAGTTCAAGACCAGCCTGGCCAACATGGTGAAACCCCGTCT B7H:=HFGAGBHICJCLLHGEHK>?KHKIMHI:MEDGFLBIHIEIJLJM=IGLLJFHLKIKIJHLHFIHKLJIEKIKK+KHHIJILJAJHGHDIAAFEED X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162872 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR242963.1107552 1187 17 3234 60 100M = 3565 430 GCCTGTAATCCCAGCCCTTTGGGAGGCCAGGGTGGGTGGATCACTTGAGGTCAGGAGTTCAAGACCAGCCTGGCCAACATGGTGAAACCCCGTCTACTAA @ABGHECGEFGGEJHIHHFFIHGDKGKGHLHHEHHHDJHEHIHGLIKFKGCJHK=ELFEKHGKFHIGLJJKKHJGGIGIGMKEGHHHHFIG?BGF?EF?C X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR242963 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@AH +ERR242963.383553 163 17 3234 60 100M = 3565 430 GCCTGTAATCCCAGCCCTTTGGGAGGCCAGGGTGGGTGGATCACTTGAGGTCAGGAGTTCAAGACCAGCCTGGCCAACATGGTGAAACCCCGTCTACTAA @DEGGEDGGJGGGKJIHIFFIHGDKHKGHLHHEKHHDJHHHIHIJEHHKGEJJKFGLFEKHGGIHIILIFKKJJGGDJHGIKDGGGGIFIG?EIF?DEAC X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR242963 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@CH +ERR162875.6771266 99 17 3240 60 100M = 3423 282 AATCCCAGCCCTTTGGGAGGCCAGGGTGGGTGGATCACTTGAGGTCAGGAGTTCAAGACCAGCCTGGCCAACATGGTGAAACCCCGTCTACTAAAAATAC ABEEDEFIHFHIGFHGHHKHKKHIIG>JIJGKHIHLIJIHJIMKHLKNJFN:HLHJMJJMFLKKILKMMK?GIGIJHI@GFGJELEAHFIFKGGFBFCC? X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162875 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243015.596677 83 17 3240 60 100M = 2861 -478 AATCGCAGCCCTTTGGGAGGCCAGGGTGGGTGGATCACTTGAGGTCAGGAGTTCAAGACCAGCCTGGCCAACATGGTGAAACCCCGTCTACTAAAAATAC 5@C>*8FI6D:EBAG:GHD>F8;FK;G>FIIJH:0C<9IIAAIF>J>JIFJEE?CHHJD@FCGHIFJ@CA;G@:GFG@EIDCCCBC@B? X0:i:1 X1:i:0 MD:Z:4C95 RG:Z:ERR243015 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR245032.287858 83 17 3258 60 100M = 2905 -452 GGCCAGGGTGGGTGGATCACTTGAGGTCAGGAGTTCAAGACCAGCCTGGCCAACATGGTGAAACCCCGTCTACTAAAAATACAAAAATTAGCCTGGCGTG CCDGCEFFHIAJGGFG>JCKHFKIIJGLGFIHH?HJFIJ>HHHHDLIJKGKEFMHFJKHJEGEIIGAIHLEEKDGEFGG@DJEEEGGGFHHFJGGG@ED@ X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR245032 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:A@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@B +ERR245038.1772750 83 17 3261 60 100M = 2917 -443 CAGGGTGGGTGGATCACTTGAGGTCAGGAGTTCAAGACCAGCCTGGCCAACATGGTGAAACCCCGTCTACTAAAAATACAAAAATTAGCCTGGCGTGGTG EEDEFEDFIBGGBFK;DGHHGIIGFIJCHIGGGEIG>IJIIHJGHIFHFEJHGHIFJECDGHHAIGIEGJCEGEEGEEIDFEFGEEIHCIFFH@EEBDC> X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR245038 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR156632.4053670 147 17 3280 60 100M = 3038 -341 GAGGTCAGGAGTTCAAGACCAGCCTGGCCAACATGGTGAAACCCCGTCTACTAAAAATACAAAAATTAGCCTGGCGTGGTGGCGCATGCCTGTAATCCCA DCEFGFCJIHCIGIFKL@LKKLKKEKL=LHHIIJMKHLFGHKKKCJIMHGMGGHGIJIGMHHHGHIHLHKMIKJCIHKIHKJCHJGGIFJFFFCFFBAFB X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR156632 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162875.18994301 163 17 3289 60 100M = 3627 437 AGTTCAAGACCAGCCTGGCCAACATGGTGAAACCCCGTCTACTAAAAATACAAAAATTAGCCTGGCGTGGTGGCGCATGCCTGTAATCCCAGCTACTTGG EFFEIGGKHIKHKKKKLJLKJJJKILJILIJJJLMLDJLKHKMIKJJIEHIHKJJJEEHH?LKCKJDJLHDLLJBLJGJKKHHIIIIHKKI?JCCGHBGD X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162875 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@II +ERR243003.1151913 99 17 3289 60 100M = 3442 253 AGTTCAAGACCAGCCTGGCCAACATGGTGAAACCCCGTCTACTAAAAATACAAAAATTAGCCTGGCGTGGTGGCGCATGCCTGTAATCCCAGCTACTTGG ?EDBEFFIFGGFJIGIIHJGGGGEFIHEJFGHIHHIBEKHDIHDEHIGGFJGFIFFGFFLJIIJHJBFJHFJJJCKGGJLHHKEFFGDIHFJIEAFGBEB X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243003 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@GG +ERR243039.1531670 99 17 3295 60 100M = 3652 456 AGACCAGCCTGGCCAACATGGTGAAACCCCGTCTACTAAAAATACAAAAATTAGCCTGGCGTGGTGGCGCATGCCTGTAATCCCAGCTACTTGGGAAGCT ?CDDDEHGFHFDGEHGGGIHHEFHHJHGHCABGIEIHCGHG>F@HHGHHECFDJGIICEFBFJDFK0FBGGDKJEJIEEGIGGIEHHFAID38FDDADE< X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243039 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162875.13732136 83 17 3298 60 100M = 2900 -497 CCAGCCTGGCCAACATGGTGAAACCCCGTCTACTAAAAATACAAAAATTAGCCTGGCGTGGTGGCGCATGCCTGTAATCCCAGCTACTTGGGAAGCTGAG =FHG?JAGGA=G8K?GJ@=EFG@LEDAAGNJHMEEHIHIIIJHH:FF:HA@EKDL<>?FIJJEKEFKB@GJKIIHHGHCGKJJKG?HGFIHHEHGGEFGA X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162875 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@A@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@C +ERR162875.12766080 99 17 3309 60 100M = 3630 420 AACATGGTGAAACCCCGACTACTAAAAATACAAAAATTAGCCTGGCGTGGAGGCGCATGCCTGTAATCCCAGCTACTTGGGAAGCTGAGGGATGAGAACT BB;EEG(>HFFD,F>24*HHG4;GEII3;@IDD3??GDFJ4AF;/K1BK:)B6G2GFE9K2G98IF,J?H=JK=2GI9K.-<98HJK0:9-=4$1;/12%27+28, X0:i:1 X1:i:0 XC:i:93 MD:Z:93 RG:Z:ERR013140 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR242963.128219 99 17 3359 60 100M = 3766 506 TGGCGCATGCCTGTAATCCCAGCTACTTGGGAAGCTGAGGGATGAGAACTGCTTGAACCTGGGAGGCAGACGTTGCAGTGAGCTGAGATCACGCCACTGC ?EAE?GFFHHGHIECDGJFHGGHJDEDEIHFGAKKHJHKBGFGJDEFGGHKJJHKGHIJIJIGGLGJBKGH@DBIJ8I==FIIFJGIE@JFG?G>>@CB> X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR242963 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162872.18600710 83 17 3375 60 100M = 3209 -265 TCCCAGCTACTTGGGAAGCTGAGGGATGAGAACTGCTTGAACCTGGGAGGCAGACGTTGCAGTGAGCTGAGATCACGCCACTGCACTCCAGCCTGGGCAA -EDHDFJ@DKH@JKHIGJJGCMGLEIFL9GJ:KDJJAIMAHJKIJLJELILLLDDJIEIKKHBJKLMILJJHGKGCIIKHLIJJHKHJIIIEIFGEFGBB X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162872 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A +ERR156632.14578469 99 17 3384 60 100M = 3677 391 CTTGGGAAGCTGAGGGATGAGAACTGCTTGAACCTGGGAGGCAGACGTTGCAGTGAGCTGAGATCACGCCACTGCACTCCAGCCTGGGCAACAGAGTAAT =A7AH;9;.55-+.&132$*8344:$:)$8807;:B<>A=@=A;@@:CDB@EDBCCIGBIFIIHJJJHGFFGJHIDCBD> X0:i:1 X1:i:0 XC:i:66 MD:Z:0T65 RG:Z:ERR013140 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243043.1629476 83 17 3421 29 100M = 2977 -543 GAGGCGGCCGTTGCAGGGACCTGAGACCCCCCCACTGCCCCCCAGCCTGGGCAACAGAGTAAGCCTCTGTCTCAAAAAAAAAAAAATCACACCATTTTGG B.C;((:#?3H.3*.11-1').:.8,&#'/'9J1;.5B7((F004D9/GHD0>D>=/;-;EG6#F@2E9/>/3CFCFDEFFEFEFGFJCJDHHFFF@E@A MD:Z:5A1A8T2G6T1A1G7A1T22A36 RG:Z:ERR243043 AM:i:29 NM:i:10 SM:i:29 MQ:i:29 XT:A:M BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162875.6771266 147 17 3423 60 100M = 3240 -282 GGCAGACGTTGCAGTGAGCTGAGATCACGCCACTGCACTCCAGCCTGGGCAACAGAGTAAGACTCTGTCTCAAAAAAAAAAAAATCACACCATTTTGGCT @@0AF,6EG4<:.>>F.?H6F8B.4:1@5JHGEHDCBBFKA?KG;A:JEA>HGHIGIHHIHIGIILHLHJKIGGGGHFFE X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162875 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@G +ERR243067.219795 99 17 3430 60 100M = 3486 155 GTTGCAGTGAGCTGAGATCACGCCACTGCACTCCAGCCTGGGCAACAGAGTAAGACTCTGTCTCAAAAAAAAAAAAATCACACCATTTTGGCTTCAGATT ?CAFFDHDHFHHIIFJEGIHGAIHHHHIIGGFIIFJIGHIIJJGIHGKHLCBHIFFKJHJFIIJHFHGFGDIGGHF9BH?A7G9AC@HDI-FG9DB9A@> X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243067 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162875.12181062 163 17 3434 60 100M = 3613 278 CAGTGAGCTGAGATCACGCCACTGCACTCCAGCCTGGGCAACAGAGTAAGACTCTGTCTCAAAAAAAAAAAAATCACACCATTTTGGCTTCAGATTGCAT DDHFIHJJJKIKIGKJHBKKJILLGIJLKKINKLKKLKJIJJKMJMGHJKKJMLLLJLLMKJHJJJJEIKIJ;@?EIGH@JJGHCIB?HAFDC1>@H3C3 X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162875 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162875.15307937 163 17 3442 29 98M2S = 3853 510 TGAGATCACGCCACTGCACTCCAGCCTGGGCAACAGAGTAAGACTCTGTCTCAAAAAAAAAAAAATAAAACAATTTTGGATTTAGATAGAATATCATCTG BEEEAEIFH@K?BIGED@HJ@/HI9LIKJJCHAEKFGM?EJ:CJCC=EI:FKK<4FB@H=H=45)-*;I2+.;IGBB@A7I2:AFI==73B2G9HGFEHL-IDDHCCDEI>?DFJEDIGAEEEJ/5FGFGFGGFFFFIHIFJEHJGGHHHIJKHGJHFHCGIIFEFFHIFFGC@ X0:i:1 X1:i:0 MD:Z:52^A48 RG:Z:ERR243003 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@efefefca`_]]@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR245041.246570 147 17 3462 60 100M = 3137 -424 CCAGCCTGGGCAACAGAGAAAGACTCTGTCTCAAAAAAAAAAAAATCACACCATTTTGGCTTCAGATTGCATATCCTCCTGCAAGGATATATACGCGTGA ?8/5F*9EA40GD0G8/:$DC:2G-C;7A1.;@E@E=FDD7EFDCHKCHAIFDGHBFFIIG=JHJ?CGJICF5GGHGGKEIGBHBHGCFCDEEAGAGED@ X0:i:1 X1:i:0 MD:Z:18T81 RG:Z:ERR245041 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@B +ERR243027.1264030 163 17 3470 29 40M1D13M1I6M1D5M1I23M1D9M2S = 3836 465 GGCAACAGAGTAAGACTCTGTCTCAAAAAAAAAAAAATCAAACATTTTGGCTTCCAGATTCAAATCCCCCCTCAAAGGATAAAAACGCGGAAATTCAAAG A?FGFGGIGLFEGJGHIIHHFIJJIHIFIGGGGFJF&*0>.*J*1G>F1?**6.)1%/G$/<%*/*E*(I4*)0B+=&-/-*7545)*55.GG)C./E*) XC:i:99 MD:Z:40^C1C17^G2T4T3G0C7T1T5^T9 RG:Z:ERR243027 AM:i:29 NM:i:12 SM:i:29 MQ:i:29 XT:A:M BQ:Z:CA@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@IEb@@C@@@@@@A@HL@JfC@@@@@@dICcL@@EU@C@@@@@@@@@@@@@@DC@@@B[@@ +ERR162875.18637663 1187 17 3471 60 100M = 3780 408 GCAACAGAGTAAGACTCTGTCTCAAAAAAAAAAAAATCACACCATTTTGGCTTCAGATTGCATATCCTCCTGCAAGGATATATACGCGTGAAATTCAAGT BDEDGHEHLHIHHJFKJJ:GKLGKDHEJCIJGJJIJ=CHCFHJGGGGCH@EJIFDGK@C;DJJ8:?KIK;;LFE=E4<-I8AA4C=F71AIF8H9=FC8, X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162875 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162875.6808869 163 17 3471 60 100M = 3780 408 GCAACAGAGTAAGACTCTGTCTCAAAAAAAAAAAAATCACACCATTTTGGCTTCAGATTGCATATCCTCCTGCAAGGATATATACGCGTGAAATTCAAGT DDDFGGJHKGGHKFIKJLLGKKLIIJIJIIJHHJKICBJJJFJAGIHBLGBFIIIKGJ?CLFFIJJKIKDCGKEHND6DDICEHHAIDBIJIFJEIJDL@FFCFF9HH>EEBB X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162872 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243067.219795 147 17 3486 60 100M = 3430 -155 TCTGTCTCAAAAAAAAAAAAATCACACCATTTTGGCTTCAGATTGCATATCCTCCTGCAAGGATATATACGCGTGAAATTCAAGTCAATGACAAATCAGA /B7E4=5:DGFFFFFEFFFEHFKGKFIIGGGHHHJJJIJKLIGHJIHHGFIIFHKGJJFIIKGEGEHFEAJAJGIFFGHFIHLIGIEIGIEIEEEDHFDA X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243067 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@C +ERR162875.19273677 147 17 3488 29 6M1I93M = 3143 -443 TGTATCAAAAAAAAAAAAAATCACACCATTTTGGCTTCAGATTGCATATCCTCCTGCAAGGATATATACGCGTGAAATTCAAGTCAATGACAAATCAGAA +CC-*98FHHF;I@(:DC1FIJ:J16A8>)2J3KC3G;ALH<@LF61G6ICB?CI;DACEIBIGG4JDAI:GHGJDB>JFJEBIBC:BGFHHHFD:B X0:i:1 X1:i:0 MD:Z:3C95 RG:Z:ERR162875 AM:i:29 NM:i:2 SM:i:29 MQ:i:29 XT:A:U BQ:Z:@@@@@@@eggeZh\CT^[HY@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A +ERR013140.22233344 163 17 3490 60 108M = 3784 401 TCTCAAAAAAAAAAAAATCACACCATTTTGGCTTCAGATTGCATATCCTCCTGCAAGGATATATACGCGTGAAATTCAAGTCAATGACAAATCAGAAAAAAAAACATA :CEDCDEGGHHHIIIIIGHHEHFJHHEEEELJJEIILHDDEKJIHIJKGJKIEKIHGMGGFEFFFI>LCFHLLHF?DIGEFFJGCFE;HEE@AGCJHIIIIHCF?F>@ X0:i:1 X1:i:0 MD:Z:97G10 RG:Z:ERR013140 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162872.22586072 83 17 3490 60 1S99M = 3226 -362 TTCTCAAAAAAAAAAAAATCACACCATTTTGGCTTCAGATTGCATATCCTCCTGCAAGGATATATACGCGTGAAATTCAAGTCAATGACAAATCAGAAGA .*71578ED=H6?H>D?,DLFJ7B7A=II5C=@JGHEAFIHIGIHBHCDHBL6EAHKB@IGCCEBCDB@CIJDCHEDGHGHEIECFFGI@CGFHGEBGE@ X0:i:1 X1:i:0 XC:i:99 MD:Z:99 RG:Z:ERR162872 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@B +ERR243091.881299 83 17 3491 60 100M = 3174 -416 CTCAAAAAAAAAAAAATCACACCATTTTGGCTTCAGATTGCATATCCTCCTGCAAGGATATATACGCGTGAAATTCAAGTCAATGACAAATCAGAAAAAA C5;=CAAEFDFEEEEBCI;JFIKHGHGHIIKGEKGJIGGIJG=GDIKGFIHIJEIHJFFFFDDDAI>IDJDFGFEIFGHGIFGFJFIDFGEHGGDB@A@? X0:i:1 X1:i:0 MD:Z:96G3 RG:Z:ERR243091 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@PSRW_`_^ +ERR162875.1328730 147 17 3494 60 100M = 3121 -472 AAAAAAAAAAAAATCACACCATTTTGGCTTCAGATTGCATATCCTCCTGCAAGGATATATACGCGTGAAATTCAAGTCAATGACAAATCAGAAGAAAAAA 0ACDFDC9GCF?CGKF:GHLIHJKJIJNJIKIEI2B6FJJJIALHIJKLKHLJKIEJHIH>DGBKJLIIJIIKDIGGLIIALIKHGGHKIJGJHFFDC?E X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162875 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@GHIJHF@IDF@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ADCDAH +ERR242955.586810 99 17 3506 60 100M = 3917 510 ATCACACCATTTTGGCTTCAGATTGCATATCCTCCTGCAAGGATATATACGCGTGAAATTCAAGTCAATGACAAATCAGAAAAAAAAACATATATATACG ?@CCEAEDBDDDEG6GG-IFFCC8FFGEADFHFIHFCAJFDFI9EI6HE>F;BBFGBF4FEAEC>ACEA7?A7 X0:i:1 X1:i:0 MD:Z:81G18 RG:Z:ERR242955 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243031.650799 147 17 3507 60 100M = 3080 -526 TCACACCATTTTGGCTTCAGATTGCATATCCTCCTGCAAGGATATATACGCGTGAAATTCAAGTCAATGACAAATCAGAAAAAAAAACATATATATACGC >GCH1GFFHGHHHFGFGIHHHEEIIIFI;GIAADHIDFFI@HDHAGD>BIAHHIEFBID>FIEFHHFGHDIFFHDEGGEFDEEEFFEJHEGEF@FDD?CA X0:i:1 X1:i:0 MD:Z:80G19 RG:Z:ERR243031 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162872.8738223 99 17 3511 60 100M = 3914 502 ACCATTTTGGCTTCAGATTGCATATCCTCCTGCAAGGATATATACGCGTGAAATTCAAGTCAATGACAAATCAGAAAAAAAAACATAAATATACGCAAAC BDDCFBAAIEBIDBGKHE=8DDGGHGHJJDFHHD;LC<=>C=GHKI:?IJB@@H7AHHB0:)J@H(AF:C@HA/378@ X0:i:1 X1:i:0 MD:Z:76G10T12 RG:Z:ERR162872 AM:i:37 NM:i:2 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@B +ERR243031.386955 83 17 3511 60 100M = 3144 -466 CCCATTTTGGCTTCAGATTGCATATCCTCCTGCAAGGATATATACGCGTGAAATTCAAGTCAATGACAAATCAGAAGAAAAAACATATATATACGCAAAC $FC@@D>FJJJAFIJIHEJKJHA@GHKHKKHKJCIGJDFHCHFEBJAJHLGEFHGHEIICJEGGJGHFFGGJIIFCIEFCDDEJFDGEGDFDEAFHBAB? X0:i:1 X1:i:0 MD:Z:0A99 RG:Z:ERR243031 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@IB@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A +ERR243059.116527 99 17 3516 60 100M = 3914 497 TTTGGCTTCAGATTGCATATCCTCCTGCAAGGATATATACGCGTGAAATTCAAGTCAATGACAAATCAGAAAAAAAAACATATATATACGCAAACCAGTA @@AFCGGDGFJFGEJIFFFFIGHIHHIHGIKIGEDGCGEHAI@EIEEFHCJG@JEJFHHJFHFHGJJEJGIHEGGHHAJGGEGEGDHEH?JDFHE@CDB@ X0:i:1 X1:i:0 MD:Z:71G28 RG:Z:ERR243059 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:EEC@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162872.4686821 163 17 3525 60 100M = 3871 445 AGATTGCATATCCTCCTGCAAGGATATATACGCGTGAAATTCAAGTCAATGACAAATCAGAAGAAAAAACATATATATACGCAAACCAGTATCCTACTGT EEEFEJJGHHIJKKLKLLJIHLMJJJJJKJJFLEILHJJIIKKIMHNJJJMKKKJIJJKLJKMKKIKKJKKGHGIIJJIKCKJJIJKJMFCHEIGEEGG< X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162872 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A@ +ERR242971.1136963 99 17 3535 60 100M = 3893 457 TCCTCCTGCAAGGATATATACGCGTGAAATTCAAGTCAATGACAAATCAGAAAAAAAAACATATATATACGCAAACCAGTATCCTACTGTGTGTGTCGTT ?DDEFFDHGFCI5GFCFDCBGAI@?IF9A>AJHGKD@@ X0:i:1 X1:i:0 MD:Z:52G47 RG:Z:ERR242971 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@BE +ERR243027.47729 147 17 3547 60 100M = 3134 -512 GATATATACGCGTGAAATTCAAGTCAATGACAAATCAGAAGAAAAAACATATATATACGCAAACCAGTATCCTACTGTGTGTGTCGTTTGTTGTGTTTTC DB?FDE?CAH@FFJGFAGGIEIIGKFIIICKFEGIDJIFJJFFIHE>IHDHFHEDEDCIJFEEJIIIEFHGLDFKCHHGHHIHEBHCHHHFHGGGDFDCA X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243027 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR016352.1106475 163 17 3557 60 108M = 3858 408 CGTGAAATTCAAGTCAATGACAAATCAGAAGAAAAAACATATATATACGCAAACCAGTATCCTACTGTGTGTGTCGTTTGTTGTGTTTTCGACAGCTGTCCGTGTTAT ;:CCDDCDCEGHGGFHIEGIDHIIGGFH>IIAFJ?JDEIHHHHH?HHF8HJEK3HBGFADFIKEI;F;HGFEKDGHGHAFGH?FHEH=AGHFIFGHG@JFIGGJGFGE@FEEBAB? X0:i:1 X1:i:0 MD:Z:22G77 RG:Z:ERR242963 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR242963.383553 83 17 3565 60 100M = 3234 -430 TCAAGTCAATGACAAATCAGAAAAAAAAACATATATATACGCAAACCAGTATCCTACTGTGTGTGTCGTTTGTTGTGTTTTCGACAGCTGTCCGTGTTAT B>DAB9>7>CD=C@B;@EC X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243087 AM:i:18 NM:i:0 SM:i:37 MQ:i:55 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR156632.10508568 83 17 3608 60 100M = 3407 -300 AACCAGTATCCTACTGTGTGTGTCGTTTGTTGTGTTTTCGACAGCTGTCCGTGTTATAATAATTCCTCTAGTTCAAATTTATTCATTTTTAACTTCATAG >EBGIFGFIJMJBLIIKIJJJJHDJIKKKJJJJJFJJIELIMLLLJJFJDKKKKIJJIIIIHIHJMIMILJIIKHHIGJIHIJLIFJIIHFGJHIIFAED X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR156632 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@G@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162875.12181062 83 17 3613 60 100M = 3434 -278 GTATCCTACTGTGTGTGTCGTTTGTTGTGTTTTCGACAGCTGTCCGTGTTATAATAATTCCTCTAGTTCAAATTTATTCATTTTTAACTTCATAGTACCA BCFB?IFBLHIHGB7JI=.>EJI8&FKF+IGB7H2JIF7F=?CF5A2+? X0:i:1 X1:i:0 MD:Z:84C15 RG:Z:ERR162872 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A +ERR242975.161746 163 17 3623 60 100M = 4004 480 GTGTGTGTCGTTTGTTGTGTTTTCGACAGCTGTCCGTGTTATAATAATTCCTCTAGTTCAAATTTATTCATTTTTAACTTCATAGTACCACATTCTACAC @CGEHDIEIAFEFIEEIFIDFFFI?FIEIJHIEIGBEJEFDCFHGFIDHKHJJJELEBHGHBHGFGHFLGHEFECFHJHEJHFFKGAHDEAHGCIFBFD> X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR242975 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162875.18994301 83 17 3627 60 100M = 3289 -437 GTGTCGTTTGTTGTGTTTTCGACAGCTGTCCGTGTTATAATAATTCCTCTAGTTCAAATTTATTCATTTTTAACTTCATAGTACCACATTCTACACACTG ?DEE=HCEFHIHJIJBHJIDGHLLKIFIJCDKJKEIJIIIIHJJFJMELHHKKJLHIHIKIIIILHIJIHIHHLIHIIIKHGGHKHJGGGJFFIFHFGEB X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162875 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162875.12766080 147 17 3630 60 100M = 3309 -420 TCGTTTGTTGTGTTTTCGACAGCTGTCCGTGTTATAATAATTCCTCTAGTTCAAATTTATTCATTTTTAACTTCATAGTACCACATTCTACACACTGCCC :==>CF@1DIH4=GCE2L9:8A9EB4/:8JKJHC5CIH3CKE;7EGGE?EDI?=IGEG?IGGG@HFGIHGGFFGHFEIGF6FG6H:CFGAIHJIFAA<=?HBGKGFF8FDHF@?GGIJG9CGHAGH>I.HH?;><;BAFHIHEKHHHAIILFDIHIDGKIGGKFJJLHJJBJFJAHGJKHLJHJADKKIDGDEKL;=DEF;EFFEH>CEGAAKEJFHHHEKEDG?IFGAGJCIHHIGGFHDFIFEHJB>HKDIHHAK=?JEKGKHJHGIGIEH?EHHHIEGGIFF@D=GC@ X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243039 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@B +ERR156632.301185 163 17 3655 60 100M = 3885 329 TCCGTGTTATAATAATTCCTCTAGTTCAAATTTATTCATTTTTAACTTCATAGTACCACATTCTACACACTGCCCATGTCCCCTCAAGCTTCCCCTGGCT BDC@EHFDFFFHGGDGGJJJKKIKFGFIIFHGEHHHJFHHIJGIIILGJIHHMHIJLIKEJIKLKEFJJJLLHLKJIHGLLLKLKDIMFKGIJJHHDD@: X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR156632 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162872.9849990 163 17 3663 60 100M = 3854 290 ATAATAATTCCTCTAGTTCAAATTTATTCATTTTTAACTTCATAGTACCACATTCTACACACTGCCCATGTCCCCTCAAGCTTCCCCTGGCTCCTGCAAC EADFFGHGGKJKKLJKIHJJKIJHIJJHMHJJIIHGHKMHMJJIMHKJLIKJJIMMCILIKKLLKLIEHLJMKLKNMK@MJKHLLKLKKIKKJIIHFCDE X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162872 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@G +ERR156632.14578469 147 17 3677 60 1S99M = 3384 -391 TAGTTCAAATTTATTCATTTTTAACTTCATAGTACCACATTCTACACACTGCCCATGTCCCCTCAAGCTTCCCCTGTCTCCTGCAACCACAAATCTACTC /.D1G.8'@12H+3IKHF>JJ@';7II::8LK80HME:-)8;I=:,:1BIL0.J;I6EM2'//H4<8>I/70G1.I-005L=JI5@F>>2EE2?@E5A:? X0:i:1 X1:i:0 XC:i:99 MD:Z:75G23 RG:Z:ERR156632 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243079.290863 163 17 3688 37 100M = 4062 473 ATTCATTTTTAACTTCATAGTACCACATTCTACACACTGCCCATGTCCCCTCAAGCTTCCCCTGGCTCCTGCAACCACAAATCTACTCTCTGCCTCTGTG ?BAFCDDCDCEFGGEIEGEIDDGHFGHGFGICHGDEILIGJIHIJCHIHHJMGEKIJEGHGGJHHIIKJJBIHEIHIIJEHGJIAHJLIJHDJFCFGDAE X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243079 AM:i:0 NM:i:0 SM:i:37 MQ:i:7 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@G +ERR016352.12571677 163 17 3692 60 108M = 4043 458 ATTTTTAACTTCATAGTACCACATTCTACACACTGCCCATGTCCCCTCAAGCTTCCCCTGGCTCCTGCAACCACAAATCTACTCTCTGCCTCTGTGGGTTGACCTATT :BAA@@BFBGDFGFFHGFDGHDHGEGIG?IEEEIHHHHIHIIHHFHJHIFJDJFGFHIJFIIJEIID8AFEGIEIIIGEIGFJAJ@F=?IK=JH?FBFDFF@;;<@ED X0:i:1 X1:i:0 MD:Z:108 RG:Z:ERR016352 AM:i:23 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@C +ERR242955.298650 99 17 3708 37 100M = 4076 467 TACCACATTCTACACACTGCCCATGTCCCCTCAAGCTTCCCCTGGCTCCTGCAACCACAAATCTACTCTCTGCCTCTGTGGGTTGACCTATTCTGGACAC ?ADCFFFDBGHDHGIGHGFJHGFFI?IHHIHGBFJKIGJDGIEKHKGJJJHJFIGHGIHIGFIIGIHJJJEJLHIEFIDJGHGAHFHGGBFCCFH?CAEA X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR242955 AM:i:0 NM:i:0 SM:i:37 MQ:i:0 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162872.16735015 99 17 3713 60 100M = 3988 374 CATTCTACACACTGCCCATGTCCCCTCAAGCTTCCCCTGGCTCCTGCAACCACAAATCTACTCTCTGCCTCTGTGGGTTGACCTATTCTGGACACGTCAT B;ICDHEF4BBFH0GJC.:F;MKK.AH6FEL=5IGIFA9GFILF5J8<@G7AH/LI&+>.CDIJF,7K669G;, X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162872 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243031.299961 163 17 3714 37 100M = 4080 465 ATTCTACACACTGCCCATGTCCCCTCAAGCTTCCCCTGGCTCCTGCAACCACAAATCTACTCTCTGCCTCTGTGGGTTGACCTATTCTGGACACGTCATA ?B@EGCBHEHFEFEHHDGIEIGHHCK@HDBG@IFFD=?BC=E@CEHEH;HHICGHHGIEF>FJIIJAIBIIEGG=DE@<@I;H=HBFIC0F7FF@1DAA: X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243031 AM:i:0 NM:i:0 SM:i:37 MQ:i:7 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243047.429920 163 17 3715 37 100M = 4067 451 TTCTACACACTGCCCATGTCCCCTCAAGCTTCCCCTGGCTCCTGCAACCACAAATCTACTCTCTGCCTCTGTGGGTTAACCTATTCTGGACACGTCATAG @ADEBEFGCGGIJFHFGIGIGHGHHFFJI=?JGFHGGGGGJGGJFHHHDIGDHGDJIDIJJIJKKJ;JHFJ;DGDCEGNHDBDHEJIICGHFF7DAE@5> X0:i:1 X1:i:0 MD:Z:77G22 RG:Z:ERR243047 AM:i:0 NM:i:1 SM:i:37 MQ:i:7 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR013140.12000443 163 17 3721 57 108M = 4045 401 ACACTGCCCATGTCCCCTCAAGCTTCCCCTGGCTCCTGCAACCACAAATCTACTCTCTGCCTCTGTGGGTTGACCTATTCTGGACACGTCCTAGAAATAGAGTCCTGC :ADBDCAFGFFGA?IGGAABEBIF=?DBA?AD@B@B?@AB?49B?B??<>?@;B687?96BDB?177)43:@?28B>6963%842;(->,1<3:33?21/24%3,A@0 X0:i:1 X1:i:0 MD:Z:90A17 RG:Z:ERR013140 AM:i:20 NM:i:1 SM:i:37 MQ:i:57 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR013140.3552250 163 17 3731 10 108M = 4051 394 TGTCCCCTCAAGCTTCCCCTCGCTCCTGCAACCACAAATCTACTCTCCGCCTCTCTGGGCTGACCTATTCTCGACACGTTCTAGAAATAGAGTCCTGCCAAACGTCGC /<@70(/>3061&A57-(#.%23.,4>@01B95B>>3:#/&AF@D+B/;%&FCB1+F3@<6B)-,:7%)9'8B<+0D7359F@7@49?@$>/B3(//). MD:Z:20G26T6G4T11G7C0A17A1C4G2 RG:Z:ERR013140 AM:i:10 NM:i:10 SM:i:10 MQ:i:10 XT:A:M BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162875.7468652 99 17 3733 60 100M = 3865 231 TCCCCTCAAGCTTCCCCTGGCTCCTGCAACCACAAATCTACTCTCTGCCTCTGTGGGTTGACCTATTCTGGACACGTCATAGAAATAGAGTCCTGCAACA AECDFHGFFJHIGJJIIJJ0KJKJGKJIIIJHHIGHJKKIKLLLLLLIKKLKKEKEBIHKJFLHIKIKMMHJIJJDHLHIFMIIFJDJIMGIJIIGFDD@ X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162875 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR245049.438880 99 17 3734 60 100M = 4134 499 CCCCTCAAGCTTCCCCTGGCTCCTGCAACCACAAATCTACTCTCTGCCTCTGTGGGTTGACCTATTCTGGACACGTCATAGAAATAGAGTCCTGCAACAC ?BAEFGFFIHHEJGHFHIDIHHGDGIHGHGEIGHGIKIEJHKHJGIIHDKIJFEA@EEJGHIGEFFKMJG9JFJAGKGCDHDHIGFI?KDFHH?IF?ECD X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR245049 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@A@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162872.10931516 163 17 3750 37 100M = 4074 423 TGGCTCCTGCAACCACAAATCTACTCTCTGCCTCTGTGGGTTGACCTATTCTGGACACGTCATAGAAATAGAGTCCTGCAACACGTGGCCGTCTGTGTCT @FBCBIJJKJFHFCFJFEDHLIHDMILFJLBLLILI?MHE;J8BFL=CJGFMJMDDK/LKGHJBGDILF) X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162872 AM:i:0 NM:i:0 SM:i:37 MQ:i:0 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243075.758288 163 17 3764 60 100M = 4186 521 ACAAATCTACTCTCTGCCTCTGTGGGTTGACCTATTCTGGACACGTCATAGAAATAGAGTCCTGCAACACGTGGCCGTCTGTGTCTGGCTTCTCTCGCTT ACECFEHGFHHIIIIJHHIIIJFJJHEEJFHHIFGGKJLHHBGJBGIFGELGHHHEJGLELIJIKIHMGIAELIIIDGJKJFJFKIIIHHDGHIGH=EF@ X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243075 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A@ +ERR242963.128219 147 17 3766 60 100M = 3359 -506 AAATCTACTCTCTGCCTCTGTGGGTTGACCTATTCTGGACACGTCATAGAAATAGAGTCCTGCAACACGTGGCCGTCTGTGTCTGGCTTCTCTCGCTTAG =>AAICDJEJEJHJIKDKHGHHGJBGGCFJHAIHLGGKFJDBHHJDFKJFCGFIILG@JKHIHFDJEAIDJFG@HGGGFGIGKGGHJFFJFIF?JJBBD@ X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR242963 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR013140.23480670 73 17 3771 37 108M = 3771 0 TACTCTCTGCCTCTGTGGGTTGACCTATTCTGGACACGTCATAGAAATAGAGTCCTGCAACACGTGGCCGTCTGTGTCTGGCTTCTCTCGCTTAGCATCTTGTTTCCC @?@@DIEHB>GHIJHEBKKFDGGFDKGEEIGCHJGFF=FEKHHGHDFG>FDD?F@DEDGEDKHAIFGCH@EEHGGC>@EC@-G=6D+8(9?F?4B=>E>GAFA@);9# X0:i:1 X1:i:0 MD:Z:107A0 RG:Z:ERR013140 AM:i:0 NM:i:1 SM:i:37 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR013140.23480670 133 17 3771 0 35M73S = 3771 0 TTCTCATCAATCCCTCATCTCTTATAACCATTTCGGTCCTTTCGGCCCTACAGCCACCTTGTTTATACTTGGTAAGACCCACACCACTCGCCAACTTACTCTACTCCC 8+7?5>09:),/%81,$,7<+?)+1+*+),3%5+)#%(4B%$&'%'/*@,)*%%&,%(/0%-&$$*$-,$3*.%/$:%$+.$*%&+.,.%%,%(%7(-.-',1*6%&$ XC:i:35 RG:Z:ERR013140 +ERR162875.18637663 1107 17 3780 60 100M = 3471 -408 CCTCTGTGGGTTGACCTATTCTGGACACGTCATAGAAATAGAGTCCTGCAACACGTGGCCGTCTGTGTCTGGCTTCTCTCGCTTAGCATCTTGTTTCCAA 0GBCBHDJFC6IKG.?HA?>F:JM8LECJIAEHMHHFIBLK8K=E:6DAIGH:JBFIJJG>MIKKMIIIJKG=E??DC8DCABCGGFDH:BA::<>>8<67=8?>0A X0:i:1 X1:i:0 MD:Z:108 RG:Z:ERR013140 AM:i:0 NM:i:0 SM:i:37 MQ:i:7 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A +ERR013140.22233344 83 17 3784 60 108M = 3490 -401 TGTGGGTTGACCTATTCTGGACACGTCATAGAAATAGAGTCCTGCAACACGTGGCCGTCTGTGTCTGGCTTCTCTCGCTTAGCATCTTGTTTCCAAGGTCCTCCCACA 3:;8-9?=@=;AACF==EEG@H@@?A>DCF=?@ED=@9@CB:=BBJG?FHFLHLHIIHLJIKKIHIH@JIJHKIIGKHJKFJJGIHGJJEIHGIGGDCA@ X0:i:1 X1:i:0 MD:Z:108 RG:Z:ERR013140 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162872.15409720 83 17 3810 60 100M = 3484 -425 CATAGAAATAGAGTCCTGCAACACGTGGCCGTCTGTGTCTGGCTTCTCTCGCTTAGCATCTTGTTTCCAAGGTCCTCCCACAGTGTAGCATGCACCTGCT CADGGEEIHKKDIIIIIJKBIJIDIGGHJ=JKNJIJJILJIKMIIEFLJEMLJGILIIJLHJJHEBIKGJGJJJIIIIKHKKIHIGJJIGGHIFFHEEGB X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162872 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR242975.1167526 163 17 3819 29 100M = 4160 433 AGAGTCCTGCAACACGTGGCCGTCTGTGTCTGGCTTCTCTCGCTTAGCATCTTGTTTCCAAGGTCCTCCCACAGTGTAGCATGCACCTGCTACACTCCTT @EDHEHGIIHHGIEI@GJHHHAFGJKFIFJHIIIIDKJFIG@JIGALJCIJJFKEDEJEHHJJGJIFJHGIHGKFJEFJKEJHJGHGIIIHHDEGFGDEB X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR242975 AM:i:29 NM:i:0 SM:i:29 MQ:i:29 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A +ERR013140.9944053 163 17 3821 60 92M16S = 4143 402 AGTCCTGCAACACGTGGCCGTCTGTGTCTGGCTTCTCTCGCTTAGCATCTTGTTTCCAAGGTCCTCCCACAGTGTAGCATGCACCTGCTACACTCTTTCTTACGGCTG 9AABCCCDEA=EB:CBBD?>EIIEACC;DDE@F@9F0@>45C7:<2=>6CFACE@6@7=50>93&=-48693<@89AA3<*,=A58<44352/%)'/'$%,$$70 X0:i:1 X1:i:0 XC:i:92 MD:Z:92 RG:Z:ERR013140 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162875.26059461 163 17 3830 57 100M = 4037 306 ACACGTGGCCGTCTGTGTCTGGCTTCTCTCGCTTAGCATCTTGTTTCCAAGGTCCTCCCACAGTGTAGCATGCACCTGCTACACTCCTTCTTAGGGCTGA DACBBH7-AG=HJK=FKDIIB9:M1;GJ=DC@IFBBKGHDLH;GHGK:I>J129CJEFJ8G>M=D99A X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162875 AM:i:20 NM:i:0 SM:i:37 MQ:i:57 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243047.360466 99 17 3832 60 100M = 4185 452 ACGTGGCCGTCTGTGTCTGGCTTCTCTCGCTTAGCATCTTGTTTCCAAGGTCCTCCCACAGTGTAGCATGCACCTGCTACACTCCTTCTTAGGGCTGATA @-=CGEEAGEFF;5>CL31D5CC@JHCD/>G26@JGHECFIE7G>BC>GG;III2D@24/'.G>6,90 X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR243047 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243027.1264030 83 17 3836 29 100M = 3470 -465 GGCCGTCTGTGTCTGGCTTCTCTCGCTTAGCATCTTGTTTCCAAGGTCCTCCCACAGTGTAGCATGCACCTGCTACACTCCTTCTTAGGGCTGATATTCC 9>B=A@=>ABAA@@>9;7>5<=?:29 X0:i:1 X1:i:0 MD:Z:83A24 RG:Z:ERR013140 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162875.15307937 83 17 3853 29 100M = 3442 -510 TTCTCTCGCTTAGCATCTTGTTTCCAAGGTCCTCCCACAGTGTAGCATGCACCTGCTACACTCCTTCTTAGGGCTGATATTCCGCGCACCTGCTACACTC =>B)IDA7FC8D/DHIF1GJ11J?G=L6DEA>HEE:AGKJ>?AJIJJ4CD;=8HKFIAFDCGBI23EHCLKB5C@JIHG6IDC+BGF>HJ;+IEGGFGDB X0:i:1 X1:i:0 MD:Z:83A16 RG:Z:ERR162875 AM:i:29 NM:i:1 SM:i:29 MQ:i:29 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@D +ERR162872.9849990 83 17 3854 60 100M = 3663 -290 TCTCTCGCTTAGCATCTTGTTTCCAAGGTCCTCCCACAGTGTAGCATGCACCTGCTACACTCCTTCTTAGGGCTGATATTCCGCGCACCTGCTACACTCC CHFHG=HKHHJJKBGKIBJICHJLGLLEIMMHKJMIKLKKHIIKKJJJMJJLILMGGKFLIKMJJMGGLKKKMIKJHIGIJCICJJGJJGIIEFHFHE>B X0:i:1 X1:i:0 MD:Z:82A17 RG:Z:ERR162872 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162872.20934779 83 17 3855 60 100M = 3616 -338 CTCTCGCTTAGCATCTTGTTTCCAAGGTCCTCCCACAGTTTAGCATACACCTGCTACACTCCTTCTTAGGGCTGATATTCCACGCACCTGCTACACTCCT C:>>A6-'07KJDD7D92002-I&K(G2&92/;B98MFH)HB2BCA-E/4KI>.DIG8AIB=HE:C7J+@3KHJB6CDDHDEFGGAABEHDHHIKBFJGKHIJIIJJGKGGK?JFK=B@HDKJHBGJHGKKJKHKHHKIIIJJEGHIKKIJIAIIJKJJIJHIIIJGIIJJIIGGHEDDCA X0:i:1 X1:i:0 MD:Z:108 RG:Z:ERR016352 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR016352.8064738 163 17 3861 37 108M = 4107 353 CTTAGCATCTTGTTTCCAAGGTCCTCCCACAGTGTAGCATGCACCTGCTACACTCCTTCTTAGGGCTGATATTCCACGCACCTGCTACACTCCTTCTTATGGCTGATA :B@AA@CCBEDDEDDCDFFEGDCDGDDDFCG@EFGEGEGGGFA?@IGFHE@DDHEFIGFIHGHFI7E?GAGHIGBIE9FHEHKDEJF6FBJ=BFC?HIEAH9AGFB5? X0:i:1 X1:i:0 MD:Z:108 RG:Z:ERR016352 AM:i:0 NM:i:0 SM:i:37 MQ:i:8 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162875.7468652 147 17 3865 60 100M = 3733 -231 GCATCTTGTTTCCAAGGTCCTCCCACAGTGTAGCATGCACCTGCTACACTCCTTCTTAGGGCTGATATTCCGCGCACCTGCTACACTCCTTCTTATGGCT DF@FJFHGGIDILFLJKHJMIIKKEJKIJHHLKLJKLLIKMEKMIIMJLEGLIIMGIMKLLMGHJIJJHKDJDKLEJMGLMIILIMFKKDHKGGHGEFFD X0:i:1 X1:i:0 MD:Z:71A28 RG:Z:ERR162875 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR016352.9446395 83 17 3871 60 108M = 3647 -331 TGTTTCCAAGGTCCTCCCACAGTGTAGCATGCACCTGCTACACTCCTTCTTAGGGCTGATATTCCGCGCACCTGCTACACTCCTTCTTATGGCTGATATTCCACGCAC A8ABBFFFFB=GIHEHIHHJKBH?EKBJCGHJFEFGDHGHJHKGEJHLKKEKFJJKBIIII=KKAIAIJHKJG@JEFJIJEJJHGJFCIBHHJGGHGHDCIHGGHA>D@>AE9>E?: X0:i:1 X1:i:0 MD:Z:61A46 RG:Z:ERR016352 AM:i:20 NM:i:1 SM:i:37 MQ:i:57 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162875.919124 99 17 3879 37 100M = 4109 329 AGGTCCTCCCACAGTGTAGCATGCACCTGCTACACTCCTTCTTAGGGCTGATATTCCACGCACCTGCTACACTCCTTCTTATGGCTGATATTCCACGCAC BG@FFFIHGHGGHJHKGHKJIHLLIJJKLKLHKIILIKKHMLHDJKMLKDGIHJILLJBDKJIKIILFAKJDAEH@BKKFF6KIEJK&G8HEB>DB;EDA X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162875 AM:i:0 NM:i:0 SM:i:37 MQ:i:0 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@C +ERR013140.17460076 163 17 3883 60 108M = 4144 368 CCTCCCACAGTGTAGCATGCACCTGCTACACTCCTTCTTAGGGCTGATATTCCGCGCACCTGCTACACTCCTTCTTATGGCTGATATTCCACGCACCTGCTACACTCC :DEDDDDCFEBGCFCFE?CBHFJGBDEGGEGFDJJEJHEACGGDEFDA?EBBC1B:@ECDFB@EA>?=E?CAA@F;98@9AECDCA@>=;C@7;=7-2?>A=99.@84 X0:i:1 X1:i:0 MD:Z:53A54 RG:Z:ERR013140 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR156632.301185 83 17 3885 60 100M = 3655 -329 TCCCACAGTGTAGCATGCACCTGCTACACTCCTTCTTAGGGCTGATATTCCACGCACCTGCTACACTCCTTCTTATGGCTGATATTCCACGCACCTGCTA :CBGFIIGHIIJKJHKLKFLKJLLHFECKIILKJMFJMLMLMJLKLIIIILHEKKILNJLLEHJGMJLMJJLIJIJKLMKKIHIIIKKGCJJFIKGHGCD X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR156632 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR242971.1136963 147 17 3893 60 100M = 3535 -457 TGTAGCATGCACCTGCTACACTCCTTCTTAGGGCTGATATTCCGCGCACCTGCTACACTCCTTCTTATGGCTGATATTCCACGCACCTGCTACACTCCTT 0EA=GFDB3FBDEIGJHGGDGHIEBJJDFK72+?./;6-6->D8ABFCCFHAEJEBAGHBEEFCDE=>:@DBHGHAHDEEBCDFDDHJDFHILJLGCHEGDCEFD@JICJHJIHHFHEHJDHDEGCBC6EFDEC@ X0:i:1 X1:i:0 MD:Z:40A60G1G4 RG:Z:ERR013140 AM:i:37 NM:i:3 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR243087.1477801 83 17 3909 55 100M = 3600 -408 TACACTCCTTCTTAGGGCTGATATTCCACGCACCTGCTACACTCCTTCTTATGGCTGATATTCCACGCACCTGCTACACTCCTTCTTAGGGCTGATATTC 0?F?HBFJGGK:DHHII@FGHDFEEHJFBHJHGKICJ@BKEFGFH@EJGCB:HHJHGGEGFDEJD@HFDGKGIH@FJ?LFA>EHJGDIEEHKEGDBCCB? X0:i:1 X1:i:3 XA:Z:17,-4057,100M,1;17,-4094,100M,1;17,-4168,100M,1; MD:Z:100 RG:Z:ERR243087 AM:i:18 NM:i:0 SM:i:18 MQ:i:55 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A +ERR013140.18542909 163 17 3912 60 108M = 4185 380 ACTCCTTCTTAGGGCTGATATTCCACGCACCTGCTACACTCCTTCTTATGGCTGATATTCCACGCACCTGCTACACTCCTTCTTAGGGCTGATATTCCACACACCCGC :AEDDD@EGBFIJJIIHIGGGDIJHG;<9+&$&$&-. X0:i:1 X1:i:0 MD:Z:108 RG:Z:ERR013140 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162872.8738223 147 17 3914 60 100M = 3511 -502 TCCTTCTTAGGGCTGATATTCCGCGCACCTGCTACACTCCTTCTTATGGCTGATATTCCACGCACCTGCTACACTCCTTCTTAGGGCTGATATTCCACAC -E8?FIGCF:AKEDCFFH>JADKDDL:9JIHKIIJII>DC@GA3F;GDJHFLIJFEIDLHDLLEKIFMMGGJ>JHLJIIMIEJKKLLGJIHHFHHIEGDB X0:i:1 X1:i:0 MD:Z:22A77 RG:Z:ERR162872 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@CAB +ERR243059.116527 147 17 3914 60 100M = 3516 -497 TCCTTCTTAGGGCTGATATTCCGCGCACCTGCTACACTCCTTCTTATGGCTGATATTCCACGCACCTGCTACACTCCTTCTTAGGGCTGATATTCCACAC =EGADGGDIHHGIGKGGIJGICJCJKGHKIIJFDJFLIHJIGJEFHIHIJLIGFIIFHIDBJJ?EKHKKDFKDKGGKGGIHFJHHIJGJGCFHFCHEGC@ X0:i:1 X1:i:0 MD:Z:22A77 RG:Z:ERR243059 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@C@@ +ERR242955.586810 147 17 3917 60 100M = 3506 -510 TTCTTAGGGCTGATATTCCGCGCACCTGCTACACTCCTTCTTATGGCTGATATTCCACGCACCTGCTACACTCCTTCTTAGGGCTGATATTCCACACACC (C7BB7FG28FJ9E>BAJ3CGHHJEEEDJ>GKGHIHFIEGJCHJHAGGF;IDIBGE>A X0:i:1 X1:i:0 MD:Z:19A80 RG:Z:ERR242955 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@F +ERR245032.607478 99 17 3950 60 100M = 4200 348 CTCCTTCTTATGGCTGATATTCCACGCACCTGCTACACTCCTTCTTAGGGCTGATATTCCACACACCCGCTACACTCCTTCTTAGGGCTGATATTCCACG ADCDG?GHCDGFJFEG>D@E?@HGDFGHH=EEIHFGFC?GGIIHCIEFED>H>0@CI4(.=FA;,J/.4./BF7?3.@9B7 X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR245032 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR016352.14078817 163 17 3952 60 106M2S = 4187 342 CCTTCTTATGGCTGATATTCCACGCACCTGCTACACTCCTTCTTAGGGCTGATATTCCACACACCCGCTACACTCCTTCTTAGGGCTGATATTCCACGCCCCCGCTAA :?CA@CABDDEDEE>CCEF@DFB'42C;6HBI@9CF8K@6F;E7C>?;D=D6JG?;)>FD:,9HI<.:BIDB0GJHA.3.2IH>HC?0E:@9G+BG82*@B;,BFFFFBB X0:i:1 X1:i:0 MD:Z:69G30 RG:Z:ERR242975 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@D +ERR013140.11440888 163 17 3974 60 108M = 4283 416 CGCACCTGCTACACTCCTTCTTAGGGCTGATATTCCACACACCCGCTACACTCCTTCTTAGGGCTGATATTCCACGCACCCGCTACACTCCTTCTTAGGGCTGATATT :?F>=:+6/@7>>:@2 X0:i:1 X1:i:0 MD:Z:108 RG:Z:ERR013140 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR156632.11081426 147 17 3977 60 100M = 3652 -424 CCCTGCTACACTCCTTCTTAGGGCTGATATTCCACACACCCGCTACACTCCTTCTTAGGGCTGATATTCCACGCACCCGCTACACTCCTTCTTAGGGCTG #6DGGIHEBALI4LIDKFAIKL1AIDCA@JJ?LIK=I0LG=DBI=LEKI7LHICI:KKJ7;HEHHHCIJKACBIGJIB:JE>J?HHFECGHFFFEFDGFB X0:i:1 X1:i:0 MD:Z:0A99 RG:Z:ERR156632 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@A@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR162872.22176921 99 17 3984 37 100M = 4109 224 ACACTCCTTCTTAGGGCTGATATTCCACACACCCGCTACACTCCTTCTTAGGGCTGATATTCCACGCACCCGCTACACTCCTTCTTAGGGCTGATATTCC BDEEHGGIEIIEGJIHJKKIIHIHKKIJDJIJKKCKLGKIIMKKHHKLHIDMGLJKIJDJEHKKJEKHHK:DKDH8IFJJKBGEIF>IHGBHGFGFE=FC X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR162872 AM:i:0 NM:i:0 SM:i:37 MQ:i:7 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@AB +ERR162872.16735015 147 17 3988 60 100M = 3713 -374 TCCTTCTTAGGGCTGATTTGCCACACACCCGCTCCACTCCTTCTTAGGGCTGATATTCCACGCACCCGCTACACTCCTTCTTAGGGCTGATATTCCACGC -6<2;D9H?:AJLDH7?)K0/LH:FF,&3??M4'N2/&0N@J:7;LFJCG7)@HIF=C@ X0:i:1 X1:i:0 MD:Z:17A1T13A66 RG:Z:ERR162872 AM:i:37 NM:i:3 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR013140.6157908 99 17 3994 37 108M = 4176 276 TTAGGGCTGATATTCCACACACCCGCTACACTCCTTCTTAGGGCTGATATTCCACGCACCCGCTACACTCCTTCTTAGGGCTGATATTCCACGCACCTGCTACACTCC @ABDGGHJGIFGFGIJJFJFKGKK@JKHGKGKJKLIKLHHIJJJLJLHIHIELKHAKLHLLAKLIHLHJKLJIKLDFEIEALIGGFH?DAJC7GHEBEFDIDAD@A<; X0:i:1 X1:i:0 MD:Z:108 RG:Z:ERR013140 AM:i:0 NM:i:0 SM:i:37 MQ:i:23 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ diff --git a/test/mpileup/mpileup.2.bam b/test/mpileup/mpileup.2.bam new file mode 100644 index 0000000000000000000000000000000000000000..82bf2ad29e7aed7b18005aa16c68f92f113d1e06 GIT binary patch literal 27928 zcmV)3K+C@$iwFb&00000{{{d;LjnLg1jSX)bJ{o_zdD<|s-bCNts^+4fJI=+5IMJ=$?)_}@*q9u-_l>~DGTSdnFMUXl}ZB`w&32Kc~CqiyMi@lnt#*Mdz% z?||yN>l&edK{cIctN^i7jKK? zl>�wn4MBPAaggq~<74w+!u4n_rVj9Zv^9YaIhM$@m2L>`ec5Ts(Eg-+&rq$%@fD z2mD~FVU!a;rZTa-J)(437dha%7W{idSj1cWSyf+S$lJy33pV|V%q!GoG$8SXylcu} zOU7_W3epPl%}z--5`a57b1`^OGX}PEG3Ba)_Ymo*jgCq8 zV}mGN2UYCx+2AEcKI370y9LF$Kz-4`J+t5Lm?yexUa^U?^ss5K@oE3qR7KWLPU+UK z^*M=ybu8raZ}(o5mj(UlL&JB9yL`y}S^`v$2aB%9)uZCbU zlpbCLpdwTPAGDrVJS}CCa2MNQ4a;AYj=N ze+b|Y{xJ=~guQ|(*f9ORk(F7QS=rOavb)PUQ&ru06lR`y2j{1!CvWT@9Uh&W94vk9&eGE7ZZ9nj`jzdJPLEaOu4^pL($L?eOzc-})f>%%kE{-EaNu#n<=v;DaxH>BH}R@5>*4`0fYqeenK! zUwHq$kKiXfK78l>58i#}OJDlZ7r*%K(if*t-kC%BH{dIuLHX!t?`-eraBs;0h%fFg zEjcj+wG0JX~D1syZSCD#D+$sZETU;gOxAAIpHIWI0l3%mw=yCV8oh{78qlqjZs=6t|m8%lQcJs8f8=`%OwE> z;pq;1WikPKR)DCHfjN$-&{$#eJ}3 zc*_X7VHc2gD>m#g)2*zkGNvpCgR1NTz*N}O24gN+)wOAP5o=C}l3>Ebh*)YNCEzAo z9BzNGSiu#5nRaLV&XPX1cGD{<#0NzQ?;kR*?z^{y1lM*h- z?c1N(dvNPB`wx~r^WecdXxWF44o|M3E&=shfVu?KzY$RX<9}$Vf83+ExR@CC4k9n# zwr?%{$r|-PxP0JiSEwH!>>V5eg?t)7e-cSlWp4z!&FlgUoEZSWq|7NB60y#ZU`NcH z1Boag5KS2a?gomLl1oFhNtj50YcvJoNV8l4kw~LcNm8Xlk2K*|0N*S8Fg&3pp`0Yb za3SazZ~%LM@4A7@O9PjeFc&W$XMp+pFJTTR#{I>KaewX7z^`CFKRG+u-#w0AHz?MtKXKHaDt)3+_V!33U*oN-Q-5@6qI z*#~O|X<^a~NL&GLfF)-V7)NJtX678u!?e~UEY}iw1kS@;kr+-xWO)g<2+)f$9c`4< zk|%Q7w9g)$9o!He0VY}czDuz>V4m$$4S+KR-zyUQy(_no!-D`8`OWhZ7fb$INh z`u?U9QSA_ab^DGVnE0;0;cu+2+--!e6*Zg9L^6ty>p3piS}JH_uu>&=H5R$-`hJpI;{bJ0(H=NnBh!i z#<6;ZLpWnpQpFT0U8suN6ljplR$PysxjH2p;r!$b? zInCiIP=lz;;W<>1Is<_MdYwHdb-&ep`Q-i9()+irIAg>kKRdB(njcT9q?K)!y?B=$4BRThsQP6H4VF_#~fkx!GjsF ze&JMBm$ELi9NX?P7hZ#RP2g@YaAS-BoeU-o=7^dvODU*ogYFFYFnOMLz@^#kz#jqU z9FPydv;kpwQ>sAifdEmdg3qQM)Hb^IW58|9QI;zKit=V+U6f1j-MaF}?V7Q_eS$SU ze*6EOvFl489igUZxI^m-S5q3JSb$OZ#iSS0{{0SY>95zux(vD^WxHca!FOOk7z z3C5|Qew#86ES#GZ*cfga@Z;fJ)M=(OBxkrr0gZqsQZ9HHa}tLVFs77=fO7^O18ykn>Rg&ofX@9CgHc%3d81cZ^yEh41wha0eBm;4~WMSm0LDs#n>z z-H?=E^n)aZf`smX*9WkROo=3>E(jE4+$dsxEWo`4VZre916K&Vd8Sifa{w4F6b@@cyzBI4N|)l?+J6J$zpe-5xe zIC^ya=wz`hx$_!q{bK0{Ze4jbNa1&;j!X1@{^1P%6Hn)>m)L(5uwTp}<*=ZX_8e9T z+j2mbcl!f(Xj%5aRD|)SAI6G?8z91UWKe3NWL=8}&F1LdLwOn0It(-ZPX^l&=8vF{MPe#*}iU3Xi~s ze{4n-9v&W@ou3{bEj2DN-@AvB<$3TPc87g}t`5g|tE_{t8K77DI3TV;6XvK8Q4)4Q zavPN1o!#Bt4D~p?vGJshPTpY89Tob4_B^3uq{e+Df4InCP)yN#GBCPflR9ZSVk#zdTHaM4qf z1A|BkUJOssrPKm!nsm69#H3Wpl%)#aM1fuKCIIIXOxg$P#>g%QX9#|vWP!_YLoK{m z`jI)z?=Jn~-6vyyesX$rc6fe;`40f*V(Eo&_iEh16_;L{OP02mZ4wDzX_g3?(XiFz zputT-;gaN8JLSzZMc|d7RK^iwL@}-eKn~YIF<*kY^F$M_h3AEVj`?h8_KSf1`Qp&* z$3g$_Wnn+@hu*w3_J^*_Jp$<8nhh2noE@K@?H|_UvPk`za#%S|*Rib1bq($JDl@c) z73~k<4Z{m2jF1sJ`rwpjCe6T(Gj!20{)9vx1F?gPufUQOW`1R^kR(Z)MDrsm-#mqgt?(umrEa9V*L~71kGXnci_2SSeniC>>VAR9iN@lU_TAoK3II$?UlA= z^{UeCmrjEaMg$8;?0HIoqA(&(d~o0aYf2(GMj1LZ8JH^uU=iF0$@LQ6=+Yu z{?!TCSHk4;z#^-2S+{s2BF!2d>O2>b=qN^a2RO(#2BbxOF|* z^Gg8sgV}v@iF95^Q(+jV=)hG%Wl8@Lti4hMbaQf9%4NjxrqpTkvf zEH`BnP!B^8&<)BBNNckWmK%a+qxm{;jetK18G<-BDphhPSX*07GNCcOnE_#J#4O}+ z%F4EaV-ajy#FTPMUI^>AUz*OodQ1%ae_UYLi1oiVXV`~;_VMNU_*^(si`tZIHa!r_ zLeMy9`<_uT*WhCsSD@zBQe|r%l>jdReo!0}J>U=lKd>eh3B~F+1+=2GH#E|{WFZy2 z>A^3Qq1tePX2OI%E#33_Do@6S{hJH4$gkX3$DTi z;XDjjBK@`}EN^Giw!NsOg|hr8VZ6n{1pXB1zxu(?LQ90fM%xTX1~lIoH6{ zxl{^B8tXJkUE>4L3)AwQ8;kVVs{hvobp21ks=sXp>C+RC*L!Cp26-NoOUuxKMPk8$ zZZ!u+)_{%DwaA0RP->JOwZj6ULuYllNlMZ6(O9f$WJExUbnq{DvSutaAVj!=H+PIk zSjJfgu7_0g=34bQHy;A7_8is{toq$qtk2m1BDCmiV6fVp-I793-Agla=n-ehe` ztW}>90-PK%9d0t;A!0pXsmL|ez$l<`6mP$Xm<)T5YC=M(fRGr@67Qbze!Z#lxL;lZ0?MK6vmM z#QOBX{?UWINAUCDpn(7GMS-b%ucdx%%qN(^nU9WOrspSTfS+V_>gdQb8FmR*#jvVp zyIqTTF^D-Zal^23IIoj3DY}CSoo^a~+~AcBwnv%bptmV?zG7-rFSzv1p#Dx*ei#9 zK#01fRWN(#AgMS7!)R>Trxjcf+i5URBUpee4bQNk(u@M!IlAvzopA($?{qRaI@4W@ zdhd4X)Ft|poopA*%3XL>ppE0XK@x?vYRuctm;_(D4R8wL$59Y^n#Oi&GD?Z0n#Ym}izyE@Oe%sPAq?Ei zHU(}GG*|`?M@a@0lz53NLU2Fh_RV)Br?9^JWUMDC$`{010s&*#E=g2Gw}Gj*qXfVN zkUDkpj2kWztkjOPkOHA7NmDJ7&}G2WsYsNUB(Vs2;6!bz1EpA#2R;pA+Xn)wkV9Sx*5f1cJ8xg_(D@eNkUutC@Nm2jXXO5QT`MT=!V&pI;-EEgbRD;F4G2Rz zWCKwlXE&Uc6>D`T-Uh|TBH{*LZ#T|UI&?U8=p5f5^BxDKFtX~*Q3*z1|F5}Xs+nl( zQ&@TiY|F8_;(~$cDuEpb5*!(ncy;$FFaq`=WFYjUF@nOAK-oygM%HmycnOm=b*2nd zqmVSl{4drCnpl7%sVD_M#|Y-#SP6J_M!s|VdK&{K&3<+U?3o1FQ>kNM*gB91a&s(Xb#63;LCGW%WjrX#o?G#DZ;O?P0C=-9RxaF4T17pMxexV z1wOtGu~9JPCIkN;Tum;th;Jy?7fU~SiS>WDfJ=Vu&U`ED@!sLl-oe5C((i%Peh1zH zpq5jh4y_TW1J@}jxRL!qWmlO0Ev%j?EgPO}gpzTgRyTv#qia5>6TTTGP7~X+1E+n@ zUTKiDxg0g`hYdU2B(}F=ah73mNTddOTd%Nt(?XPo<#Tpl*w9qrEzD+izET@*HN+dR+~u>`Cdriu5eXA zC@}vU#EixIWa?se(=&kNG1{v5-Gq{Ne2GomM1$YJ1x))@=LhP10TteA{W-Eb>JZ z&KdmqO*}mRvq^~Xievs6aLiwv4G|t5>>V7BT%Kn}x{F8y8Ceawwh|Jy6}FQd9yB9& zryV*i?lY3OP2zJyBci-^#C$&i`Y@y!OC1RV?!HPT5B&&?KA{BMNH}+8WNk+)jW}t8 zpl`a=M1;z4rvCWspqMZ9eqFVK#YOjGGMnI67Q|05%QM^5Fv;kQ<0m6R>CO=fdm^FO zV@jEMXfSUsa@hl96k3wLLv5J|N?S}CcvuGs1 znIa(JGbIIg=i?^_r^WGN6MsE5$YaU!_ZPUD7*=V`ls?RaP@aLcZO5``Svgg&VpZ8C z5s$Eg4-|>)U{*(Bg*+z2u!JfFrIP1$bv=I1!Py6IAJk%!W!OT+u$9|zuzG^I2~e6T zHW!*$X<=wU;9!8qjqSWFmcD$6^*_FSJ!kn>fKE>4YV1$<&yG$;(b$hAYNQX_=@q@Q z*EMCyoDxd}X%e%*ciM?fJ>q#T^?AU=#s;{Hk%(-Q3gI)j8Z-^tLED&I3ITdMRlp!1 z-;);0m5#T!-JKA=?(VpjAJLG}`*)iGY29vxDV=EtJUx4~e_Sj+F>k+C+y2K3LRJL) z$v-#iZk`{VpYC6lz&<11!%Ms^z?*^nfl0!hFI7gR$>2alj|Qw9JsI$LBzA^ia7q)D z;&pu*=6)~(lwqT>&cH+BDN8}1hg|900GEKBGeRS{$plYssBK?i{ZAM02xc??iy8Kw z$y`1oc~Bg>fz95u|2Uut3u8vWTCt-T+)Sp0Qq5q;q=26YI8Xwo9up?wVahm-0$mqj zN|k6GF}MY!q9g_{M+q9k8vtdKP!W(g@e~Ms`XXVJSA+GKM}BXCU8i8ze|D~u;dJll z==|t16#Ma3jPo~Kdobu%!vg+N^~y%9Id(*GkB2->;81IGrZNo7GT>>9zXpVGB6Xtt z=CbIJHX|g`jHC)EJ7kHBV?i3tDB`SROp=R)ftTth;Hhe+RGfs3X{=9=A00p3Kfi%I z@_#SD`*(r2zkRlg;q2u26nwkvk=m_`*5I2&I?1q<{tawPOIdE}EJGdphTn*t48ZQd{5LesaAn*7 z&w?}Z_i=XJY+cXZ5%9?68TmX`ZP^xZ4q?2$)v?C_P{(*xElC)L!3DI|7_$%}$BB0uN5}xfi!{f&6~#H`bl}&(VUS5RjrGYP*!F^nV6V%zuezeJ zj>nqwDzV<@!@0Kky0+&l@Zztd=KdI)9!}ZxfI0A<%C()ToF&6}HdBFcSL_A}n>5)X zAx(l+RdGPjioL9Mfj=XCHTNZQu_~Bs>U7Dl@?-S}(^|2Cd-=Frx_b+rnfbG(>V91?UJVxGfZ1GzF3- zP;jkSLRcW_bl>0M0oeG-;<-t$hrh=S#aPv2&)GOu|NQ){Ho2_ysnGAdhuu&g%h>E1 z;)AQ|lU&9dD-8{XP9+m87D*_mqr%9Iw|pYOZN#`Nh(!)pMD8@;K5(Nuk|nVu8myWH zUYmqUCE)*u?MV1e09S&!OefPu{@nok@lo-F(O|FF$oKDDC-U#TJ0CkaIX*r;KEEu` zd`8P2^qFN@L(6je7sRKm%>%+|g4tolz*SdlhboUU;U{Fni-fLc&;aEFVaE#d@NlkX zNc=R4z{+vV5)&eDsp2F7zeu;kl-FVL*8^5oi`PCz1`hT+%bFb zcn z5KG->xmO&_(F73IHGbJ%8oS^>il2RQ`v#>cOda)k2sngxSZig+t)7qdpDsbIt< z5t!>_l42tS1@;z_2t`{r)~6q9l>h3^s6_V8)N%P6K;J(+OW%k4`{2}{)!p$p0J(&> z^np4qp|%j};RI^8TlL*O1^34lwq4QTuw+$HIStzK8jaoixHL{M&Be2#%DeVct@K3yhzCEv}Jc0_xKw(|l z2Hztu0b{T0*YXU`Pk}A2IQ&jxtCW(AZbw4E!Ekf)_2Y8;e|Be_OS{4v^K0KXE5fI8 zX$$Fsn%ah`?Ksr3L4*(BytE3-!EcS2VfZgob$y8(1!2Lf&p{VTU=PqFG>cURK6@@AfHpyKp47DGxCfXM}b0_J%TXN3>ghNAtbCkmbD1J7IinqWZO| zGKlwUiNXH<0;q#F zJ9Y9V%P<<7XPtV`iGgQ2brd$m0T4JCtS(l@FLabLuyiHUn{3l#s$RK!y))_zoR_c6 z#$fmNj{xhD?0aU2UFP-&mE~S|J`dsUcM}OJkAv*P5nw`zT*)XEz!O=f^ITwl3?s0e zOyxZ91StA69C(|Nz^*g!?YYR5Oqy6dh{T>^UmM&2jNRl)?>}`3HKrryi+WIE|M09E zIZjdj6L{(Ioe_PMmMMqBs^|?b>BH^ynEOQfcs}ixq~01$e7CU?ZtbipEnQCs-uBMg z{g%`4f}J*LdfSriaG%6}&<;aDJEGHdRA(4~eYE%Bc=24S*PGEv?_Lj1ZQh%oq<(gI zczg{0`zWKc7}v@v26X76^fpz&9Je>DEYR8RaQGO`v4}Aa3NH|b8IT$VOXP7r9gZ^5 zD$+OsiN+BQ(!?bqffiW#s&Pm%h`k(JwT-R^%D@SkFt{m<5cQmJ1%{4;!(YI}-~Qwu zdGHeb$OqjAep6UPkZpPp-GxXe}_!N&+(3Woug30HtsmNqS_g(l9F zLt9yjLBcfR>%Oy0yu`BOw%rc4)+63-1?xe}-vIYMNi}0E5XDcTPPD?ZDh{ArIdP5Ng1T!3zRL}WFCdUI3#E9ZqJy>1k^*qN>#tl?EsBr@a zr4sDs4n?}c`g{S_pT0LgIP>Ue|KRZKvXA(=p*D}PL)*alh6xx9l4yxj(l5vSkN(Z- zeHWNEzC^mS3)F#|xiW@hlJFGG>w)!IM}lIZnDnU!onVRxJewCeE#G?k;lr0aru40= zX(r#ifVKm``eH7|eSCVpcRuphpA+a|*LlpSVn!r55fD=b(kO<>VTn0(B}Har?UCm= zauk22napwYYgU7d17uJxqUqP@;`daJCM1DJByi!`O&wi-akVDkI~UmXp9ideZmwAE zcz=I966smc?e~X$25vnLUbjp=2o?o57$Ejf0=8LgmDn4Cc%ny+Wm5TQDi8i!FGH)R zLEwbg-H`+zP42<@#`yjmuLt}N4L(0HH=jek_wIG)2J>g%H9dKg=TmkUQck|kF@94U+L`Z~NcWS=~7#oM*0mPuiu{Q!N znn_%vAzv&w^0FUq|B_4{DgAIcJ(W^%ok) zxL!s&OkMU`?1NvVsg@zAKpiGA4V$i%Nd#2g!bp^20Zr!j1Du{bctW|_ ztIxbY{KVBM`4<DGSG@LoYKbX(GWU=57LOWU*wc5%a>oTR!llXzOn%8p8~AEXKv=# z!QRoq!DvAgLR~!%)PsiSgq#IIsMglJI8sE0?RH4Hl*HZGY591CM@(88MTC9R^OpRW`;$#N2@`JgadR_mNnfp zcEDjLxD`%CfUHh&^AprD^Q7J@o30>146tDd+Xtt;A0PLg;!(+O3cz z#ERps7{|ME$+mCbwl<=K#+u!}K1KREmw2z^w8SG~l9t32*1pY4; zkjlThH*e=SD(Up>ctk26i>)x!Ha*(_r`V>z0kKwZctNm@Nl_6{iWBMq%{T_Z3=U7K z>(VsPFW~>+R7O%Omz;yl#wuAIDNhXFF=92lY-A=9_;hT`vIOonR+n`t6GcHdlqfBv_q| z2PODIgk!@yCcz{L!PV4ZC~!3(0Z)|Ii?YETtu-OaNN{yP>qrJ?uav2jH&S}zV}fvN=EP%C0nNZ0kSW>>I~+vpYuX9{ z{|Hzos6Btfsq1mvqLbt7!Mx7i*OQXj%=rJ)lWWycAII1)`B6+VW|$qb=Q8e?Mf>t> zc5*6XX7w#r;lO#z8CGRk3>oV?OfZ|3j_rtII57QQ-}H^!9hj<1hl9tUuwzGi1Pl~} zbmWDs-E3Nn`63q06@Pta!`fb7376^4j@@XkxR$q*aH0e7baY!wAI{7uj$Fb;dn;%M zJPsl%J?XTV?YU9lvzS;nxA|!j1H5;=xB=tcUzy98O~tmKZq)XaQ5)m*8W@+Vi$TBy zWiB`<3veb03wYqgtq=~&7K?o8dJUl>9ATI8JWX)I7e@IqOj5dS6SOuJZ7M-E_?942 zD3Q7yMKk~>$d4K~9_w-eiToG<`dzaz!2Pqcqy5uSA<6St^q^n%hvnmY0d+wf3!|6< zhy@SUS}u;00XIdvJC3*E>@ecr+1&B{n1Wh~sE%5S*YjeNknxNqJi~1OIh=`_-D|gH zh=KCD(JbCfxFF3J*zNDmL$F|s)kh@O zI#HQOnuHWYUe@6lQ)PL_;4pODWT8`v_dy66MW!mPcf1%5q>RhYaPgVM)>nNwr)MN_ zUgU6mHFK!OSU>2CFyQHn|rG=-^0>87_D6ct2L zPdZPrVybQf?$is0aZs@_s)MB?aQj&?5^fdefi#X z$MFjQ=x1jOcTUcZ_D(L(#^*)4>Rki@-sEkOxE|d0k`Y5Z&4~b5qnJ=|Sq#pNPO!jI z*UJ_dPPpS(y)Af}tVK8_L+>W618m|q)>zE!#4s81#Ka2R{6O6NhWDRX;LKp;^}n30 zXPu6+Ue_6J)pOmd8dRoN*cC!=K&4c6*(*wimIc9X4~F}-aHuZhn(@@ogx9mVHO@{G z^&TRL)8?@(Emc{PrV{h*_4ka`xrEUm0yK9)?qN?L+yubjUWUT_<~xpmegTJIe)6Na zMue$cQvz7A@C$M*ss!w5xg$# z6S(nAg5)r`YzU_jNYTPz2wV>MMFAYIT*4>dp5O_xihPlBomYePxFPtb?v0xzuQ=pK z0nlvLaXdTQ1A$%Fui=pCk4L+A9c}TLda?Fd(~o>Ai6BT&>p zI4sKHGzH0xiyDASaJVT59q(r5e`~DAfstQXa7O<0{rN2|Cnq3C4i3iiUV)m+Iclbb zQw~hG*JTwOQtB{P6;5IGs^PFK9+QMqBf>C>wt^@ErObf<6t2r|Qx(Oj@HqB6a>_%3 zJF~RjR?Csk{g7+vfqNFSha|APf+ ze+?l0so8A%$??g-;n67MH-83xEYO2NMHwNeI#fW~0i~WVLo0|J(vCp7`I1Mr4E+$u zoui?%7Hjf2iDg2;Zx02F38Qi7Hxt(ut0azT)7=gN*LFNfqsGQYoPc|&MeF89M#kx} ze{t`6dQ2=YE&cp#dJN>q!3nSk7FlAk<;Oy6Xx*M*s*2G8kP2f1d(Z$J!NW$Ls3RUJ zW&kd0pA5@7DZ@&Vx)6ReJcB1J_JSx0xzXziE`^|EtqIp-n=%R-M?ZzSZ(O0}_gzB% zzfTU!E6D%l{rL^f=X-l#;a3UC=LXy%E#YC^FR%h-nbat)u_FmcyUzToymn?p?N?%X za3}5HxHX(opGhV_=Yjm7*lt!2*JU^~)=FZA;Vr{8P31EsBwxQ2{8tN(O3au2%&hF5 z&W$}6(#)oXc}&2qp)zJhMV_eJKsrdp9S(Rata~z}CU-D!UC;5#>kXjwx}1!nR|)QC zy@(QS5P>C^^*SAcg$;0MVjr2lp-1I|tL6mEt`P5fKv#S;n=oT(&C5-u|05GCWt_Y?uo1t=Pe zd_1PW$>))ZfiWn?`P9Xn0}PFNDGUG673+IzJB;HWrwh#lAu&L3R&d@$<0{Hi;! z-+Jr86`gWQSW)TxgV6ch7MQKd7MQi7=n#U)m_>0IZv@X4@X4Mh;fc+(g1 z>|a6DySR!De&PQ0qZ1>Be{D8NIUOB*PM{5CkCQMA91*vb>0rQ$U_-EoMH+X&35pH& zQUjY18i-Kk(${&4MjawjamF7W*9`21k+cmY79j^_7VH%=U6=}jK2wc{WZvWVr!$u2GDtZ!?KaJ&z}Qu4gh~QXkw&q!9kbADZR;3rg^Uxj=}k{b zzrgtH;>l{Scka}W-M_xQ5-TJAg}xETf4W_*lBFvUum{l0JXw+N^$&P z|LoD?YO2>WmS^k${p12B|J3q)3gY1Sbnp25@Z>VJHev4JV&(>^UX@r~KX52slnXbI zEymWYcEd@weGvo#td!liU0~)miD~33ZDh)VR>DN81r?#rOcD@3plQe(&8^k7ZQF}t zAZ(x9PPT%GtvVb_3qkmhEGChfPGcS%JUqQggBr)@=1(t>g%~8C-Q_Y95dYXCavtcS z>)PzG2yv~D#7VoUuB%9J$(hbF9HFZP2=FwklkZsv8>6tZk|kJ0D5XqBy{n_<)zRp5 zcs09RtShmQR&fwPH#fO9mW5xNoSRozV~G3*XNw`m;qV`Vmwy{x1_1j8x1Bi*AnjTh z&2qY|%c`o|Gj$UJTnY*Trs}b(OIbOg5}bk|u@)+ktQ~WM6VHX_GLRr-z_B;r-cw%) zngK%_8Gs%UOkfALtec8)QKiapyO+W3P`GhHsFuWb6h2)}|2-HmyfN(k_FI$E%zt_R zdTAzxZD-fAjzhF{x!`jlT>>B%4MDL4N?>F=+G)0Td_f}6DjH}7egzBtR^n|3QR4BC zk*MYExT_vB_593wLcNS)mHO@GmK*qSEW^eciS6aEx#N4WhxKueV0;UW3Itf_jcf{jF?N4gvN^UxUt=~6Q5){SGfIF=DK4H5nhbf z0vTUMHx}!08|ybNU-x!?AD$z#(_;3HkIoMd50*X+di(Be44#ZY9y}Rj1|XXX$z@nM zR?%=HKXQ1`^c+7HgeQsH-fYKlu;vAPV|gnMqMbx5Z)I~Uh}YW$!D7gR!(}0&*^#N%I z)Jhj9n}Lfn?3!L_hDG66Hp1WQv zbxOf8rD@b**zcYxKN27ZHE;<{mByA!9!o27;m(O@vJK}f?!@IH{{KUA?bFNGr65LV ze`(g!nU2POEPqUywgoPaDTl7@HmHyU`}t5{D3W5iAl6*Qb!HN~oUjc(l{o1kujj^O zsqEDGHB7YCiRF3=2Cj`y>p8J?uY8KdRw;4}Huk&#sXYAT%TGMKHF0vjbph5GR+(Mr zHwmHCSWnya;Hh@qr~L*ncfzDcW7=GACfgvXxuWe5&PuW-bOySvlTjYPr9dk0NW&wB zEo!)mwUyumZ@fx5rga=1Vt|DOGQ*1RSa4fnl4qvo=iszBU7S<9mgV`xO9y+(vcF>i z+88kW&*#NWeMoR|Z16${rUV;As*V>`@otg-;d zo|ZlEf4X+BGF{s1!?(w4F4tkJ6>&HSL70TnOIWHxie94jTDT}GCV(3_hhU(%kr+LD zZiMgpE)fFjuG*GI>VdkrV-C(llSg3kCcvdqibd+?whE7DJ^cLg^{x@b`u(|$7W>EN z$Cq7x&jIpqNNGu{#tyFs-@20YOE+<)v&n#OK!0F0 za+Yd}5ta_hYlS79IVK^%?~!$D16&P}OwZLgKYVz4W7J=7V%YzDfnop7%C#{)N5>~; zhx;R6at2EQSXyrBxE8gYqFXRHC%YApOSea<00J3wyAHv^28?JhT&+q##2KBynFeI5 zV#O&gNz77Qe}k3|YzAHQ8;P#-P zk2Oh}TRdtJus;yT33ps~bxUdhf2S2Y&F%V_6C|LC-)j5BBP|*;7B-yaRShmYZElFh z8fnL?YhDib17lXS7FiK|1ow7%WD6YqDXjM%UYlP01j~N!)30E~*~GHZOP{Ba?_XV7 z`s!?+a{v6~_~0_SeQBw!^WhL2w3t z7jR>6uGtN4X1I>^m1Se(Ql8Pd_EW zDU4#X-P9L2551nJrls$scnnGbx)CetB~EdaQ6Ry<6AVl3i+ za`t%KJ3l`^J001znBs?O;0U)G0887Iu?GgHY%rHv%uok6xZo~7%RIj408k32>BNyh z15YyJW1*`81+7&9vyRoS(AF7`f#QgP`<2^@MnmPz2_XjYuiZ6ZlFqd1AMsLJHIjzx+?HP9L7G5|YQ z9G7!}pPxrchS*il83W4ZItSvXQc*e=lKKK_lErzl*K6Ouuz*WYe*f87w`N*umpy6^ z>vdX%1(;H&Kd@<0RE`1e8;s%zBHq0}nINz^!pW47V%;NjV`WhEcJ z{qjBbVgcG$xdas8e|dht)|J?P5ww#STo!_TzNUj~K!I;D+sNS{Ou;YjfEZ*rasWHB zv4s+c6^{;4{=wNe@HayhB~S$g@5U{CrG)N=I(>@2d8r{}%A|cg|K! zo$c+NA001!_3qNr--1^bS}mivHl%dA!ZA)!x?)&41KM@qhfT>2Pmr)3Y_?9Rlu2^G z$raa>$kAwSu-Z-_cn%jqgAz=sVRSw5R78Y~JSRYwNEKDjm_qm@)&o9c;`i;BzoG9+ z`~A)WzDBQdZt%dg2RU!C%)#{`Mahb8zjTU0Z&>u;Irvc^&vdEV2ynE3u6Y)_DC^14 z28_I(1&DPD=^J&FwS#kBJ6fc1J%!tJIvtZrP~bItgS4g?*49ArTF5X3=`B$EAz$C% zX;VLZiS_F0^$gkVwfS<_le4|kQ(UC=1GnMw+*w*0T$yo!X6#PPxNEws=!-5+5bPO) zYc2W|zBSf1{1s;z{@{UT+p_PqWqZf+?EBlB-mUeuZSJqM*JAqhl~GNbx2`qd!NJ4x zhu7=pUtcxgcs}FF1o)}iG%);MojoSUqFcbn_HfTdy}WGNknIw8w>X0V!tB}rHMRR) zS_)hY3KX$uxk4txh=tzWwaxbSmd|KnZ!?Cp?I6TO zA?dC*EKIcFNvLtJd%YvxL@76QEhYyaNn@tQWKq4!+@PGn?TR>FP|-vPDVX5=rj9hZ zm;_x1tJilCeG!=Dt=U?@z5SEDy-Nok4@umu+6N!r=~fPilhU5-pR6zp*n=aras?gW zQbg9M=UI+c>LF`u98Y2}8IvguPK>VqCNWBa+n<23X-=__MAh93;B11l&gu{0$f-QW zVa6uJX^*Mu=z3EhpN_en9z8r*ywvt}81~gPV{{;$xuENR1YrN$bJL9X56{j{k4LGS zXS3#F&~>TlBEho@kA&a_wvyNncpOOzZo22i?bR@GBHoI0K(yS6sI+O!V%biFis7O% z57RUvmbx8!bSnrW96JSW4QZ>yA~+6($%rR92pMPojkWCWn*w`&D>-`gKRz3Ez4YM6 zrGOQC7V|Eq%zIMEow7jSu2pJ4@zJ)w-4aYO-VT9SK(r_sODcjL5Hp0SAZT+pNi|3r zP}$9UD;^DG(`zT&ei%p04}3zxb|c2RPRDA_xB&}7v~T69xg8DzWZ9Ytp59}*Hbxv9iIEqrP*@sqm$F~ z%L!o5P9|k#I}Z3i4T_Vf6lGi_wG>B3#~7^pOASaxjcPlq8*b_Zd@kYKtlwBqJ<%e- zc&*}DJ!uI(gT3;e0uNuMIN^?CA@WVlQCGk-8!G&P0w$8iUUL(wZ} z(JOk?^o+nIXim{cK#x#uM6QT3yT){I6cx6}Yb+85EwYQ14Ty4*rr>E}#Wrpik*ote z6J?hRFR;=(uN@^LIaOOYkg%SHoQm1aPiLpa{>>4B-AQ5KZ!Ms3boBp|*&3cpr~WJO z>aQb(1H5d&uER@5@H*i2JD|UlaEIXl!qf~)PZxJQ@od)+^hsq$Jk;j=1`1E>BVX zkRl4-mf^;~#AsX}syN5;2<$lKVrI(S!BKH~b2Q;q878{%^JSRm?$1{9OkDf%27uzp z)=Vv@Ybu+$28Vm&91fS-!i;vfP!S8RJ@^7yn0nG@B2GqAsWhuwCPmAC0Oge*hv#+?O0YQC0A6(&5b00m!})fa09^k_1cHmvUH(_d~D$N z*RCI!2VmeoGh5qzaC&%td|5|7fx3DYs2$htVF?4yJr^AFX!UyX`@RH65?r2ol1zqP zkH!WZESSQ1Ckl5KbuyBhoFT8*Ib@s@26sSO@88OB>RtB2^EeHM5?K&u5 zD#ivw8wkZEO&K!cHt7bA@o8Gy(fX>}bO?(z^18beNi_q42GE10eo$HFo3hOXPly<=mGV*%$Pn{Id0Zr1l&ZVTy$vaO_X52Ao=RV z4R}7L&fN%&!mxuYw*Q@I2KoFN*K=Wm8K)>+>pU06RkKp_BXRfyLeDe z8lNyqGT-=w(UiYCw=w%Fa`L=DoBm_)(04*CDb`rWok>NpFa$SM08lwfYbGeoD8|JF z$AxDchy*9!2}OK`rQL}Fs;3byUWK>&pl+xFnx_dTUg$C5-qaw~gUK2B(d3N0GV6Z` zX8ntE8@E7{>>XTXT zxq~YbJ2(&)KDDc`f)IV24kk4_xP#cBiNmcT1XPue-m1p_?9L1VvET}tUL0$O2 zD?t604E{%%TR3Ic3`v9~OktqF=?&oQ4<+2jYKM4jI9P&Y1@6w~`l{1jXN)c1U0!!3 zjYa#;jxeOPwGIw9V~L74vB8VAByCB#!NNq~3~fSbEi#0fuFX5#dvI|6=;(T3&C=Mr zcrC$ZjCDG5-ZO^j26J;*r{kYbxKq2s1vt~95M@EY?E*mHGq~Ib4jO3$9!K@Tgt2@| zqI%0?#wC+fQGyFO>p9QNs2u(vLv3)Mtf|K?qB3sNEEQo&jErM>lZQHA?M(Trlk@3H z<$e-Kb7O9X$m!|f(c$QPnpRW>Th84f4o(H7s1U! zaG{77dpKg$z4_CK{@Q}`X$Vk%)2zpQa0Jj2pRm^`Dx6(nN0(k+iI2irK2pJ#C5c}X$} zdcIJs`4!Y2O!bWZjRlbZ_tzjl**iEmK7{|~#{fBwmRrOl-6!w}wx$;)*%3UkCFe2; zQx$7LL(3;jfm?VXKgCq64}*Kl{4 zaOg!0(BhUnoM2J!x~jkH92fQ0OH*)H3RYEv03*QLI1Lx;J@UL`FcpZC`oV98?-u6^ZnDk!+K;Qxzu50*#|sb z#Iv$&hxLRz7}%^V%Rvc$@0BGeVfa>dd!+y|Bg(IPIL-V2(wdG1BBh}A^D0cBJO8VIGqr(W|zg)3>`2qYfWZQqyJBamwx5dv-qhocgg1x45sD&mMo zXzSP;W3a9rCoC{0fVXJui58g(_%ko~y)^JoeDdYP+?yPm7*w7wuEF5*56(3*UIvfNh z!2oB*i>f^K0h_30GVPTcb?iCE5yPz0;P|Ot_QQ5WJgKIklm(shr0(^}1H?3bUW5NL4 z-E6YAp+KLpU4`6VP!d8Dk|H+bD~>yowB?LIin$S!W}P&n6_KXzMJ?lp**4z zo?)$Z%k$ciT4}UmMdb$O#si-*O+@JVoH8O|>%oY0uFK`kh~!8?tcaV?K{AN?~0Y82F2{ z+C6v$U5!`F{VnU)lUAPu3;*2gDui>CB$q{z&x^EE0&@eJL73D7$+c!ENQ_b`W=9OJ z$--90MDuzn6OM;dNsb{?OV z`SZgC!UTQ%|87>8jQ#lvUj9uGCQpPFi`u(3TmYONUm=fxr!(x8{j1=oA}aJ-Qnb7k z7KzyRgbcQ5%z5HRaU7>KWx`W}gl^Dk8Ic5`jH86IG=r-Xxvh=Bi9yK#yuRipQO0k! zNDB;G@NkMvzPs*7zbTM|dH>KQ+l4VBU`~gwh3HreNT~ zP;hNP7*b?!=l^T&YId6jg0PUN(wZi9ob}Ioy??W7*OoW{Qmgiciv^Lm_KM(Hq8zwz z;0bsF9s>#9rjO8>G=^YY5E5$1DUqTazKp;9W_D&ii0UQ&0d2?Xb+?Szy0smxzGYcw zj#%L^LTA?LI^boceC(^bvG|Vc)sMBIW|@k6mpkfGLcQ|140DZGIvofe$bFsJy&{e= zkGEDzNmGpn3ctYdsoCZ^KOlccy&jjR=aHkS9J7vNzBeX(STWFjdQz{D z%3%ofY6CP3fNt6Q7Fc9g>s7dgSE)G7lM0F?I4bclbV)J^T$RKknms%y7KcKF!909m z(p>C`MRdsHM@$>4C@N`?S*%1gZtCO4x)QW?jVDWS{3R&OZV%bp%>-Wi^vSD}apdnu z8ur2dZ6w$~|8j001A02m}BC000301^_}s0sz$*&3s*qBWrq= zXZHNe>FJ)ftIKx%*Z2Q@RppMl-QDhP5kcGSIpf{c*=%+P>97%h$&wHPNnjVa0Ew|> zBqK#a2(1EA6cQ06qU0hG;vzyIa+Ta5tq3>Vpj_k@5doLcZl1UL&vy5mnKR1HboCsM zU1g6>Ki^x=`#kUae*UQkjr#cSj~fl|hrj4OX#Cs8-?%u{_&=MC#*gFr)31H4-#K#-2YCbHRu6kq`>c=JTPy7z*Fxv-!;P`FQGk zvpLH|E`?EA8|{p?M&-G6ILb^HPTR6qmd+KnDk@zR6)wf}RwD~zge;_~k5~&UnaE8g zxRkQ6rf{OG3sdM)$EpA6-uZ)1_s<)jjK8tJx8L~Mvu|Ag|2Kx8oa?WAa^Cnl{{G}g z&wu#S=fl4^`q6Kky^W*sH!q=n2v~P&sQ=|P)PDi+|IhDz|NBc&pPu%Q_VzBYemSOY z;l`tu;3I!B6mHyFi1`d}7&T*^Gp)D+V$SKFu|?&ysH#$xB_5pt);%CyxuV>avaD=T zltr&7abDv&Rt49}(psgR!n>?7Wl?CW@I+wwloHv!$J)Qf`X;RXtw!UUD`DLq4EFo| zi}lZ6Vm$!Xe)>i4;Zj^T5ZCjSxZdA8 zK0e()-aBag5kB|x@8L5`aEsS~d$MRg{OrS-jSZ_(6*pU3v2ao_C3Knx0T)W=ZDrbA zJXRla9j0MwR7HFe94Udxr;uI=)|uYO57YI2VCGQezHMcO0}c4Fo?EQfh@@woW_5qeJ)_huCzW z?aEk?Hdv#FATGfwy>ho#R5)>Q3-A!pO|M-_wBw4Z0GH53W|RZJTkAmM_WpCpx397O z`Zd=78d(4C3f3p5eH=#@T=JQ)j>KX<_D6g?!B4>5+@J7qQzJyd58w`>T3ZMMe7MXj z#glF>P0GX6_coe4k676H0K8+EzZrW$CIZP#nOP-LC4+|@%UY>uDw(TTMroVbI5#o} zbxY3P0PEpf#rhv#WBn7?STDfaKeo!-$AiJ)-tk3Te?FZ31^1hbBReV{<()1#LIdh< zu48E&lX<{nn~Rtwp|&lbMR}lgk;jNsP&Yp0AY>#@v!orxtQ*D*|CrWTFsnM;L|q(*O}7^w_q3}3YR4zR2*}lVAGW{C;3rnjs@^pp$ZL!=XsgRWdQ{U zKC%$)U~2_F@}-Dl9_oxSi28fa+`oTEmi#wh?r*IycmL?*^yp-8!Q9I{u^Pn_=S^F! zDQ~qFg#KhaAB}>Mn>0B9Hpq_^9Esg^t|BrJmUD?y3R#mLNciErb3842J&wfa6kxBA z5S=bbeM6_?B$A{_l&N!QO3nu|969*DV*Rx7GnZI@_l~&!9mMq~t8u;GKRSh#yol=w zp9HUsb89Ai)``1J$ar(>{YOC<$9X3LF-YOk^hp@QRcg*-AuRG`R0p=R5+DO`W{b#3l!~O7`g!WHg!u`KVbg#kvKLGca zSK!{?J3Ttx?;jjosFIiRh2rx|MxVO*xHX#l<6t=S=9JuI$iiGp1tDldt|c6~O28dT zNvOV(>^jLnrAy%J;LjbaoI~hV$|?sHV`1gthAL$=C)L+;C4mi3WRXz8H}^EQhmD_o za8nTR>P&f~0I6{D%d5`)vPkm(@u|N?{w5esu4rWRdg1*FfAi32sgtO=&A7j#btJMf z=Qig#Pe`3;tVqWqXbeDB^Me%AP-OLQL~ zly@40_|t2|=^PzP;eBv;ba*;AZtOj5G!!5oEr!9^^Cx0FT}-Ee`H%tbb2Uzvn-Do!|2e8qCK> zU-$lX^Ohim=6h!yl^_hX?g|cZDs{%CX_xJ76&W3GF&2gXX6vIg-punP*?5dMi4K#z z;6{Zmh#v7wuqcWW51-atMz%6{{GKT{;E-6@f1E3<*aoQc+GB z(4;Pqmynn$XUkGnuB?jEAo;^06C2`PB@9JjsDh*n)&WvLGu*|{26$@WyphJ#JtfVv z#^1gw!EN2P%~Y2ArB(5@T!I^|Lp^#0)U)P8E+qu1Q$i(4$Z}Sg*qCG^mCWymh~>!# zX(j{~KxetgE2&eYAgXTe2q;{nv<$h7!CE-jx=41?Ty_EzW?aQV2Dc{-Tei)6=LZMF z!Qk~2!N+d{@2lAU_>S2A){{o#U#uI8{>j1M!aBbcR&T`J$eWQa8?`vNbLiZ}A!jv{ z97u~GPgSf;kY-Lok9D)u8f2q93A9i?s71t?+{rcG+etQ>QD~SBa*-OA$}D9r>FfyW zb=n_=8{3hxrR1Aw6!W$q;UG8fUu=K*D_{PRPtF=YcZv1ax2~-7O?lY?>(dpiPr=!z zgT2GXAA`2PiML#{@np^?L$GuJC+*DJ+c$Kyvp5+HvsuRS%rLW|K#}i!d`qHr~|4X zEne(IxoBrQ@X2}D?g*805J#b7ojc`t9;lsEMZEpk?>u&CqWPoNcGB7jwqXDb@~O-s z@pwDm?$~@==;roDAe%d(fOb|vo`b@7Hii<`gJj+tE3eo*l5+(OX?+&lY`xmxuS1PDJ_wQF7##Jqj!h4OG z>6m#QUo6IM<_B{=ojEb*{%|^-Dm8Bfv(_1GFAQD8w0fM#JdL#J@W5~L06tH_C6uLc zL>k7Fq9~ZqrU03g1t?_~2sexZ4cnAfk7=kR~D*pm-|yBU?(Lnbl0$95KwKg(hTdvz;=$Za;~hp$Y#0q5g}jCH}qB!69J3XcN9BnM`;vt7|T)75s$uLJ9!S<{4vaP#~9>ypKFG`G0$5Y2$Uj%FN)W{AKG zLJ3B#xrdN%kp@piEP2Q81gUevsW&W2eD*;l3&Q&3eDHkmynkm8{0mDx@K4^lng5+T zawb)w|HCSyELWUg!Po@w&!ha!hRtpLk^2#ylUqe$QT)NB_g^`YBQVRwx zl2n-@FJDw5Dk|hhWK3DGg6pt$_jF?j2X!J71<7JmU^U#ONL?P@&){Cd`ny}V=V^ZX z$$H`BcDCtlUVHrZ!4W127J`lTlT!fuB~P?g zcmfI1o8y>G7L)mWu~1ZA7L&e3*ylw#9|^wHN?o4Q%Lh*5zM^BtmRm;lg29Y^N4lX zRwv6;uoJeUKkFQMBLXQ`9=xl%$sNaafbTrHV-j+EeZaTh9}JH6_AknUFAwP1Wk8GB zbaH`quvoO*thp0NEp?ikFi|Ga#K9)Fs-0@XGJ|MEh^w~79k3O`oP)wyv9amPEF<#? zAFrhhSTk2htWxSsYzYbXLsMc_XI&|rP|JP7qyG8feG%MeXQONG&YoOx_YK;Af^(y_ zw(Q~2;b8CJV#s%emM4qZkdNjwHD3g+X)trnUqBH~7trEUZ^5S%kMkE7vtp_=7KBa1 z8L6cV2LdzKhHa)p;gK_k2cxqP7nF*gBgwRJRFU20Whjn|fD4rIvhDc0j_to0o<(gKZqbyWZ! zoDBA1aV|8;%hKUGdj$Sec)@JS*-oMuO?62fSZNZKMN&z|gvu37pjHK3X0pR_s*4M) zDk2N4K)1H>$e+$|8cWrJ*~fvZp5~Ga=UXz9f#jr9qzsA zF4V65^Mv%md7k%z8)>;tjj)BppQ5n4yA?-t?$StaRWYKFTK`eck>nqBDJu$nMn3B@n&$wRVkZ(P?t+lCZ`E%5+4j@nk-7!E8R{3en#Re4oJQYCclHeKsGxc=#|&bCtFk z%LVeJiU3s{#G7fDav*P|$dqWC&5c~huH*bkN}4)iq1LiTno-s>Cqh`}kZZHnhKwQl zW5=+1GG5)|1<1cigAdOSPKJZqorUyr@ZoLmg&AJ&KcX)1`g9(3i>Ir&Uv`GS{e?#3 z58*49bKzX@`Aj%Ic6c1SI~GJ>L0-J6P1MOFUu2!+qrB@SX_93oZD+~OPRP^r!%(M5 z(AoS#+fTOIVH_^O{zK#`kB9fi=iIo;-@HSjP>1KAu3&!ML%S$Zt%K^VNBL|y$`_8s zie+6!twovIcHB;dMD)rO`O_+!vB>ghD`L&o_VzXxaT3a=E{LX;b2af>n+44e!qDU@ z1Jg^t1O0BaQ4;ntRt9!+xkPom_w3;Q^v*`tqg20r2io7gRis*}zOHk1i@4hJCVYyg z!wH4BHyMiw+z=vuHk*xJ1Z|q`%{F!(H=|Hm0nr>e>$p>pBU|zIhmV7exV6zydHzH& zcozphuXf-#g^E2G8L=rii#vv6)~ST_C|FS!UrU6KjQBA2?N?O}D%n~RR$$uw>Z ztsk~Kp|)K?@{qdswC6*w36&owMj1To-$uQ$#3+q-vVGuBuIp4cj6&s<|FYI&SgupO z3hdDm*rRz6%;3_qRDnW_6NpNxcGPX1oQ&lzb;|Hl^r)@l%DRD2I*RCg6nA-!ct?$8pF9%Wa)*xzaf65#lLs0#lQaE%fY^`Qz=~Ddo#Qdfcye)BTe!M za7!4=IEN>9%<96;7x0zBRrDB5#7QignMBaOpoDtPIz;5 zgEvC_CrFE*-b2W#sjxn6Ld}Q&w#ML>jRpllxc43`(1j8ixp7Oqnq6oCUPlxPlWoLG z+tl!nIv`3S&a{`q`3wD_5;WkM2A1b>9;5+ROz6$7Qo(jdDVZ&c!gHE7xli`z zN)ooVZ;KSF8vfR*NLj8B-jNl3KIdW%Q4Te@@W*aAU5L?5q`#06Tc*DJdxYf-H1Y^b(9njtB zCIpLBpyZrdVMNeeaQe0p+BJ%ob;Aa9pZ7=+!qm%xYfVEaP8QVM7s#uoN8hkx!2I>p zcS+5iX!UDFo}b>r~bU9F9ty7RhljL z<_Ck}!R>ufccJ}u#$x~ZCE9-;X#4(ZY(GG3+qKr^;Iw~yd~o41*8^Ft1ab|yw;JtD z*h*K=WixW|PS?AhNOQZwG6ihAjzRLl?v%6}8pcLdH11;<&7BnR^fYDSOhhwOMZN1< zn98Y2yUL0r<-EwvCEO1`9e!i~xK|zS5BfcX$S1x2pQ~T*ot#{~uAS(?@Q##vrP6&Y z$%D7*Lx1veNuF(Ac%ui6U#*wq`pn!2K` zX0Aq^=7RE)(-#zhO{$BkxTBpV7vB;^+Fj#91(jG9R>hpkDp(Hs>IN(XO>eq_&Kaas z+&W7)K>u)fe0u|xe{}=AHKd1UPp@l;Kf8UqT>kf)>%*Ia{?Y#7;r@PIx25{+%j2BD z<{Z$jf<0nF)$y-oM&BA>42=^PRL!ysid?`(TKFKcNmU6%VTxP=dU8dE709$`Grz^D z%S`pH!elk%@L74`U`#iq)4_@h{bo(@_h-+;S>sOuZGKxLdrklVABzYC000000RIL6 TLPG)o8vp|U0000000000rTlLC literal 0 HcmV?d00001 diff --git a/test/mpileup/mpileup.2.bam.bai b/test/mpileup/mpileup.2.bam.bai new file mode 100644 index 0000000000000000000000000000000000000000..4900edf25f72adddf26c6aee4eb8dcb32b3bab49 GIT binary patch literal 96 ycmZ>A^kigYU|?VZVoxCk1`wNp!I}k3F-YWsXs<~Sd35pT5Jh0UASS9_h$H|R0R+4N literal 0 HcmV?d00001 diff --git a/test/mpileup/mpileup.2.cram b/test/mpileup/mpileup.2.cram new file mode 100644 index 0000000000000000000000000000000000000000..758c09202e0d3a556cd3e79f6c973677e856b212 GIT binary patch literal 20072 zcmeEsWmKEdvS@-k1P{<)Ews412X`&*?(Ul6#akp;DNx*L@d7PSpt#c#v=j|einRoJ zaL+sIo_FuLf8KgO->jASzCF74WX~j9pt`ae=m1W@e}{Rjf6~y<05S1?d_D|703aqT z$(lY1=N~NemMk6Ld=c_klf3A^Og(jnWXiXM2bXA! z&cLPR<12;f)nwaoS>>2x&>oZ7+iWaNe6DYwN#@vO@sQTX@y%t{+$iDSYQM0q zEPU^8nqM%w-C8|vJ?r@B{pO?Cr@k?+F~k~IWGyu3ldnu(bd+Mvy#kMvS-TLvaCix; z%A|;0g@3KKGb9}d9QXhIa~$NUoA>-JaMB7g?k;y z-i*Z!H%*do)fC{KJt?@M81$pm>|rc0*iz-K%ZTQg=!nzj$&>4llx#OU$}ccz5fG?Z zcq>AEQC;JS`}1=Ak$#InG}boZ5nDE_efxzZh5Hvi5&>-VfbzvO&B0}!?)Q4W{TIvR zPjMO?akQqee{@9*NuPGzcC4LpU-xLy6_FIROYQynImT*URDgQ7^BTYCEPV0A{6|;) zUEAGw5eq%ZM73ZZ|L{o>Wk(u?A8Tgv3brcDfQq=+60O>eBrlu`D*jD zp~Gsa2Q&5skICa4!pTG_h4%`ioUcZof1UF|KJDzt!|1Ph438Di+?ExA#72AOc=Lc` zzw*m#2MRP8zHsc)`yqPpynphk>?K#GzuPR6%cS*MCy;G=&+z|WH;ZG5|v933@XYBnmyk0GR!RDyNz8KNspxS0% zT;+j$<%bY8ZJVv-F?iyK;BjBtdWrwMA;8eIsgG;@X6WxXytq{-slb(phCmMuso zxQWz{vR$#p2LQ_B*mv)X&kN`a=s(NT|9}4f2>f40fYd$Dj7{lY8JIQ`wFmfQdWZ{* zqaS=@Z3+Ma;>hF3qlPf_<)d0;HK2MLPz@cZk-n^)jtRhs2WrF%HG)F_J>wtL|3miQ z3;t8&e=>CM;Xg(GtJi;W{?Qj%lmF^MPlNUWbTxsp+Q66zN;ySzHWJ&Y*HNW<0FoHJ zm{J96Z~v&osN$%ms16b|G&FRqd%*tR098cC0HOl{y6X2&dmuno8$C!I07S#UN5{m* z!NnsW1d)={VG&V*X<69#h)KvOsUI;tVdv!L7Zs;~&@(VHKW63O6%rPcmV+v&>Dr59 zJOJjuz=O93_@~EzJaPUF=qla!;r<)ZP(;VOe?hx%p`oK|>Y?MI-Q5E*01XJ#)W$*s z5bEopzvzt02i#M4G4Ijd1480IAi@Vk1e1e7VG1x;SO6^ap0NGE+9r5FL=TAg9_>76 z?>t!EL4QCGCU&qM5cUIl5Z-w(w)Y^n2Yf&e+`R__`wz7J2aWv);eDKYgnXbOAKnfg z-VPotA3TU0Jg6N$prZ%IF~$RWP`gBjF~C@1Y%npHI7|vA15<`+!;E0YFjJTn%m(HH z^MrZ9qG5@!R9FV=)xE;jLw~j(jBGy`-hObljr)M`?$Pc;A9o+z?moEK{SVs1z;_>p zyZ122y$8nLgWBE$WA9;*`wtrX4~+eXKJGs-_8%PW|Hnulbde91kq-ut4|2!{=g0?L zUpo0gO2M@Z355k8Ja)%H7JA5#8@?ierLHG}La8ycEQPe&R7e)YMg0aIm zVf-*5m?%sdCJU2?sln7?8Za%G4onxO2Qz?~z|3G4Fgut%%n9ZObBB4u{9$3R2v{U6 z2KEw`1WSRX!!lu6uxwZk3=YeOy@i!VsV`wj$z^%4q+{)_;lCe@WGU8=(Il3Ay_`#kfz=e`KwSCgy#f z%E{i-WT8s>825DtO->F23kYNb0-tE;pc7z9JbD5k$9xzohVFwjzK$LcNT93ok0PK4 zy(bZc;I7}-KMdS^8t}d}0DUz_&@{9l{*mHl6v_az<^4Htdg zNcQ1*?}_(c+0||tI{-AmnX-@Gz6_h!b7=&1K%iUtC_Xgtg0KK z_5v{hv5#W0{<&B3E@}qM1!IwHZ#6M%bLRSieVGG{^w}yzva@(FRlR zaK&&RKaMeBl`tdvMe%0z900)L^TQy<+>f>N^6UgqJ$V&{{kRPeKxt^bMdtfTAH6Q; zT2vVTIE|D;i0u*>*MHWKckw|2bZAEve|}K*%^^7eF;29B+_dE-jGeS`E4uKfUlljL z4e3Xl=DUdgO1PR3GWE$JA%oXBF`-(OY+C;lT86nSxlZy89!{&smvOMLcE6mJ&=px0 zIy-5dKh7^08|XX>*QxPCjPejJ*zfU6C0RM;cT}ZX8`Yb}(2xVRVzXxKW(nNOVaH_c z{lBhGzWH-J+CPZ3aUtW6=Tl!kqFjjooG%{?$54`P9w)7rNsphiE8hP|v4__U&LPR5 zw`9PiAIr8H5OfNxJ|zC0B_9Um_yInHwzkIpdZCD??!ic^xHia5;#FeSQ|bE`0D#<} zOY_1Pbd!Xs$yGAedgXA|)#1|`6@+I7PFRIhTi-UO0Kmh5k=fop2Z0>|SUpTNya5*C7_$;2m z%ID|yO5ZnrpjUhrQ6AruUIll5C*#Cct^?1lA!JZF$yN4tcv2p=!-)qi#&Avx94uod zc`Gm$_IX}~HAKLfiWu-(Qu_UEdhFx6b`h5JsFdj0kSR))uaPcuiNYT`J9B0N*=Wdf z@amzI8p7Rd^=JZfWg>>X8!{!pjgx*-d9unu!pyoh23`O5b6ucV?^C8i<(l#gMdvS> zO-F3hRXQHRjTNLS#e1_w@0!9nXT9!belS;Bm;EvlX0zCjB8}Euch&lRF=T+HKQ+OI zSCwNF<6JPL66-g%C@bdR0N5^xnl>qkt`m-*N!3G-6-8#^SLYC~$BIfOynDCik5&y& z6YHeU3)(+R{;VbHlu+Y5j79V>q;z_%5 zBjc-$_$7Xa@>C_%0czCdKsAZ6h8SOhwQDcuf6fP;09+9Lg^23TL2XHZd3%hpjVBj~0cW#H!K%2O40-n>+- z+KCb6f~dy|RDimym~Xsn&~S$iAZ4Q8|MGj{YWz2DFIz^R+}p|$eVSnh&Mc?phW%*) zhCSavYPxIm#faUlpVK;TN0sU2kHYHq8mi~P*jcvwS126Z<>Czv_z{!VV0)Nl%PbIm>bP+mEj*% zpN`b&f5Ai!6~~Ls`7sEdeQ??Ktt+AYNzhemP-BoCw@K*Mn5aHlHx15~34A^^kMD}E z=Qe&!SZpRGvs)8CT*+$oBu#sXJu#Ohd8D4))XDJ^oQfvpOV+Rk84-j4P!!4Od9@Az zzUmpu$F^lVDC^9b!@>jrUS>Cj0x^Ivw%Fu<)=2<*p}wTn01rXSU&1!OVg0|~(!Wvj zF_6S#$jL>O5qX^<@9wa$x+Hh#pkJmIdmJlT$;6+P<-8;AQ_lp$5)t>OMwUKD)&;pZsAAkV@Z(dcB!O${)1d$$_N3j zlwu(%Bz;{L`PU1R!W+|){i{^b2d{Ux!;*5{r4G*y*?eeWR!^2ZFJq%keSzY3F^`%o zK1%=UD@9Ab51JC8N(T@FJsRzk*~x!K?J!@%bD4o8uH$zDmTmHP_qc%Rw=|#$CObKrfg5 zAgC?$mYM5mK9(SqZC7B}##UE$2k3wfsHo~b^m~u|!Vr~OnZ{&F z{uuFjWF;;EM^8*;xFg{BvD~;uC_AC-qTQ4rSVn-Rl#x_-vI>p{Xy#S4y-L}q5R1kw z1=`OFipmJochnT?%Y#g2zp35yIK<59u~h;ZWz`hOfu+C|pD}7e+`Znp-d6N+4LzEa zuA|oah!!0=6TL{PI)xi-6((fNV?)$ZwhVinYx5_kt74w`a)EZm`&gi<+e&xnPdN*4 zqB`$%PN1)>M0)xNAVL}N6-&UW(oH7M0+VkyzK^bxC3-=Cun>pAKn56CC=E#H3|lxc z0{|3LBv*hKxZF(tnF{;@i_=290{k<)0z7B)yv;)Y(Qa&vIsuCSM@8PSGu^NKhb$Xi zff)GF1{t#dsacpanqe=BBabM-jlg{eJd{Csjva`}%g)v0ax!}J6Qk|j-kuI68~ja+ zQ!2l?x)CO22&1pcV~`UZJadf5toyVLYymC6f}LRS5K$Y)>-uj z&bGXoM75z30|#XF(Jmc{8}lJNlIoo~0YBgNTkTl|H3nwO|5_Q=w9^2Q`hoWht%)bP z8ga=*mZPd*V@)m@+{J#|5};9jGXo|ILM2Y2pZ$C>Zqw8H`7f&CMyGn3+Qb=t=SelP zreKb3>zqOWvgEPvFSH9K!>ovc;`YW`h7I9C$QrdTkH=Q0)wCa#&SC#`Id}O;OH3Ni zsGLou^!iZ&71!d?REQuQ#wZ85Z91JBhxlWqtLSkUWTh`JX8;Y3t3?}V_;^Obg6Qn| zsEWm7Qu?R#TcYapnUbTnMDL=bn`K{%&Y31Mu8ulOnYt8d(RJX!J zi-fap+BW{ett!v=kGB6e-f8k&V)^qUnzZ-*srl^46{iG_38}SWcco`0{3vVe=bGQJ z2|;e-bj{iQcxA)NTP7*wH&TAZC)K~HwLTNLA8sg(t(Q`=l@aU(gY|XP6ouTO!$z&J zM}9=)vNSA7oJI1=$xt5=m%QAR3`eJuA9KRETq_sRPDr=RrlLCX_9 zT>sYnz2Fm;TQ%BN13L{amD3&{BJdU(fQzN zMk|dD?Q}-+1yD4?H8XqH+c!p*4W%a++JWOrUTs7mENl-OkCj0znrxAMVY&p z6Ub%@KoAg8PKiniT?4uqH;Gm_0wjrMunVIdDz2%0+Xx7YreU>NA#pA&uTjbA-_&aSTr zfPG39UfEEWau1ZI%KCD5C(2lp&o`~i{H)2;)xe)3P9{GlN`H((roAH61p=4iXPQ%{ z?RTUTF?!`5BoDXm&!~cVrQ0%Ho4$;Hnaj(LYo;(@FuRdn%%hdhn|4h(M3+I%-?t29 zzSqg!$mN|CU{X@V3)E_7V&$>cW7bYI0vilqyE;{F(4MQc3%AqGNzPT!Ucxo|#}9|A z%$dWkHfHrq;l>zYs&tw*G(-VoE)Ai3PNo%jM=Sc)D`jl*f@5cWKZm`nPxri&$;;Y` zdB=o{ahwz4d5@$mzjFwbdhx#(>d5C4)T{G@6qc>6RIzb@h!~cA%loZTWif#7tD8gO zg04j9`VKq-IBt}dj>R=Ah8h1iQ)dIWv{ z6MkMMY5w=_md9Z(Sj&Ryza9QXAZBPasPlDQP)E;@JjvCNr+ zJSdN_m&r#oCO_VoxFI7^C$haqmaA>Qb$<@gUlJEdYo$rkU$m_e7iCEeCL&4y{0(D6 zujsiAxj}UX-`Iwm6h%m0pR}&6j{XhvP-URPUj7QFwAHIu7x1Ibt!5Gpf{Pkl0;#nY zhrwUBPuvH+$NmcXx`_BV$t%ih7Ws~O1(jEX%8Sq`^9mX=@x}rv-$;x}bkg?E%Skdb z37(2LKu+O9C;oIwc6L~N4vO1jwy6YxU-!Uo!1o_F85(x1jG9iP7&eJV;5WQBokJ2n ziesW_BHN1~-ZW;1?WQl@KY49KjD!W@v1QCe2Gr$>pH?dJ^Ajsy>UR4*$1c#?-oU7@ z4S%7R5TAT5=JXZkf??_{2(6NlRE4Ylmpi#2G36@zWoJ!(ifl9QYp=!WFJ_^qjKBJM z=NX-6_S-@HbWdX!*ow=wbj+b)B@AvA8{vr&ku8bvYq7CqBXD>Z-FT<;59# z>`Uof)4I*8Nv{p|==Q>&S_IIXw{%^ihYwJdQ(X;Jl1DNfOnO~2J7+aUnv_$`@E+2? z4t;YO=nBVOj$}O4`e``McSpDAdbn65t=Sb9|2TslIm9@$@Kq&gU$dI6_QH>43mv|s zvMIpd{OCxOpJ_NtclV~X(=HH%@65S&9dh6fX5unjz5PJ zY$t+$O4w{?h)OyPo}8a&Sq^!R1&56@^GQ~K*Kq*bK&`vqzdZ3CXB^}lUU(a~>0Ht8 zEDTj4-dY#2G&lJ3xOEG9pu`m4JLQ5Apw&MnLA7e^`kwl(IY&Qta!i@6MdxC5s%Q+h zW0jsTXSF`7rZIgr7c&W#BCP7K@Ri?=84Es(E?%*%#EOm8qAi9ijmdN(X&^*VAnYg@ zV_$Q6#>=LCAN#WQ)yOlZ8d#oF>Wz;B(S;C)^S0n0x@pO{uhb^^I>I(&fn_|U1}bn` zF=)2^n)ctLqtpR~q@>vV3MD>)mHQceKMC_Plwuz7rqJoJ+Bl4Ds!8@U|6u1!?sTEk zZo`dNs^*)HupM6S>NV=koc~T!v`rP1i9BUTzGvga4`~>q*V^1ghD0m}W1j|y-h4bV zoh^44UqS5MrZqQtAp3IO&uv}kw%5}4P9P>vQJb-Inas?$ussmZrxi!}F*N`v6Sv0WX8eE=}S06K)W1ctQ zr(^MWv%#0ftgHBRd4Sob92+(E=f|0PqWXzC{(u1K$!Zn8dpB27Ze#mgt17*XPzdjH zGzq=0R&W+bmod+aQ|;I>z;?R&J17H$zo%!pvkMLog5yZY6XM0jzZ$zQ2ea;~c7a(5 z%x5_Asmin@L+7L?M9NWd zke8o{e`hhn7cw-~J66Dd_xt?ZU;di8+p#=Ea}qkACLltrjWym3OjxraE4c%G>g%{M z!&NDZ{04(0IBi|keJaEB9y;*q-3pULoXmxRqk^0 zVruE8b@|vnymj>N&7x>n=GqQw_V3=_R>hvr#?5KS5o%Y>{v1$1$3~VaBZ86rM)X4D z1=PL&uq7!MdoJUMEJ|B*((eyeyxfq3x}6YUR!TnZI`-%`)TNDG2Wen*IodIgrS>2G6?+A@Qzo*cY z@A)hemt37yn_b1tI0_2O607Ey<3r)8Q6Fv;32A2Boa;s=5LIT_Li}Q_%L7Q*Dv zsU$)|@`!>cFg}>V;61PUa4co<;1{c@s>e9-T8%Va_*%X=$xA#FQLzd!u}UF>5(N@{ zdT1LaV__zWR`H+jZ)Ftg8Zr1A+B8{Cnwk%8j{LYbTiTN#Z!N5smV&H?6daHK-MPJJ zlDs)RJd4*bTxI|oei$!W1mmO@LSRbD?TOwFJcYIJEk1FsR<`9R=h8H@WoQrbEr9Akh zuL1c9dq(Wl3<vZ2V;ReB7|~QYR*%6JB2R%l(-dd0f;Uu)Ri<;a9;4C%W%Ma)Ky- z`8W<$&NLr|YUakQu}(;5S5<6Hr(yJ;Z=D3ULQWr45h0zeX-#ML9VuDDuPQ3sA1RE) z#}BLG(KcDO)u8l2fiYm}`a`){ZA(kfA{6rQG;I=rG8xp|+@as8vpnJoB{+H0C%9jlywT@Qn{uK0 z$a>g|m}KDKV|a*Hx*LHv1V52#H99Dha0AECRi;=+-u;X%RzvX##O0^^@PeypveBT$ z=Xcc~e@#rQZ;jYh6~Be^uQ#1fm`}S&u8mGN%!LBac}kY6oa<)RCdzmo9l5JA+gj3g zMUS~4)&gEUt=Y(jrf2wePWnxfoF){U!q-y4Lj|Y94WeoH|00|e6&1t2NHdYh&QiqF zF82}Q@bh^kkkB>}*fS+`2Dj%$tIPKFOG?15w{yY#PFiom-Jcc0KdK}b~ahn$|YRs$nzj~PSuFF#G%Rxf9{fh|q$Eo{@3ZQ-94 z@jXC?@2*%`|qJ1Ltxpfj2bTls(X6KKGk^-@D0~n}e09*31Se@ZX=1Lb| zj>htwj7`eeT$3?^twl3G)%(&?qfU$16UP~0#Y* z+wZ`#=Pl6&PNwzY!mjM72+rm=LR_>fICYo)Q(0{jr5zn)&c?}7@to0i?l;cQUTDXX z(Joi3h?R$u$}2tV3Zw@ly0uv^=cjz~C-$&Aur@HrZaI8Zo|i||PMVGm=Q>(7@R>-+ z7*$mDv8q-Sw5&?KStwlObu}3);Iw_>gzO4(gab5^|U9`sjESk|WVG za?8~ciry9R-CvIzv6Ly6Y{h~Tq@Az;CZhD9Qnj!y{s9>j>MRI3XWj;Fi@E=yF1CLe z-z9XS%=$=s)Y?Fy>sx#B=69T?eXG$=Dg13q1)0w*d_Tl6YjHntRV6$^L9b}WPy_6VA~nb3hQi1+Pv;_-rB0uXmbaJLJBa(w|4ak6%Kt3+p zv(K>!)*lmJll5ViL@$`*pJY*HJ{!pW%FqS^&X8hGAp`TfE0$NVri;$^ z&kGL3=qCUIRrviG)~Dc*JqQT00eW-4y}-N!Iu&6`g9Sz|?cyjT%SPsNZ}Nj<2O+2Nh$7<>=>*S$Q{;ZO3lnw^6a%gly| z{Fr){x&Z-?6BD1gucBSZAN5Hb;z_Wm<3z3~|4zo*c3VR3(BgHr(ye`5e9TS(8UGBr z^>U$DE?;g}v%$d0VKGB(viD#F1g!4|RJ+wV^B7vYNu|U-E+CCyl4<6C{lhPS)R~!uD5A3`&F@mN%nf9yYM{QXaTr_P8eEaE4`*~ z%KLtl1XSw&LG!o9&>(b7-K9ZcOkF&YOTLsBXamH}Q)M2IKw}37|4DZS<I&< zf1j0HT54S#I_|dQ4)wh0UdY*J8&GWs3_R8ug_2o~2~IP;8}B{fNm1+R8iktv1yJ zv|SFQ-LJ)s4t*RF)1@WFH!fSrGP0~#S>==`zRp9(F%^T|=SI?GwtudhtFNC<6x*VV zzD|gPKJZb`(SX0DcqtHWvli>*l*4QEWo$h=(wmq#aYg>?yXrU>3S887lqsQ>p|J3& zb__28hK}B%=fFS#hfPU!37eukT9MQaeD96u@BGjZGNYLHa#eW=@{RAraAYRNz>th1 zDU_TG2`;5z7JFi|syQ!LR}G~Qf*{We(iYqOxg0yJQ`0|M&e^M>>`kK|Q=*J7rH3Na=&i&C}D(!)vclODWnww?e%7sTLjXmSwTgbNen2vo=1z>DgGR zY}4=0t8c&HL`bWbB!<(T)P~reYG~6m2!0IgYfB zuVFxg6(vJ6H83r>ZtHMJ$fNeLhh6vUUl&0gRk_MI9z_*fduJ-)H>lH{&IR7MY?u$P zgP;>4@ih&rdRQFB?$CL4S5@?i?0HAi*?YXE1itUWf&TPMejmc$DnaOYUvF;=@%lnC z5{e-`@v{AW5|RbZJaRx>!xoat@6;?=Dhi2%QGNPj87GIHp6Ha*W6Yq96@I?$3|O+4 z^zz{^o}zk{k#e4G37%*_zgXI9#F>{>-c@=|vtfVC>rjdzke(Hfy~C+_Uv1tFL4cO` z_|J@AQT)U8 zdaR_CM9?vWKgzI+o4r9CN>u}W%S6B`xH=im$#;?WIfu!U-rx$Qxr`!duCr|8%{I8a ztSh)`Q7$#;2;1#BlJ8U0?wrbXtyxkmUXFFC(78Nc_Mrb=vnV#vw&>m!UO@S1>u|5C z^&M8n0ml3aAhw^Ad0djYSEEAW#c#M$*ytFXw?oIgbtWL-T8JrQntsylOw7rTW%-8K z%nrm$vHMn^V5T0xVUEryLif7=MJk{0J zC6yWX+=o4hVfj4jHKd?ksDGK+VIo<5U<`bk!0a%PJPh(uhbayCwZC(WW9lcfVNn*8 z>qe#N1pOrm@)uoMyD*7J868bK+&fGwB9=a)@A9E#DQ$@4r(GIiimg4YYqFE}pEX(d zBIZq77!T*PGml9!aI}-JjLT>3>+YM=iGM%+lr36a9<>tLU&ra{I{H*Sr>my+BO!_5 zU$fPSkNgd#^~ljv$5lv!KSH5F)uq>CboOvat>M$T!`9yqnWoY?yi5HSUyg67 zLTC?W%G?SM&A+STlyXOZz4-lp#_6RI6a4aqEwvJ?_mxAI=_5f9Unk|(k;67dJbrm( zfdAI+`Vi_et!(9D^tW$tSS`{Zo8|m=2hqUBhC-!XUe4YGuh46a&UCFGNfVd(kwNNo zbv0LB#9KDlR*O`{Cbf)p0vQo$TzDkh}@wOrx*J zu^ipmOdF!-_AK&jkfxu=8Finb!CcR2mg z-u-G<$Y!VQbhKe;F|BNl$O2^^`W^2^tSK*q+hFa-f0x{hyPGWIN}jkr8Q#ta>)$;C;75aR~4@2zB@ zLu46egQ+wA@!Y8W-}~c&;SJTNw0$l5N#`LE9qz7moxPG5SKhrv(u-wWi1w2`Kk+mn zzh6&BJ@?T!y!`Xo8tLTvLuRE^i`@^^Ip#)ZzF^t|h|Xou<@FW7lrDC1EDrAJZYkA5 zOV~m#ZG(tv#t&&eT`H#TevCbJ-1TYA)+`$6-47F;J$MR5 zmb*A8ydIl6b!4>^1c`H3w5aYZcr5O?)*&{VPiAk_Rz@77If*B^O>e@(O-Fj*64GH| zX8Q?W278WtE_*jdpzX%*PwUK6ggURoX$`x~BKf`Dsnp(gju7(3p%Q%3Yn+!%>}Y`$ zkF4LSZ&e>}wGwAeTlnkg?Q{4i1Uy=rXRgK0h|krD?ShVR{79H8P?|^xmXCud(ee5Y z7AQSz2k+%V_~{Bjxf>HSShJpUL9XvcD>tuE%NA9bi1s5iWZDaX7G`YE{bCyLN?%6V z5SgDrz9xSr-jopMzc4nqo{ys+& z_~g_u$>RMP-7@o|`rJl>nMVC4Ait)L;!36aOempHsk^>NLXP$RZ;`QbEI#5(u*)k* z#DM>fOFQbt>(_d(;kMrbe!lYKIQCqt0=5BS($eE{Z^!wFDTvjtn zw6bA5)%_Jrugw<_AxI{SG9+pSbcD6&pemK*`e)G2SzlesSU%I}9jhw|8LbsSv9T&d z@lS#ZM46eDSc_=^w3h*}9FRx_i>BTG6pe}U-!E=fcx@-ZYXn3_ z@6ewoT9=eRSE`X}&#(Twu?=)eQlDtVN$Hn&N-mxiT=6X*_qy~VZjY9G`Q6HXi}A}~ ztM~Ds4Z>tKfE09O%K1F+23o9NZroKE5r+sNS&!`E82w6VANJF~dB13WOUpHNb29Q8 zyg7OILdXRX$t`hL%yFXSu%tTPF&ngUqo!rr_={Ee`@E(b)TXla;&g0~+WhMsrk`6M znd+_wZ^7VktI=MGy{J3E>qhIqJF@&3FaeParv%+bS#Cw>fZu@h%v>t-PBJ>F;P%+B z`_m7B&@pB{5Fe9`jb{8V%!W~;=Koa^9 zqYF1}FopcBhGbGas|1G}36I|UX?cBRc&MPx0>;=fvsK4skoI7jz`OzAt`%LDQR|Ri95~(np z(9qTPXrtU9-mQqoui3rpcO9lG|I*0cp?*FgN$$mq&ZCy8&bsd7#Wpr^eBUm~o`&9q zqJ~LNdR8#i+~MDw;JcHn=Talzj&7rqi|5=))X?8ApMf%j zZq?};z2J(^ARJa~O7z&+*eG*@GThOq(GMQCTM-PPkWU*gej2T) z!)beUk|UaSADfl_toUwt7ZU-FPI1>=eoLY9i02;Sxl|4VZS!GhT!*NqOLw*dqO3Fd z;`P#@#;C?%K;%+gHV@6=jK;#Gu!UzuF+ymhFD50lj)|>YriBDOFJWkmQecOd-?367 zMYO-Sd|RS?Cx8Ul4FhVx zvq0hRnv><3)zI#Otn5p~%_J3gr1`QZcWSF5OtJKG^77I=%l++}q9vA4%edTxL@yAp zZ_}TS>QI`;3>mq3^!M7B-qRg8-e$sTnoRXVb@pDA5 zL?Zmnn&s%RW!q_0T65CEn))*)dos1v>=aHXF~7Xd>aBLLu3E8V(xrBECP1uX4$_-}i+mCu`aeokLe7*7Y!X zp6hJr?D;y<8e(KrELo-JfdTnedarnWf<$5*nM571lD}NJWE79{3_jJ5`R@1RmGz3d zz|m+=`m$JJjT4$zU=YLdMg|_g(e@a42qY@#@N+DIIc*cppT;cEztYRWOa~J&nG1r>2{*xqbwX6gR6y0KJ(vBR9Xx+r647h~Y{%hbhHFZAC-gKrS}L%HPcN(=6A! zDF5>W@)SgUcu;8@MLkKp68T9k)MEx;qu;(5b!hPIg&vujYvA3HUVHe{_pOq(a)Y-$ z0eoB~IwLK62dr%UXNySxyAz}@%KxuzXwV-wf7!*S`OhxWT&vcZKC7X+ImM?}B1>P! zVR5K$fcAbR44mx+%QFdZFs0c#_+18%F{k$1PV{RSZw?P9Gxxs)*Ny8BaivsN0S?0t zmyd4mrtA?|gc(hV#V@7nyK?*TTr9Ebk=3|gaoczTd77)@sdTD!@u~C{1cc+O^5N6Y zuKU`0uRf%lA4LLcmh8TVWX)&A5j}GAU-R5L`xS)9UJdN1%gO0|X5c|Jf=n;3ooQN~ z_*k^M$dywOu~Ki?EEU&uf9Ia)5-?|;OYx}M!=rNhDBC+IXkY_^ZN{6H00*n`Kk4UB z?ROj)Q&xxw#oVZz3Jgtv?2D) zae)?PD}H;<N@xkSMcen+&+*0e&Cu>C&-TbhnE&+MHj>?(4d9u zF^2u2SM#TV3`hozV?3oTRemiP-uv(`xSO9L+RdvdpE0sJdY5KEb0s_y zYjWq@*Rd+JY|yU6Wxt%qnedjgCXW60upjXloQ8L!rz(#o9_-zCGg^*uH0L&BwH*~Z zYtS#J*XFbI!9R=9VY@z_v7CK8_m!w)r~MVLt!CP_%|v2CGBe*S1?Wh$!V#^6YZl!B zTucJb$bYF_H&{~INE-Z75OSwn*{qMrOxiz0fM+s6|3=QPJvco` z*;QZ|EsA&8v;$S-8yXfv{(W_|NZ6;G>s{H3N3=Y`_&{Q}ZJF47L|2`qeYS2z{ezp` z7d(ICNRsz2nKt&Lf{oy&p9I5bW+eI364XZ}ej^idb2o4no5m90xfa{%m+%c3fs(Md z0eV5MPL}+WF$z533xbJgL}rsEttnVdG+d%5TKZ zlKYHh*>1C?K)lsqIk`aTxPQ#9_Rz&ir!eaFr;=El6C9l>eM~|lF{Z}XX1OIqrt#C4^RKz%*$rCq?F=$e|iR; z(qEn2I)+VRJZbKT|N>Ltb822SE z297Nc%YX#KHsyv)dm8BwuT8nyU;+3jFC&*XygWYs&}IXN+s%Q*K&R7fQS+mu*i&Qct5 z*=se@+2Gj_ULa*)Sp6Mq$;nnJrsjY~?PNN9g_}LF42i|;uwdVXM+Q=~j5xfhdlS*q zZGLn+Yi8&8e4d@qpmE`Iz{F`yZ8^gC80ixda%a$5v2by7a;aUWwgc+7J3(CWu$}vx zUlJSau2ak&-HLZV>k|0BP`u1$Um3KZd6SZ z;yE8XG?Fv($LD<+(RUAjk*4z=Va8%p_U6PDRsW-bMH4Ib`PQ|}pZeId&;P!!N;kV0 zYV&WZZ&UmdvSHGBoTJq@v~}$o9A=LBb+f7#A@W+BRyyO8F`0uGHQ$sZQ+TJ+*!__R z-^Ypjs~7y6NRi)vC_&)aKGHaz#YFV_c&#ws>(Q0ozh<C@6AeP1>^oI*vuVm=)36x`@BTzK1|=rmRU(*?>A)90sD*oCEKm z10MV6LI;Wp!ycm@4U>qS=EK5eer6tia|K1>sMKWToW?|ts84emj3sjZa|`ix=3AE& zb+s-z-r|Krb(f4|1&vgL`2o!yx0-YjXBcah07N z7cx>W z8kC(!F6*OphxBdDoZ|C6zrMXx?oDl}KQz1gyBYpHCa>|2hf#$ec41@h|Qk zJv<_&GL-P2(XsKufYCaz+{qCytx=7;OQq_QUvVXRUy+?8#bMp_2aGcqG1D&i~s zhzLK9BggcZneIS`S}F`MQ?a^#mQB`ETl=*?Uuu=x=W<@}{$qXKSXoQ6Wf$8up=J$o zE^57+JETI+8tTsrOk+lm$EOq5I&QtIh%(>$Ta&@gtd*XL8LkFE>y^n#ltd*=(x47A zpuodDT+KZbeMZD_MC2S17T>-yzH%PN*YOoIGUGV%FOHm=nSS6%k4!k!j8&?rxJj6G zGcwR3=H?Lsc!c-#I6O7NtEvt0I3mabam+(WDEv4g6Hxf{%v8aV9#8@EJrEBBP zdIQ@ob!Fk+Nt&nwGeod|_BJ{RsZ4g}@P4I;bY*iJhICa4WgY~F5}+*GFeM3PZNnHt zixGkm9D%Q|IWqGrkBB*YL>v*35%8IFrp5H>=HYWXW|(G1z!B+YCSAwSZYCtMGmCNW zZO7iX_WQI9-L<<7Dz=SS{k&gEXb9Y!8V!ztkW!C6o_1s5QTlG4kzmn?7@vhZiPKrD z3m$7r>B8(Ao2q4#8!hi-NZ2SHLsEwtRE!3zMI0H&RMLz&kLey68IJIX$Z!WE!hr~K zN0_*&im8Z=AwnXJYg^4=L#>fCgdgYIpypmL}!gdn2&Pssr0?dn!vATnJ26=xk4qjri(gycA}wYhP6P zFsSp4v>-zF&RX9ed6V(Jc^_)LnTk-o`~OJyhZEJy{;OR-_OjP%@)#g7bDR#0KTk-5{ua#aN%${`UU*`Z{Ra7k<+aHx+k7!hm{v z`?)OEq$(+&E(S6+VPf9IWH8;%Lz(L1=kK?5VGzrCs!oB4F-InGnS z&&Ayl5%b7F8jW=-8RDA{x|}XmL9BXrzATC>IS_Eh1VZn=Q7z(da|#ay5CFVI9Pt$y zGiJnbOb<`@bfkA6C*VEM&k0;9&>@U^WKJFePHTySp0>Hz#A;9}r-HZ_P}+ z+epl?Bhxj58?%TNEt1X2X9NIU15gp8YxwRk4(lprqcs_(LzwRV*U0MQCW>O?*X0+j zx_<7^wdzL`8l?9^3A1v;Xj{9L+mKHBbQQV1UPQPqyqdc1#Dy0Mc!a=$m+iJ(>$Yqn zt(IE|MCw+09el1-o+WB6-C~%I>-qLMI-sr8t?aj*cWq<)c)VB>)3My{z5!lur9V<2 z-1}zZ_V7#1*2~9Og>|$bg^jMPY8#R4%k}Z|^=BiCvHZOC{rpfqE|(v#pKt5wvh2L> zACHgE_e-I%ua86iGF-}&s6qm0u7&_GXeg0~y9SURnQq>WoJY<`j-fgu!#UC;DBbNq z9%*5R<6D}su7#KZXXt3Z*Tzl)hzbx>rE;x(5E-$NnnWInjKiJWHNt07MHSsW+{08m z3XSFtV3?|zi1tb>E}}xcyTR4NBpeYQ=z@%^_kd<1)5CpEnRy&(J;FU;FbCXLfGmIs zBbzQ$eS-EfMl>UFm4pS<5uP6I9+54_jK~=|9pMpvPuPYHnt#8W2?U#!Lu>BLVnKwMd8WaQ3JkQI*d9^ge8eBVl0` zFf^*Ag%j%&yWZ~Z{x7O1;-c+a006+$=yL=F4uT7Y{{R94009360001hv_XTlLxh$` zgV0oiFaYG<<`eI@cmf9vrUO7yrwejYtyBpD{1Hf)>hg>QCmKSLlJtmkK#PHvuU0ia zKE7-CwBjr>Np_rv^%O$?)sg4RGZh-a$3!AY?<}Wx($%3O<5x^Azf&HU4<> zujwn42_OUF!r8|e=`eU>@y68AyH3xDgh)^Zv1+qU#Uu#q5lS7=@fsqDbtF!(`!w7X5uNzvieH=STC9-s zkB#uBc5(!WEOhnf?L8NoVOCZUBJ69BX7(sTNR8MHAk^FRxPp;xOnXq#0izYvsk2y^)kTQ==rez%?ce;k?7XY<$RP|(_%QX26c*! z96jJLrPNz4tT}w!i?u%Y9$}?4iX@^C!e@f{|JmZd9)%5u$`8YLn8+Tkb z?P=BnkZ~fKY7vb?ou$Oy2A@^wGSu~njJ@!YyWCPWilf4;LHeE)~6X7T~mTbuR)oZ-PlTBS7H4*&oF|NsC058y>l dMgRZ+00966z1dFy0RRRD0RRC20RZk}0ZaNE=Mew^ literal 0 HcmV?d00001 diff --git a/test/mpileup/mpileup.2.cram.crai b/test/mpileup/mpileup.2.cram.crai new file mode 100644 index 0000000000000000000000000000000000000000..fbe69e16dc9be39a64f5628e13f5ddcbf9d9ff1a GIT binary patch literal 45 wcmb2|=3oE=X5$AYPfQFAOdpt-Y&UsmVq$9i+{DD#*z^e#gH?+OpCnKf00=h=cmMzZ literal 0 HcmV?d00001 diff --git a/test/mpileup/mpileup.2.out b/test/mpileup/mpileup.2.out new file mode 100644 index 000000000..00c8efa6b --- /dev/null +++ b/test/mpileup/mpileup.2.out @@ -0,0 +1,523 @@ +##fileformat=VCFv4.2 +##FILTER= +##contig= +##ALT= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##FORMAT= +##FORMAT= +##FORMAT= +#CHROM POS ID REF ALT QUAL FILTER INFO FORMAT HG00100 HG00101 HG00102 +17 100 . C <*> 0 . DP=18;I16=17,0,0,0,688,29762,0,0,958,55682,0,0,332,7446,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,189:9:0 0,9,108:3:0 0,15,134:5:0 +17 101 . C <*> 0 . DP=18;I16=17,0,0,0,650,27530,0,0,958,55682,0,0,331,7303,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,182:9:0 0,9,99:3:0 0,15,132:5:0 +17 102 . C <*> 0 . DP=18;I16=17,0,0,0,695,30453,0,0,958,55682,0,0,330,7178,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,188:9:0 0,9,111:3:0 0,15,139:5:0 +17 103 . T <*> 0 . DP=18;I16=16,0,0,0,692,31998,0,0,929,54841,0,0,323,7035,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,189:8:0 0,9,108:3:0 0,15,147:5:0 +17 104 . G <*> 0 . DP=18;I16=15,0,0,0,611,26723,0,0,900,54000,0,0,295,6259,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,24,178:8:0 0,6,89:2:0 0,15,133:5:0 +17 105 . G <*> 0 . DP=19;I16=17,0,0,0,604,23936,0,0,989,58441,0,0,317,6751,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,170:9:0 0,9,97:3:0 0,15,125:5:0 +17 106 . G <*> 0 . DP=19;I16=17,0,0,0,644,26574,0,0,989,58441,0,0,299,6093,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,30,190:10:0 0,6,85:2:0 0,15,124:5:0 +17 107 . C <*> 0 . DP=19;I16=17,0,0,0,694,30064,0,0,989,58441,0,0,313,6543,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,192:9:0 0,9,108:3:0 0,15,136:5:0 +17 108 . C <*> 0 . DP=19;I16=17,0,0,0,692,30148,0,0,989,58441,0,0,310,6420,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,190:9:0 0,9,108:3:0 0,15,135:5:0 +17 109 . T <*> 0 . DP=19;I16=17,0,0,0,741,34273,0,0,989,58441,0,0,307,6319,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,195:9:0 0,9,110:3:0 0,15,150:5:0 +17 110 . G <*> 0 . DP=19;I16=17,0,0,0,704,31276,0,0,989,58441,0,0,304,6240,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,194:9:0 0,9,104:3:0 0,15,136:5:0 +17 111 . G <*> 0 . DP=19;I16=16,0,0,0,584,24362,0,0,929,54841,0,0,272,5416,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,30,167:10:0 0,6,88:2:0 0,12,118:4:0 +17 112 . C <*> 0 . DP=19;I16=17,0,0,0,680,29854,0,0,989,58441,0,0,296,6052,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,191:9:0 0,9,95:3:0 0,15,135:5:0 +17 113 . A <*> 0 . DP=19;I16=16,0,0,0,645,28035,0,0,960,57600,0,0,266,5318,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,176:9:0 0,6,87:2:0 0,15,139:5:0 +17 114 . C <*> 0 . DP=19;I16=17,0,0,0,674,28788,0,0,989,58441,0,0,286,5856,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,27,182:9:0 0,9,103:3:0 0,15,133:5:0 +17 115 . C <*> 0 . DP=21;I16=18,0,0,0,708,30546,0,0,1049,62041,0,0,274,5490,0,0;QS=3,0;MQ0F=0 PL:DP:DV 0,30,189:10:0 0,6,89:2:0 0,18,147:6:0 +17 116 . A <*> 0 . DP=21;I16=17,1,0,0,727,31755,0,0,1049,62041,0,0,253,5079,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,183:9:0 0,6,90:2:0 0,21,175:7:0 +17 117 . G <*> 0 . DP=21;I16=17,1,0,0,712,30478,0,0,1049,62041,0,0,249,5019,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,183:9:0 0,6,85:2:0 0,21,177:7:0 +17 118 . G <*> 0 . DP=20;I16=16,1,0,0,636,26574,0,0,958,55682,0,0,266,5426,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,175:9:0 0,3,60:1:0 0,21,162:7:0 +17 119 . G <*> 0 . DP=19;I16=16,1,0,0,629,26439,0,0,958,55682,0,0,267,5553,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,175:8:0 0,6,73:2:0 0,21,160:7:0 +17 120 . A <*> 0 . DP=19;I16=16,1,0,0,672,29188,0,0,958,55682,0,0,264,5518,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,175:8:0 0,6,83:2:0 0,21,171:7:0 +17 121 . G <*> 0 . DP=19;I16=16,1,0,0,662,28460,0,0,958,55682,0,0,260,5454,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,181:8:0 0,6,80:2:0 0,21,168:7:0 +17 122 . C <*> 0 . DP=20;I16=17,1,0,0,716,31224,0,0,1018,59282,0,0,256,5410,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,181:8:0 0,9,99:3:0 0,21,178:7:0 +17 123 . T <*> 0 . DP=18;I16=15,1,0,0,661,29997,0,0,898,52082,0,0,255,5385,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,167:7:0 0,9,112:3:0 0,18,166:6:0 +17 124 . T <*> 0 . DP=19;I16=17,1,0,0,626,24802,0,0,987,56523,0,0,279,6003,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,27,154:9:0 0,9,104:3:0 0,18,154:6:0 +17 125 . A <*> 0 . DP=18;I16=15,1,0,0,611,25689,0,0,898,52082,0,0,254,5340,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,154:7:0 0,9,104:3:0 0,18,162:6:0 +17 126 . A <*> 0 . DP=18;I16=16,1,0,0,648,27366,0,0,927,52923,0,0,279,5947,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,162:8:0 0,9,107:3:0 0,18,174:6:0 +17 127 . C <*> 0 . DP=18;I16=16,1,0,0,646,26972,0,0,927,52923,0,0,279,5949,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,163:8:0 0,9,109:3:0 0,18,160:6:0 +17 128 . A <*> 0 . DP=18;I16=16,1,0,0,673,28797,0,0,927,52923,0,0,279,5971,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,169:8:0 0,9,111:3:0 0,18,162:6:0 +17 129 . A <*> 0 . DP=17;I16=15,1,0,0,645,27891,0,0,867,49323,0,0,280,6012,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,168:8:0 0,9,113:3:0 0,15,159:5:0 +17 130 . A <*> 0 . DP=17;I16=15,1,0,0,641,27295,0,0,867,49323,0,0,281,6071,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,24,169:8:0 0,9,113:3:0 0,15,152:5:0 +17 131 . C <*> 0 . DP=16;I16=14,1,0,0,606,25732,0,0,838,48482,0,0,256,5472,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,167:7:0 0,9,110:3:0 0,15,147:5:0 +17 132 . A <*> 0 . DP=16;I16=14,1,0,0,627,27579,0,0,838,48482,0,0,256,5514,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,169:7:0 0,9,110:3:0 0,15,151:5:0 +17 133 . T <*> 0 . DP=15;I16=13,2,0,0,584,22816,0,0,838,48482,0,0,282,6196,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL:DP:DV 0,21,163:7:0 0,9,105:3:0 0,15,150:5:0 +17 134 . C <*> 0 . DP=15;I16=13,2,0,0,607,24653,0,0,838,48482,0,0,283,6267,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL:DP:DV 0,21,177:7:0 0,9,105:3:0 0,15,152:5:0 +17 135 . T <*> 0 . DP=15;I16=13,2,0,0,600,24178,0,0,838,48482,0,0,284,6352,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL:DP:DV 0,21,173:7:0 0,9,106:3:0 0,15,156:5:0 +17 136 . G <*> 0 . DP=15;I16=13,2,0,0,574,22258,0,0,838,48482,0,0,286,6450,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL:DP:DV 0,21,172:7:0 0,9,105:3:0 0,15,134:5:0 +17 137 . T <*> 0 . DP=15;I16=13,2,0,0,563,21377,0,0,838,48482,0,0,289,6561,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL:DP:DV 0,21,160:7:0 0,9,104:3:0 0,15,139:5:0 +17 138 . C <*> 0 . DP=15;I16=13,2,0,0,584,23088,0,0,838,48482,0,0,291,6637,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL:DP:DV 0,21,172:7:0 0,9,108:3:0 0,15,142:5:0 +17 139 . C <*> 0 . DP=15;I16=13,2,0,0,554,20790,0,0,838,48482,0,0,292,6680,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL:DP:DV 0,21,161:7:0 0,9,106:3:0 0,15,143:5:0 +17 140 . A <*> 0 . DP=15;I16=13,2,0,0,583,22789,0,0,838,48482,0,0,292,6690,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL:DP:DV 0,21,163:7:0 0,9,107:3:0 0,15,153:5:0 +17 141 . G <*> 0 . DP=14;I16=12,2,0,0,534,20750,0,0,778,44882,0,0,292,6664,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL:DP:DV 0,18,158:6:0 0,9,108:3:0 0,15,142:5:0 +17 142 . C <*> 0 . DP=14;I16=12,2,0,0,503,18593,0,0,778,44882,0,0,292,6650,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL:DP:DV 0,18,157:6:0 0,9,97:3:0 0,15,129:5:0 +17 143 . G <*> 0 . DP=14;I16=11,2,0,0,415,13657,0,0,718,41282,0,0,285,6599,0,0;QS=3,0;MQSB=0.590909;MQ0F=0 PL:DP:DV 0,18,128:6:0 0,9,95:3:0 0,12,97:4:0 +17 144 . A <*> 0 . DP=14;I16=12,2,0,0,519,19725,0,0,778,44882,0,0,291,6609,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL:DP:DV 0,18,152:6:0 0,9,105:3:0 0,15,129:5:0 +17 145 . A <*> 0 . DP=14;I16=12,2,0,0,527,20289,0,0,778,44882,0,0,290,6584,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL:DP:DV 0,18,153:6:0 0,9,106:3:0 0,15,138:5:0 +17 146 . T <*> 0 . DP=14;I16=12,2,0,0,514,19484,0,0,778,44882,0,0,289,6573,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL:DP:DV 0,18,152:6:0 0,9,103:3:0 0,15,128:5:0 +17 147 . A <*> 0 . DP=14;I16=12,2,0,0,515,19213,0,0,778,44882,0,0,288,6576,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL:DP:DV 0,18,150:6:0 0,9,99:3:0 0,15,140:5:0 +17 148 . C <*> 0 . DP=14;I16=12,2,0,0,541,21019,0,0,778,44882,0,0,286,6542,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL:DP:DV 0,18,157:6:0 0,9,106:3:0 0,15,146:5:0 +17 149 . C <*> 0 . DP=14;I16=12,2,0,0,512,19326,0,0,778,44882,0,0,283,6471,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL:DP:DV 0,18,148:6:0 0,9,109:3:0 0,15,140:5:0 +17 150 . T <*> 0 . DP=13;I16=11,2,0,0,511,20251,0,0,749,44041,0,0,280,6362,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,18,153:6:0 0,6,84:2:0 0,15,152:5:0 +17 151 . G <*> 0 . DP=13;I16=11,2,0,0,506,19826,0,0,749,44041,0,0,277,6263,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,18,157:6:0 0,6,84:2:0 0,15,144:5:0 +17 152 . C <*> 0 . DP=14;I16=12,2,0,0,543,21283,0,0,809,47641,0,0,274,6174,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,21,168:7:0 0,6,84:2:0 0,15,146:5:0 +17 153 . A <*> 0 . DP=14;I16=12,2,0,0,536,20594,0,0,809,47641,0,0,272,6096,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,21,156:7:0 0,6,81:2:0 0,15,153:5:0 +17 154 . T <*> 0 . DP=14;I16=12,2,0,0,523,20051,0,0,809,47641,0,0,270,6030,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,21,159:7:0 0,6,83:2:0 0,15,139:5:0 +17 155 . C <*> 0 . DP=14;I16=12,2,0,0,542,21254,0,0,809,47641,0,0,268,5976,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,21,172:7:0 0,6,85:2:0 0,15,139:5:0 +17 156 . C <*> 0 . DP=14;I16=12,2,0,0,536,20884,0,0,809,47641,0,0,266,5934,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,21,163:7:0 0,6,84:2:0 0,15,150:5:0 +17 157 . C <*> 0 . DP=14;I16=12,2,0,0,555,22081,0,0,809,47641,0,0,264,5904,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,21,169:7:0 0,6,85:2:0 0,15,149:5:0 +17 158 . T <*> 0 . DP=14;I16=12,2,0,0,568,23154,0,0,809,47641,0,0,262,5886,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,21,170:7:0 0,6,84:2:0 0,15,159:5:0 +17 159 . A <*> 0 . DP=15;I16=12,2,0,0,519,19467,0,0,809,47641,0,0,260,5880,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,21,157:7:0 0,6,83:2:0 0,15,135:5:0 +17 160 . G <*> 0 . DP=15;I16=13,2,0,0,547,20633,0,0,869,51241,0,0,259,5887,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,21,165:7:0 0,6,85:2:0 0,18,139:6:0 +17 161 . A <*> 0 . DP=15;I16=13,2,0,0,568,21610,0,0,869,51241,0,0,258,5908,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,21,157:7:0 0,6,83:2:0 0,18,162:6:0 +17 162 . A <*> 0 . DP=15;I16=13,2,0,0,557,21139,0,0,869,51241,0,0,255,5843,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,21,147:7:0 0,6,87:2:0 0,18,167:6:0 +17 163 . G <*> 0 . DP=14;I16=12,2,0,0,503,18645,0,0,809,47641,0,0,253,5791,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,21,153:7:0 0,6,79:2:0 0,15,138:5:0 +17 164 . T <*> 0 . DP=14;I16=12,2,0,0,460,15968,0,0,809,47641,0,0,252,5750,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,18,131:6:0 0,6,79:2:0 0,18,136:6:0 +17 165 . G <*> 0 . DP=14;I16=10,2,0,0,456,17460,0,0,689,40441,0,0,226,5094,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,18,149:6:0 0,6,80:2:0 0,12,122:4:0 +17 166 . A <*> 0 . DP=14;I16=11,2,0,0,496,19138,0,0,749,44041,0,0,227,5077,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,18,145:6:0 0,6,82:2:0 0,15,148:5:0 +17 167 . A <*> 0 . DP=14;I16=11,2,0,0,477,17851,0,0,749,44041,0,0,227,5071,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,18,132:6:0 0,6,86:2:0 0,15,147:5:0 +17 168 . G <*> 0 . DP=14;I16=12,2,0,0,481,18015,0,0,809,47641,0,0,252,5702,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,18,145:6:0 0,6,82:2:0 0,18,140:6:0 +17 169 . C <*> 0 . DP=13;I16=10,2,0,0,402,14224,0,0,689,40441,0,0,227,5045,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,15,106:5:0 0,6,76:2:0 0,15,145:5:0 +17 170 . C <*> 0 . DP=13;I16=11,2,0,0,447,16383,0,0,749,44041,0,0,251,5601,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,15,128:5:0 0,6,80:2:0 0,18,143:6:0 +17 171 . A <*> 0 . DP=13;I16=11,2,0,0,500,19366,0,0,749,44041,0,0,250,5546,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,15,134:5:0 0,6,81:2:0 0,18,166:6:0 +17 172 . C <*> 0 . DP=13;I16=10,2,0,0,439,16395,0,0,689,40441,0,0,241,5441,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,15,138:5:0 0,6,75:2:0 0,15,129:5:0 +17 173 . C <*> 0 . DP=13;I16=11,2,0,0,435,15225,0,0,749,44041,0,0,248,5478,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV 0,15,121:5:0 0,6,76:2:0 0,18,146:6:0 +17 174 . G <*> 0 . DP=13;I16=11,1,0,0,351,10685,0,0,689,40441,0,0,238,5364,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,15,111:5:0 0,3,27:1:0 0,18,117:6:0 +17 175 . C <*> 0 . DP=14;I16=13,1,0,0,511,19161,0,0,809,47641,0,0,249,5463,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,143:6:0 0,3,41:1:0 0,21,175:7:0 +17 176 . C <*> 0 . DP=14;I16=13,1,0,0,489,17733,0,0,809,47641,0,0,251,5477,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,146:6:0 0,3,44:1:0 0,21,152:7:0 +17 177 . C <*> 0 . DP=14;I16=13,1,0,0,488,17328,0,0,809,47641,0,0,253,5507,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,138:6:0 0,3,44:1:0 0,21,158:7:0 +17 178 . A <*> 0 . DP=14;I16=13,1,0,0,519,19485,0,0,809,47641,0,0,254,5502,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,147:6:0 0,3,42:1:0 0,21,172:7:0 +17 179 . A <*> 0 . DP=14;I16=13,1,0,0,478,17278,0,0,809,47641,0,0,255,5511,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,134:6:0 0,3,44:1:0 0,21,170:7:0 +17 180 . A <*> 0 . DP=14;I16=12,1,0,0,425,14653,0,0,749,44041,0,0,250,5498,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,126:6:0 0,3,43:1:0 0,18,148:6:0 +17 181 . G <*> 0 . DP=14;I16=11,1,0,0,450,17152,0,0,689,40441,0,0,233,5233,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,156:6:0 0,3,41:1:0 0,15,138:5:0 +17 182 . A <*> 0 . DP=15;I16=14,1,0,0,515,18235,0,0,869,51241,0,0,258,5622,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,150:7:0 0,3,43:1:0 0,21,159:7:0 +17 183 . C <*> 0 . DP=15;I16=13,1,0,0,483,17419,0,0,809,47641,0,0,235,5063,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,159:7:0 0,3,40:1:0 0,18,139:6:0 +17 184 . A <*> 0 . DP=15;I16=14,1,0,0,535,19667,0,0,869,51241,0,0,262,5770,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,158:7:0 0,3,41:1:0 0,21,163:7:0 +17 185 . C <*> 0 . DP=15;I16=13,1,0,0,487,17295,0,0,809,47641,0,0,238,5192,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,21,150:7:0 0,3,38:1:0 0,18,160:6:0 +17 186 . G <*> 0 . DP=15;I16=12,1,0,0,381,11429,0,0,749,44041,0,0,239,5253,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,117:6:0 0,3,32:1:0 0,18,124:6:0 +17 187 . C <*> 0 . DP=14;I16=13,1,0,0,511,18979,0,0,809,47641,0,0,266,5952,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,147:6:0 0,3,38:1:0 0,21,172:7:0 +17 188 . C <*> 0 . DP=14;I16=13,1,0,0,496,18042,0,0,809,47641,0,0,267,5989,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,18,147:6:0 0,3,37:1:0 0,21,162:7:0 +17 189 . C <*> 0 . DP=15;I16=13,2,0,0,552,20504,0,0,838,48482,0,0,268,6040,0,0;QS=3,0;MQSB=0;MQ0F=0 PL:DP:DV 0,18,152:6:0 0,6,67:2:0 0,21,167:7:0 +17 190 . A <*> 0 . DP=15;I16=12,2,0,0,500,18230,0,0,778,44882,0,0,243,5381,0,0;QS=3,0;MQSB=0;MQ0F=0 PL:DP:DV 0,18,138:6:0 0,6,68:2:0 0,18,159:6:0 +17 191 . T <*> 0 . DP=15;I16=13,2,0,0,534,19276,0,0,838,48482,0,0,267,5939,0,0;QS=3,0;MQSB=0;MQ0F=0 PL:DP:DV 0,18,143:6:0 0,6,67:2:0 0,21,169:7:0 +17 192 . G <*> 0 . DP=15;I16=13,2,0,0,499,17439,0,0,838,48482,0,0,266,5890,0,0;QS=3,0;MQSB=0;MQ0F=0 PL:DP:DV 0,18,143:6:0 0,6,67:2:0 0,21,151:7:0 +17 193 . T <*> 0 . DP=15;I16=13,2,0,0,505,17811,0,0,838,48482,0,0,265,5859,0,0;QS=3,0;MQSB=0;MQ0F=0 PL:DP:DV 0,18,140:6:0 0,6,63:2:0 0,21,157:7:0 +17 194 . C <*> 0 . DP=14;I16=12,2,0,0,467,16569,0,0,778,44882,0,0,265,5845,0,0;QS=3,0;MQSB=0;MQ0F=0 PL:DP:DV 0,18,142:6:0 0,6,67:2:0 0,18,145:6:0 +17 195 . C <*> 0 . DP=14;I16=11,3,0,0,503,18647,0,0,747,42123,0,0,266,5846,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:DV 0,18,159:6:0 0,6,71:2:0 0,18,160:6:0 +17 196 . A <*> 0 . DP=14;I16=11,3,0,0,482,17400,0,0,747,42123,0,0,268,5862,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:DV 0,18,166:6:0 0,6,69:2:0 0,18,138:6:0 +17 197 . G <*> 0 . DP=14;I16=11,3,0,0,481,17391,0,0,747,42123,0,0,270,5894,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:DV 0,18,164:6:0 0,6,68:2:0 0,18,134:6:0 +17 198 . C <*> 0 . DP=14;I16=11,3,0,0,539,20957,0,0,747,42123,0,0,271,5893,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:DV 0,18,172:6:0 0,6,70:2:0 0,18,164:6:0 +17 199 . T <*> 0 . DP=14;I16=11,3,0,0,505,19197,0,0,747,42123,0,0,271,5861,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:DV 0,18,162:6:0 0,6,73:2:0 0,18,154:6:0 +17 200 . T <*> 0 . DP=15;I16=11,4,0,0,544,19918,0,0,776,42964,0,0,270,5798,0,0;QS=3,0;MQSB=0.0161635;MQ0F=0 PL:DP:DV 0,18,161:6:0 0,9,89:3:0 0,18,154:6:0 +17 201 . A <*> 0 . DP=16;I16=12,4,0,0,568,20416,0,0,836,46564,0,0,269,5703,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,171:7:0 0,9,89:3:0 0,18,157:6:0 +17 202 . A <*> 0 . DP=16;I16=12,4,0,0,566,20590,0,0,836,46564,0,0,269,5627,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,178:7:0 0,9,84:3:0 0,18,163:6:0 +17 203 . C <*> 0 . DP=16;I16=12,4,0,0,557,20119,0,0,836,46564,0,0,269,5571,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,166:7:0 0,9,90:3:0 0,18,153:6:0 +17 204 . C <*> 0 . DP=16;I16=12,4,0,0,591,22379,0,0,836,46564,0,0,269,5535,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,173:7:0 0,9,91:3:0 0,18,163:6:0 +17 205 . T <*> 0 . DP=16;I16=12,4,0,0,635,25281,0,0,836,46564,0,0,269,5519,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,188:7:0 0,9,95:3:0 0,18,173:6:0 +17 206 . G <*> 0 . DP=16;I16=12,4,0,0,577,21337,0,0,836,46564,0,0,269,5523,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,180:7:0 0,9,89:3:0 0,18,143:6:0 +17 207 . C <*> 0 . DP=16;I16=12,4,0,0,574,21076,0,0,836,46564,0,0,269,5547,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,179:7:0 0,9,93:3:0 0,18,151:6:0 +17 208 . A <*> 0 . DP=16;I16=12,4,0,0,576,21486,0,0,836,46564,0,0,268,5540,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,184:7:0 0,9,93:3:0 0,18,154:6:0 +17 209 . T <*> 0 . DP=16;I16=12,4,0,0,567,20475,0,0,836,46564,0,0,267,5551,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,173:7:0 0,9,91:3:0 0,18,146:6:0 +17 210 . C <*> 0 . DP=16;I16=12,4,0,0,577,21109,0,0,836,46564,0,0,266,5580,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,185:7:0 0,9,92:3:0 0,18,151:6:0 +17 211 . C <*> 0 . DP=16;I16=12,4,0,0,563,20227,0,0,836,46564,0,0,265,5627,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,172:7:0 0,9,92:3:0 0,18,153:6:0 +17 212 . C <*> 0 . DP=16;I16=12,4,0,0,589,22179,0,0,836,46564,0,0,263,5643,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,181:7:0 0,9,92:3:0 0,18,152:6:0 +17 213 . T <*> 0 . DP=16;I16=12,4,0,0,598,22838,0,0,836,46564,0,0,262,5678,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV 0,21,181:7:0 0,9,95:3:0 0,18,165:6:0 +17 214 . A <*> 0 . DP=16;I16=11,4,0,0,529,19401,0,0,776,42964,0,0,240,5248,0,0;QS=3,0;MQSB=0.0161635;MQ0F=0 PL:DP:DV 0,21,176:7:0 0,9,92:3:0 0,15,118:5:0 +17 215 . G <*> 0 . DP=15;I16=12,3,0,0,521,19073,0,0,807,45723,0,0,262,5754,0,0;QS=3,0;MQSB=0.0342181;MQ0F=0 PL:DP:DV 0,21,185:7:0 0,9,90:3:0 0,15,105:5:0 +17 216 . A <*> 0 . DP=14;I16=10,3,0,0,464,16900,0,0,687,38523,0,0,238,5166,0,0;QS=3,0;MQSB=0.040184;MQ0F=0 PL:DP:DV 0,21,173:7:0 0,9,92:3:0 0,9,81:3:0 +17 217 . A <*> 0 . DP=14;I16=11,3,0,0,515,19433,0,0,747,42123,0,0,264,5842,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:DV 0,21,181:7:0 0,9,90:3:0 0,12,97:4:0 +17 218 . G <*> 0 . DP=14;I16=11,3,0,0,507,18957,0,0,747,42123,0,0,265,5907,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:DV 0,21,178:7:0 0,9,90:3:0 0,12,110:4:0 +17 219 . T <*> 0 . DP=14;I16=11,3,0,0,470,16286,0,0,747,42123,0,0,266,5986,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:DV 0,21,173:7:0 0,9,88:3:0 0,12,89:4:0 +17 220 . G <*> 0 . DP=14;I16=10,3,0,0,485,18307,0,0,687,38523,0,0,242,5454,0,0;QS=3,0;MQSB=0.040184;MQ0F=0 PL:DP:DV 0,21,188:7:0 0,9,88:3:0 0,9,80:3:0 +17 221 . A <*> 0 . DP=14;I16=11,3,0,0,487,17615,0,0,747,42123,0,0,267,6135,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:DV 0,21,176:7:0 0,9,88:3:0 0,12,101:4:0 +17 222 . A <*> 0 . DP=14;I16=10,3,0,0,465,17367,0,0,687,38523,0,0,242,5578,0,0;QS=3,0;MQSB=0.040184;MQ0F=0 PL:DP:DV 0,21,186:7:0 0,9,85:3:0 0,9,69:3:0 +17 223 . G <*> 0 . DP=13;I16=9,3,0,0,405,14327,0,0,627,34923,0,0,243,5657,0,0;QS=3,0;MQSB=0.0443614;MQ0F=0 PL:DP:DV 0,18,168:6:0 0,6,53:2:0 0,12,81:4:0 +17 224 . G <*> 0 . DP=12;I16=9,3,0,0,379,12759,0,0,627,34923,0,0,270,6370,0,0;QS=3,0;MQSB=0.0443614;MQ0F=0 PL:DP:DV 0,18,168:6:0 0,6,50:2:0 0,12,70:4:0 +17 225 . C <*> 0 . DP=12;I16=8,3,0,0,382,13896,0,0,567,31323,0,0,261,6345,0,0;QS=3,0;MQSB=0.0497871;MQ0F=0 PL:DP:DV 0,18,165:6:0 0,6,48:2:0 0,9,83:3:0 +17 226 . A <*> 0 . DP=13;I16=8,3,0,0,381,13669,0,0,567,31323,0,0,248,5894,0,0;QS=3,0;MQSB=0.0497871;MQ0F=0 PL:DP:DV 0,18,166:6:0 0,6,53:2:0 0,9,84:3:0 +17 227 . C <*> 0 . DP=13;I16=8,4,0,0,406,14306,0,0,596,32164,0,0,267,6253,0,0;QS=3,0;MQSB=0.0249144;MQ0F=0 PL:DP:DV 0,21,190:7:0 0,6,53:2:0 0,9,73:3:0 +17 228 . C <*> 0 . DP=13;I16=9,4,0,0,417,14381,0,0,656,35764,0,0,292,6884,0,0;QS=3,0;MQSB=0.0211283;MQ0F=0 PL:DP:DV 0,21,187:7:0 0,6,45:2:0 0,12,96:4:0 +17 229 . G <*> 0 . DP=13;I16=9,3,0,0,358,11424,0,0,627,34923,0,0,270,6414,0,0;QS=3,0;MQSB=0.0443614;MQ0F=0 PL:DP:DV 0,18,136:6:0 0,6,53:2:0 0,12,70:4:0 +17 230 . C <*> 0 . DP=13;I16=9,4,0,0,461,16861,0,0,656,35764,0,0,292,6920,0,0;QS=3,0;MQSB=0.0211283;MQ0F=0 PL:DP:DV 0,21,186:7:0 0,6,53:2:0 0,12,100:4:0 +17 231 . C <*> 0 . DP=13;I16=7,4,0,0,414,15832,0,0,536,28564,0,0,247,5925,0,0;QS=3,0;MQSB=0.0401934;MQ0F=0 PL:DP:DV 0,18,184:6:0 0,6,53:2:0 0,9,82:3:0 +17 232 . C <*> 0 . DP=14;I16=9,4,0,0,471,17371,0,0,656,35764,0,0,267,6363,0,0;QS=3,0;MQSB=0.0211283;MQ0F=0 PL:DP:DV 0,21,198:7:0 0,6,53:2:0 0,12,101:4:0 +17 233 . A <*> 0 . DP=14;I16=10,4,0,0,496,18142,0,0,716,39364,0,0,292,6984,0,0;QS=3,0;MQSB=0.0183156;MQ0F=0 PL:DP:DV 0,21,192:7:0 0,6,53:2:0 0,15,119:5:0 +17 234 . A <*> 0 . DP=14;I16=10,4,0,0,502,18390,0,0,716,39364,0,0,292,6988,0,0;QS=3,0;MQSB=0.0183156;MQ0F=0 PL:DP:DV 0,21,185:7:0 0,6,53:2:0 0,15,123:5:0 +17 235 . A <*> 0 . DP=14;I16=9,4,0,0,476,17652,0,0,656,35764,0,0,267,6375,0,0;QS=3,0;MQSB=0.0211283;MQ0F=0 PL:DP:DV 0,21,186:7:0 0,6,53:2:0 0,12,111:4:0 +17 236 . G <*> 0 . DP=15;I16=11,4,0,0,501,17481,0,0,776,42964,0,0,290,6924,0,0;QS=3,0;MQSB=0.0161635;MQ0F=0 PL:DP:DV 0,24,206:8:0 0,6,53:2:0 0,15,103:5:0 +17 237 . A <*> 0 . DP=14;I16=9,4,0,0,465,16877,0,0,656,35764,0,0,266,6282,0,0;QS=3,0;MQSB=0.0211283;MQ0F=0 PL:DP:DV 0,24,206:8:0 0,6,53:2:0 0,9,92:3:0 +17 238 . C <*> 0 . DP=14;I16=10,4,0,0,482,17238,0,0,716,39364,0,0,292,6900,0,0;QS=3,0;MQSB=0.0183156;MQ0F=0 PL:DP:DV 0,24,211:8:0 0,6,53:2:0 0,12,82:4:0 +17 239 . A <*> 0 . DP=15;I16=10,5,0,0,525,19155,0,0,776,42964,0,0,292,6852,0,0;QS=3,0;MQSB=0.0497871;MQ0F=0 PL:DP:DV 0,27,223:9:0 0,6,50:2:0 0,12,108:4:0 +17 240 . C <*> 0 . DP=15;I16=10,5,0,0,512,17930,0,0,776,42964,0,0,292,6764,0,0;QS=3,0;MQSB=0.0497871;MQ0F=0 PL:DP:DV 0,27,220:9:0 0,6,53:2:0 0,12,106:4:0 +17 241 . G <*> 0 . DP=15;I16=9,5,0,0,444,14636,0,0,716,39364,0,0,269,6159,0,0;QS=3,0;MQSB=0.0561348;MQ0F=0 PL:DP:DV 0,27,203:9:0 0,6,53:2:0 0,9,59:3:0 +17 242 . C <*> 0 . DP=15;I16=10,5,0,0,555,21177,0,0,776,42964,0,0,292,6624,0,0;QS=3,0;MQSB=0.0497871;MQ0F=0 PL:DP:DV 0,27,242:9:0 0,6,53:2:0 0,12,94:4:0 +17 243 . C <*> 0 . DP=16;I16=9,5,0,0,523,19737,0,0,716,39364,0,0,284,6508,0,0;QS=3,0;MQSB=0.0561348;MQ0F=0 PL:DP:DV 0,24,220:8:0 0,6,53:2:0 0,12,104:4:0 +17 244 . C <*> 0 . DP=16;I16=10,6,0,0,620,24272,0,0,805,43805,0,0,298,6568,0,0;QS=3,0;MQSB=0.0253122;MQ0F=0 PL:DP:DV 0,27,245:9:0 0,9,72:3:0 0,12,106:4:0 +17 245 . A <*> 0 . DP=17;I16=10,7,0,0,649,24843,0,0,865,47405,0,0,299,6553,0,0;QS=3,0;MQSB=0.0509867;MQ0F=0 PL:DP:DV 0,27,236:9:0 0,12,93:4:0 0,12,115:4:0 +17 246 . T <*> 0 . DP=18;I16=10,8,0,0,649,23833,0,0,894,48246,0,0,301,6553,0,0;QS=3,0;MQSB=0.0286491;MQ0F=0 PL:DP:DV 0,30,247:10:0 0,12,94:4:0 0,12,98:4:0 +17 247 . G <*> 0 . DP=18;I16=10,8,0,0,642,23610,0,0,894,48246,0,0,304,6570,0,0;QS=3,0;MQSB=0.0286491;MQ0F=0 PL:DP:DV 0,30,252:10:0 0,12,83:4:0 0,12,103:4:0 +17 248 . T <*> 0 . DP=18;I16=10,8,0,0,636,22944,0,0,894,48246,0,0,307,6605,0,0;QS=3,0;MQSB=0.0286491;MQ0F=0 PL:DP:DV 0,30,234:10:0 0,12,86:4:0 0,12,114:4:0 +17 249 . C <*> 0 . DP=18;I16=10,8,0,0,656,24846,0,0,894,48246,0,0,310,6658,0,0;QS=3,0;MQSB=0.0286491;MQ0F=0 PL:DP:DV 0,30,253:10:0 0,12,79:4:0 0,12,112:4:0 +17 250 . C <*> 0 . DP=19;I16=10,9,0,0,694,26160,0,0,923,49087,0,0,311,6631,0,0;QS=3,0;MQSB=0.0168512;MQ0F=0 PL:DP:DV 0,30,248:10:0 0,12,89:4:0 0,15,142:5:0 +17 251 . A <*> 0 . DP=19;I16=9,9,0,0,688,26506,0,0,863,45487,0,0,313,6627,0,0;QS=3,0;MQSB=0.0208913;MQ0F=0 PL:DP:DV 0,27,233:9:0 0,12,97:4:0 0,15,148:5:0 +17 252 . G <*> 0 . DP=18;I16=8,9,0,0,641,24631,0,0,803,41887,0,0,304,6502,0,0;QS=3,0;MQSB=0.026526;MQ0F=0 PL:DP:DV 0,27,243:9:0 0,12,91:4:0 0,12,121:4:0 +17 253 . C <*> 0 . DP=19;I16=9,10,0,0,705,26921,0,0,892,46328,0,0,319,6687,0,0;QS=3,0;MQSB=0.0132999;MQ0F=0 PL:DP:DV 0,27,247:9:0 0,12,86:4:0 0,18,155:6:0 +17 254 . T <*> 0 . DP=20;I16=10,9,0,0,719,27517,0,0,892,46328,0,0,314,6670,0,0;QS=3,0;MQSB=0.00482795;MQ0F=0 PL:DP:DV 0,30,254:10:0 0,9,72:3:0 0,18,164:6:0 +17 255 . T <*> 0 . DP=21;I16=11,10,0,0,750,27076,0,0,1012,53528,0,0,328,6840,0,0;QS=3,0;MQSB=0.00822975;MQ0F=0 PL:DP:DV 0,33,241:11:0 0,12,95:4:0 0,18,161:6:0 +17 256 . A <*> 0 . DP=22;I16=11,11,0,0,811,30063,0,0,1049,54897,0,0,334,6956,0,0;QS=3,0;MQSB=0.00507916;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,110:5:0 0,18,166:6:0 +17 257 . T <*> 0 . DP=22;I16=11,11,0,0,814,30420,0,0,1049,54897,0,0,341,7101,0,0;QS=3,0;MQSB=0.00507916;MQ0F=0 PL:DP:DV 0,33,247:11:0 0,15,113:5:0 0,18,168:6:0 +17 258 . T <*> 0 . DP=22;I16=11,11,0,0,791,28943,0,0,1049,54897,0,0,347,7225,0,0;QS=3,0;MQSB=0.00507916;MQ0F=0 PL:DP:DV 0,33,254:11:0 0,15,116:5:0 0,18,155:6:0 +17 259 . C <*> 0 . DP=22;I16=11,10,0,0,785,29809,0,0,1020,54056,0,0,332,6936,0,0;QS=3,0;MQSB=0.00822975;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,90:4:0 0,18,170:6:0 +17 260 . T <*> 0 . DP=21;I16=10,11,0,0,829,32899,0,0,989,51297,0,0,360,7556,0,0;QS=3,0;MQSB=0.00660016;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,118:5:0 0,15,156:5:0 +17 261 . G <*> 0 . DP=21;I16=10,11,0,0,735,27379,0,0,989,51297,0,0,367,7761,0,0;QS=3,0;MQSB=0.00660016;MQ0F=0 PL:DP:DV 0,33,254:11:0 0,15,111:5:0 0,15,122:5:0 +17 262 . C <*> 0 . DP=22;I16=10,12,0,0,806,30278,0,0,1049,54897,0,0,373,7941,0,0;QS=3,0;MQSB=0.0122507;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,99:5:0 0,18,164:6:0 +17 263 . C <*> 0 . DP=22;I16=10,12,0,0,799,29717,0,0,1049,54897,0,0,380,8146,0,0;QS=3,0;MQSB=0.0122507;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,98:5:0 0,18,168:6:0 +17 264 . C <*> 0 . DP=22;I16=10,12,0,0,821,31325,0,0,1049,54897,0,0,386,8326,0,0;QS=3,0;MQSB=0.0122507;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,104:5:0 0,18,172:6:0 +17 265 . A <*> 0 . DP=21;I16=9,12,0,0,800,31906,0,0,989,51297,0,0,390,8380,0,0;QS=3,0;MQSB=0.0158903;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,114:5:0 0,15,129:5:0 +17 266 . G <*> 0 . DP=21;I16=9,11,0,0,747,28155,0,0,960,50456,0,0,369,7833,0,0;QS=3,0;MQSB=0.0237479;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,12,97:4:0 0,15,138:5:0 +17 267 . T <*> 0 . DP=21;I16=9,11,0,0,739,27465,0,0,960,50456,0,0,373,7935,0,0;QS=3,0;MQSB=0.0237479;MQ0F=0 PL:DP:DV 0,33,254:11:0 0,12,101:4:0 0,15,149:5:0 +17 268 . T <*> 0 . DP=21;I16=9,12,0,0,748,27708,0,0,989,51297,0,0,402,8686,0,0;QS=3,0;MQSB=0.0158903;MQ0F=0 PL:DP:DV 0,33,238:11:0 0,15,110:5:0 0,15,156:5:0 +17 269 . C <*> 0 . DP=22;I16=9,12,0,0,764,28632,0,0,989,51297,0,0,381,8211,0,0;QS=3,0;MQSB=0.0158903;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,91:4:0 0,15,154:5:0 +17 270 . C <*> 0 . DP=22;I16=9,12,0,0,758,28146,0,0,989,51297,0,0,385,8337,0,0;QS=3,0;MQSB=0.0158903;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,96:4:0 0,15,143:5:0 +17 271 . T <*> 0 . DP=22;I16=9,13,0,0,847,32935,0,0,1018,52138,0,0,413,9065,0,0;QS=3,0;MQSB=0.0109431;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,113:5:0 0,15,152:5:0 +17 272 . C <*> 0 . DP=22;I16=9,12,0,0,809,31413,0,0,989,51297,0,0,390,8518,0,0;QS=3,0;MQSB=0.0158903;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,96:4:0 0,15,149:5:0 +17 273 . T <*> 0 . DP=22;I16=9,12,0,0,798,30664,0,0,989,51297,0,0,392,8620,0,0;QS=3,0;MQSB=0.0158903;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,95:4:0 0,15,161:5:0 +17 274 . C <*> 0 . DP=22;I16=9,12,0,0,763,28177,0,0,989,51297,0,0,394,8746,0,0;QS=3,0;MQSB=0.0158903;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,12,101:4:0 0,15,144:5:0 +17 275 . C <*> 0 . DP=20;I16=7,13,0,0,768,29994,0,0,898,44938,0,0,423,9519,0,0;QS=3,0;MQSB=0.0213617;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,114:5:0 0,12,122:4:0 +17 276 . A <*> 0 . DP=20;I16=7,13,0,0,805,32931,0,0,898,44938,0,0,424,9538,0,0;QS=3,0;MQSB=0.0213617;MQ0F=0 PL:DP:DV 0,33,253:11:0 0,15,122:5:0 0,12,124:4:0 +17 277 . G <*> 0 . DP=20;I16=7,13,0,0,764,29732,0,0,898,44938,0,0,425,9579,0,0;QS=3,0;MQSB=0.0213617;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,15,114:5:0 0,12,121:4:0 +17 278 . A <*> 0 . DP=21;I16=6,14,0,0,722,26452,0,0,867,42179,0,0,415,9521,0,0;QS=3,0;MQSB=0.0246228;MQ0F=0 PL:DP:DV 0,30,238:10:0 0,18,123:6:0 0,12,121:4:0 +17 279 . A <*> 0 . DP=22;I16=7,15,0,0,786,28694,0,0,956,46620,0,0,427,9677,0,0;QS=3,0;MQSB=0.0124927;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,123:6:0 0,12,122:4:0 +17 280 . A <*> 0 . DP=22;I16=7,15,0,0,815,31561,0,0,956,46620,0,0,428,9684,0,0;QS=3,0;MQSB=0.0124927;MQ0F=0 PL:DP:DV 0,36,253:12:0 0,18,130:6:0 0,12,129:4:0 +17 281 . G <*> 0 . DP=22;I16=7,15,0,0,820,31416,0,0,956,46620,0,0,428,9662,0,0;QS=3,0;MQSB=0.0124927;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,122:6:0 0,12,123:4:0 +17 282 . G <*> 0 . DP=22;I16=7,15,0,0,806,30420,0,0,956,46620,0,0,427,9609,0,0;QS=3,0;MQSB=0.0124927;MQ0F=0 PL:DP:DV 0,36,253:12:0 0,18,124:6:0 0,12,119:4:0 +17 283 . C <*> 0 . DP=23;I16=7,15,0,0,827,31785,0,0,956,46620,0,0,426,9574,0,0;QS=3,0;MQSB=0.0124927;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,125:6:0 0,12,122:4:0 +17 284 . T <*> 0 . DP=23;I16=7,16,0,0,901,35479,0,0,1016,50220,0,0,431,9593,0,0;QS=3,0;MQSB=0.0194969;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,126:6:0 0,15,144:5:0 +17 285 . G <*> 0 . DP=23;I16=7,16,0,0,860,32856,0,0,1016,50220,0,0,431,9607,0,0;QS=3,0;MQSB=0.0194969;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,119:6:0 0,15,132:5:0 +17 286 . C <*> 0 . DP=24;I16=8,16,0,0,875,32883,0,0,1076,53820,0,0,431,9641,0,0;QS=3,0;MQSB=0.0132999;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,150:7:0 0,15,134:5:0 +17 287 . A <*> 0 . DP=25;I16=9,16,0,0,895,32957,0,0,1136,57420,0,0,432,9696,0,0;QS=3,0;MQSB=0.00934348;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,178:8:0 0,15,133:5:0 +17 288 . T <*> 0 . DP=25;I16=9,16,0,0,931,35011,0,0,1136,57420,0,0,432,9674,0,0;QS=3,0;MQSB=0.00934348;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,184:8:0 0,15,146:5:0 +17 289 . G <*> 0 . DP=25;I16=9,16,0,0,939,36117,0,0,1136,57420,0,0,432,9676,0,0;QS=3,0;MQSB=0.00934348;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,185:8:0 0,15,136:5:0 +17 290 . G <*> 0 . DP=23;I16=8,15,0,0,805,29157,0,0,1047,52979,0,0,433,9651,0,0;QS=3,0;MQSB=0.0177152;MQ0F=0 PL:DP:DV 0,33,240:11:0 0,21,164:7:0 0,15,126:5:0 +17 291 . T <*> 0 . DP=24;I16=8,15,0,0,840,31616,0,0,1047,52979,0,0,421,9479,0,0;QS=3,0;MQSB=0.0177152;MQ0F=0 PL:DP:DV 0,33,244:11:0 0,21,168:7:0 0,15,136:5:0 +17 292 . T <*> 0 . DP=25;I16=9,16,0,0,888,32274,0,0,1167,60179,0,0,436,9668,0,0;QS=3,0;MQSB=0.0197089;MQ0F=0 PL:DP:DV 0,33,253:11:0 0,24,181:8:0 0,18,156:6:0 +17 293 . G <*> 0 . DP=26;I16=10,15,0,0,934,35232,0,0,1167,60179,0,0,424,9488,0,0;QS=3,0;MQSB=0.0095249;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,196:8:0 0,15,145:5:0 +17 294 . A <*> 0 . DP=26;I16=10,16,0,0,931,33937,0,0,1227,63779,0,0,443,9785,0,0;QS=3,0;MQSB=0.0149748;MQ0F=0 PL:DP:DV 0,36,252:12:0 0,24,201:8:0 0,18,161:6:0 +17 295 . C <*> 0 . DP=25;I16=10,14,0,0,897,33973,0,0,1169,62097,0,0,430,9544,0,0;QS=3,0;MQSB=0.0310726;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,180:7:0 0,18,159:6:0 +17 296 . A <*> 0 . DP=25;I16=10,15,0,0,874,31846,0,0,1198,62938,0,0,451,9905,0,0;QS=3,0;MQSB=0.0213617;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,169:8:0 0,18,169:6:0 +17 297 . C <*> 0 . DP=25;I16=9,15,0,0,901,34305,0,0,1138,59338,0,0,445,9901,0,0;QS=3,0;MQSB=0.0273237;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,174:7:0 0,18,161:6:0 +17 298 . A <*> 0 . DP=26;I16=11,15,0,0,936,34652,0,0,1258,66538,0,0,459,10121,0,0;QS=3,0;MQSB=0.017008;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,184:8:0 0,21,191:7:0 +17 299 . C <*> 0 . DP=27;I16=11,15,0,0,971,36863,0,0,1258,66538,0,0,464,10266,0,0;QS=3,0;MQSB=0.017008;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,193:8:0 0,21,189:7:0 +17 300 . A <*> 0 . DP=27;I16=11,15,0,0,1001,39455,0,0,1258,66538,0,0,469,10437,0,0;QS=3,0;MQSB=0.017008;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,204:8:0 0,21,210:7:0 +17 301 . G <*> 0 . DP=25;I16=10,14,0,0,928,36116,0,0,1169,62097,0,0,476,10632,0,0;QS=3,0;MQSB=0.0310726;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,195:7:0 0,21,196:7:0 +17 302 . T <*> 0 . DP=25;I16=10,14,0,0,879,32885,0,0,1169,62097,0,0,483,10849,0,0;QS=3,0;MQSB=0.0310726;MQ0F=0 PL:DP:DV 0,30,231:10:0 0,21,172:7:0 0,21,202:7:0 +17 302 . T TA 0 . INDEL;IDV=7;IMF=1;DP=25;I16=2,4,8,11,214,7674,793,33369,236,10564,993,55133,109,2229,377,8629;QS=0.511212,2.48879;VDB=0.27613;SGB=-4.22417;MQSB=0.0443614;MQ0F=0 PL:DP:DV 167,0,96:11:6 157,0,9:7:6 201,21,0:7:7 +17 303 . G <*> 0 . DP=25;I16=10,15,0,0,976,38516,0,0,1229,65697,0,0,497,11181,0,0;QS=3,0;MQSB=0.0443614;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,197:7:0 0,21,195:7:0 +17 304 . C <*> 0 . DP=27;I16=11,16,0,0,991,37005,0,0,1318,70138,0,0,503,11359,0,0;QS=3,0;MQSB=0.129164;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,206:8:0 0,24,200:8:0 +17 305 . C <*> 0 . DP=27;I16=11,16,0,0,1057,41761,0,0,1318,70138,0,0,510,11508,0,0;QS=3,0;MQSB=0.129164;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,213:8:0 0,24,211:8:0 +17 306 . T <*> 0 . DP=27;I16=11,16,0,0,1033,40253,0,0,1318,70138,0,0,517,11679,0,0;QS=3,0;MQSB=0.129164;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,207:8:0 0,24,217:8:0 +17 307 . G <*> 0 . DP=27;I16=11,15,0,0,984,37886,0,0,1289,69297,0,0,498,11198,0,0;QS=3,0;MQSB=0.174566;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,189:7:0 0,24,203:8:0 +17 308 . C <*> 0 . DP=27;I16=11,16,0,0,892,30810,0,0,1318,70138,0,0,529,11991,0,0;QS=3,0;MQSB=0.129164;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,178:8:0 0,24,185:8:0 +17 309 . G <*> 0 . DP=27;I16=11,16,0,0,951,34599,0,0,1318,70138,0,0,535,12183,0,0;QS=3,0;MQSB=0.129164;MQ0F=0 PL:DP:DV 0,33,243:11:0 0,24,183:8:0 0,24,205:8:0 +17 310 . A <*> 0 . DP=27;I16=11,16,0,0,1001,38063,0,0,1318,70138,0,0,540,12350,0,0;QS=3,0;MQSB=0.129164;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,200:8:0 0,24,217:8:0 +17 311 . C <*> 0 . DP=27;I16=11,16,0,0,1037,40263,0,0,1318,70138,0,0,544,12492,0,0;QS=3,0;MQSB=0.129164;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,215:8:0 0,24,210:8:0 +17 312 . A <*> 0 . DP=26;I16=10,16,0,0,985,38043,0,0,1258,66538,0,0,549,12657,0,0;QS=3,0;MQSB=0.157183;MQ0F=0 PL:DP:DV 0,30,237:10:0 0,24,215:8:0 0,24,218:8:0 +17 313 . A <*> 0 . DP=26;I16=10,16,0,0,983,37969,0,0,1258,66538,0,0,551,12695,0,0;QS=3,0;MQSB=0.157183;MQ0F=0 PL:DP:DV 0,30,235:10:0 0,24,219:8:0 0,24,215:8:0 +17 314 . A <*> 0 . DP=27;I16=10,17,0,0,1050,41798,0,0,1318,70138,0,0,553,12757,0,0;QS=3,0;MQSB=0.195223;MQ0F=0 PL:DP:DV 0,33,250:11:0 0,24,217:8:0 0,24,227:8:0 +17 315 . G <*> 0 . DP=26;I16=10,16,0,0,1025,40941,0,0,1289,69297,0,0,557,12843,0,0;QS=3,0;MQSB=0.252051;MQ0F=0 PL:DP:DV 0,30,252:10:0 0,24,216:8:0 0,24,225:8:0 +17 316 . C <*> 0 . DP=27;I16=10,15,0,0,983,39393,0,0,1252,67928,0,0,535,12277,0,0;QS=3,0;MQSB=0.312403;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,183:7:0 0,24,224:8:0 +17 317 . T <*> 0 . DP=27;I16=10,16,0,0,1028,41392,0,0,1320,72056,0,0,547,12557,0,0;QS=3,0;MQSB=0.377061;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,24,230:8:0 0,24,206:8:0 +17 318 . G <*> 0 . DP=27;I16=10,17,0,0,1038,40546,0,0,1349,72897,0,0,570,13018,0,0;QS=3,0;MQSB=0.297797;MQ0F=0 PL:DP:DV 0,30,249:10:0 0,27,235:9:0 0,24,208:8:0 +17 319 . A <*> 0 . DP=27;I16=9,17,0,0,994,38654,0,0,1289,69297,0,0,560,12906,0,0;QS=3,0;MQSB=0.346864;MQ0F=0 PL:DP:DV 0,30,249:10:0 0,27,228:9:0 0,21,185:7:0 +17 320 . A <*> 0 . DP=27;I16=10,17,0,0,1022,39418,0,0,1349,72897,0,0,573,13053,0,0;QS=3,0;MQSB=0.297797;MQ0F=0 PL:DP:DV 0,30,247:10:0 0,27,230:9:0 0,24,211:8:0 +17 321 . T <*> 0 . DP=27;I16=10,17,0,0,1026,39772,0,0,1349,72897,0,0,573,13029,0,0;QS=3,0;MQSB=0.297797;MQ0F=0 PL:DP:DV 0,30,253:10:0 0,27,214:9:0 0,24,218:8:0 +17 322 . G <*> 0 . DP=28;I16=10,18,0,0,1091,43151,0,0,1409,76497,0,0,573,13029,0,0;QS=3,0;MQSB=0.343265;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,27,226:9:0 0,27,223:9:0 +17 323 . C <*> 0 . DP=28;I16=9,18,0,0,1067,42619,0,0,1349,72897,0,0,565,12939,0,0;QS=3,0;MQSB=0.394987;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,27,225:9:0 0,24,198:8:0 +17 324 . T <*> 0 . DP=30;I16=12,18,0,0,1145,44221,0,0,1529,83697,0,0,573,13001,0,0;QS=3,0;MQSB=0.264959;MQ0F=0 PL:DP:DV 0,30,253:10:0 0,27,237:9:0 0,33,255:11:0 +17 325 . A <*> 0 . DP=31;I16=13,18,0,0,1132,42058,0,0,1589,87297,0,0,573,12925,0,0;QS=3,0;MQSB=0.235201;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,208:9:0 0,33,255:11:0 +17 326 . T <*> 0 . DP=31;I16=13,18,0,0,1157,44193,0,0,1589,87297,0,0,574,12878,0,0;QS=3,0;MQSB=0.235201;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,216:9:0 0,33,255:11:0 +17 327 . C <*> 0 . DP=31;I16=13,18,0,0,1147,43895,0,0,1589,87297,0,0,575,12861,0,0;QS=3,0;MQSB=0.235201;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,198:9:0 0,33,255:11:0 +17 328 . A <*> 0 . DP=31;I16=13,18,0,0,1167,44531,0,0,1589,87297,0,0,574,12776,0,0;QS=3,0;MQSB=0.235201;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,226:9:0 0,33,255:11:0 +17 329 . T <*> 0 . DP=31;I16=13,18,0,0,1210,47742,0,0,1589,87297,0,0,572,12676,0,0;QS=3,0;MQSB=0.235201;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,237:9:0 0,33,255:11:0 +17 330 . T <*> 0 . DP=31;I16=13,18,0,0,1185,45839,0,0,1589,87297,0,0,568,12510,0,0;QS=3,0;MQSB=0.235201;MQ0F=0 PL:DP:DV 0,33,254:11:0 0,27,231:9:0 0,33,255:11:0 +17 331 . T <*> 0 . DP=32;I16=14,18,0,0,1154,42510,0,0,1649,90897,0,0,563,12327,0,0;QS=3,0;MQSB=0.210122;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,222:9:0 0,36,255:12:0 +17 332 . A <*> 0 . DP=32;I16=14,18,0,0,1156,42666,0,0,1649,90897,0,0,560,12178,0,0;QS=3,0;MQSB=0.210122;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,214:9:0 0,33,255:11:0 +17 333 . A <*> 0 . DP=32;I16=14,18,0,0,1141,41987,0,0,1649,90897,0,0,558,12064,0,0;QS=3,0;MQSB=0.210122;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,223:9:0 0,33,255:11:0 +17 334 . A <*> 0 . DP=32;I16=14,18,0,0,1162,43328,0,0,1649,90897,0,0,556,11986,0,0;QS=3,0;MQSB=0.210122;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,27,221:9:0 0,33,255:11:0 +17 335 . A <*> 0 . DP=32;I16=12,18,0,0,1077,40287,0,0,1529,83697,0,0,552,11934,0,0;QS=3,0;MQSB=0.264959;MQ0F=0 PL:DP:DV 0,30,250:10:0 0,27,219:9:0 0,33,251:11:0 +17 336 . A <*> 0 . DP=32;I16=14,17,0,0,1088,39758,0,0,1612,89528,0,0,536,11574,0,0;QS=3,0;MQSB=0.274662;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,211:8:0 0,36,255:12:0 +17 337 . C <*> 0 . DP=32;I16=13,17,0,0,1115,42381,0,0,1552,85928,0,0,531,11565,0,0;QS=3,0;MQSB=0.301511;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,24,202:8:0 0,36,255:12:0 +17 338 . T <*> 0 . DP=30;I16=14,16,0,0,1191,47979,0,0,1560,86456,0,0,554,11878,0,0;QS=3,0;MQSB=0.242376;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,24,226:8:0 0,36,255:12:0 +17 339 . C <*> 0 . DP=31;I16=14,17,0,0,1130,43210,0,0,1589,87297,0,0,554,11874,0,0;QS=3,0;MQSB=0.175471;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,185:8:0 0,36,255:12:0 +17 340 . C <*> 0 . DP=31;I16=14,17,0,0,1196,47044,0,0,1589,87297,0,0,554,11852,0,0;QS=3,0;MQSB=0.175471;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,221:8:0 0,36,255:12:0 +17 341 . T <*> 0 . DP=31;I16=14,17,0,0,1227,48995,0,0,1589,87297,0,0,554,11862,0,0;QS=3,0;MQSB=0.175471;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,216:8:0 0,36,255:12:0 +17 342 . T <*> 0 . DP=31;I16=14,17,0,0,1162,43942,0,0,1589,87297,0,0,554,11904,0,0;QS=3,0;MQSB=0.175471;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,210:8:0 0,36,255:12:0 +17 343 . G <*> 0 . DP=32;I16=14,17,0,0,1150,43702,0,0,1620,90056,0,0,550,11962,0,0;QS=3,0;MQSB=0.283511;MQ0F=0 PL:DP:DV 0,30,249:10:0 0,27,218:9:0 0,36,255:12:0 +17 344 . C <*> 0 . DP=32;I16=14,18,0,0,1181,45169,0,0,1649,90897,0,0,554,12036,0,0;QS=3,0;MQSB=0.210122;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,217:9:0 0,36,255:12:0 +17 345 . T <*> 0 . DP=31;I16=14,17,0,0,1205,47259,0,0,1589,87297,0,0,555,12129,0,0;QS=3,0;MQSB=0.175471;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,221:8:0 0,36,255:12:0 +17 346 . G <*> 0 . DP=31;I16=15,16,0,0,1147,43597,0,0,1620,90056,0,0,557,12255,0,0;QS=3,0;MQSB=0.220358;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,212:8:0 0,36,255:12:0 +17 347 . G <*> 0 . DP=31;I16=14,16,0,0,1119,42227,0,0,1560,86456,0,0,545,12189,0,0;QS=3,0;MQSB=0.242376;MQ0F=0 PL:DP:DV 0,30,251:10:0 0,24,207:8:0 0,36,255:12:0 +17 348 . T <*> 0 . DP=32;I16=15,16,0,0,1145,43007,0,0,1620,90056,0,0,546,12300,0,0;QS=3,0;MQSB=0.220358;MQ0F=0 PL:DP:DV 0,30,243:10:0 0,27,228:9:0 0,36,255:12:0 +17 349 . T <*> 0 . DP=32;I16=16,16,0,0,1194,45350,0,0,1680,93656,0,0,565,12731,0,0;QS=3,0;MQSB=0.201402;MQ0F=0 PL:DP:DV 0,33,246:11:0 0,27,230:9:0 0,36,255:12:0 +17 350 . T <*> 0 . DP=31;I16=16,15,0,0,1142,43072,0,0,1651,92815,0,0,567,12837,0,0;QS=3,0;MQSB=0.286505;MQ0F=0 PL:DP:DV 0,33,249:11:0 0,27,230:9:0 0,33,255:11:0 +17 351 . G <*> 0 . DP=31;I16=16,15,0,0,1146,43750,0,0,1651,92815,0,0,568,12920,0,0;QS=3,0;MQSB=0.286505;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,27,212:9:0 0,33,255:11:0 +17 352 . A <*> 0 . DP=31;I16=16,14,0,0,1150,45520,0,0,1591,89215,0,0,544,12404,0,0;QS=3,0;MQSB=0.242376;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,224:8:0 0,33,255:11:0 +17 353 . G <*> 0 . DP=29;I16=15,14,0,0,1109,43095,0,0,1562,88374,0,0,570,13064,0,0;QS=3,0;MQSB=0.424373;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,27,231:9:0 0,30,255:10:0 +17 354 . A <*> 0 . DP=28;I16=14,14,0,0,1078,42938,0,0,1502,84774,0,0,571,13075,0,0;QS=3,0;MQSB=0.450096;MQ0F=0 PL:DP:DV 0,27,225:9:0 0,27,244:9:0 0,30,255:10:0 +17 355 . G T,<*> 0 . DP=28;I16=14,13,0,1,1001,37907,41,1681,1442,81174,60,3600,547,12487,25,625;QS=2.875,0.125,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.450096;BQB=1;MQ0F=0 PL:DP:DV 14,0,200,38,203,231:9:1 0,27,222,27,222,222:9:0 0,30,255,30,255,255:10:0 +17 356 . G <*> 0 . DP=27;I16=14,13,0,0,993,37481,0,0,1465,83405,0,0,574,13174,0,0;QS=3,0;MQSB=0.580277;MQ0F=0 PL:DP:DV 0,27,228:9:0 0,24,201:8:0 0,30,255:10:0 +17 357 . C <*> 0 . DP=28;I16=14,13,0,0,1021,39471,0,0,1465,83405,0,0,550,12584,0,0;QS=3,0;MQSB=0.580277;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,24,205:8:0 0,27,251:9:0 +17 358 . A <*> 0 . DP=28;I16=15,13,0,0,1050,40518,0,0,1525,87005,0,0,576,13216,0,0;QS=3,0;MQSB=0.556581;MQ0F=0 PL:DP:DV 0,30,254:10:0 0,24,197:8:0 0,30,255:10:0 +17 359 . G <*> 0 . DP=29;I16=15,13,0,0,1085,42761,0,0,1525,87005,0,0,552,12620,0,0;QS=3,0;MQSB=0.556581;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,21,187:7:0 0,33,255:11:0 +17 360 . A <*> 0 . DP=29;I16=15,14,0,0,1111,43259,0,0,1585,90605,0,0,579,13297,0,0;QS=3,0;MQSB=0.604224;MQ0F=0 PL:DP:DV 0,30,252:10:0 0,24,220:8:0 0,33,255:11:0 +17 361 . A <*> 0 . DP=29;I16=15,14,0,0,1116,43442,0,0,1585,90605,0,0,579,13273,0,0;QS=3,0;MQSB=0.604224;MQ0F=0 PL:DP:DV 0,30,252:10:0 0,24,219:8:0 0,33,255:11:0 +17 362 . A <*> 0 . DP=29;I16=16,13,0,0,1104,42700,0,0,1585,90605,0,0,580,13272,0,0;QS=3,0;MQSB=0.535133;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,218:8:0 0,30,255:10:0 +17 363 . A <*> 0 . DP=29;I16=16,13,0,0,1087,41437,0,0,1585,90605,0,0,581,13245,0,0;QS=3,0;MQSB=0.535133;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,213:8:0 0,30,255:10:0 +17 364 . T <*> 0 . DP=29;I16=16,13,0,0,1032,37960,0,0,1585,90605,0,0,582,13244,0,0;QS=3,0;MQSB=0.535133;MQ0F=0 PL:DP:DV 0,33,250:11:0 0,24,205:8:0 0,30,255:10:0 +17 365 . G <*> 0 . DP=29;I16=16,13,0,0,1105,43079,0,0,1585,90605,0,0,582,13218,0,0;QS=3,0;MQSB=0.535133;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,211:8:0 0,30,255:10:0 +17 366 . A <*> 0 . DP=29;I16=16,13,0,0,1090,41562,0,0,1585,90605,0,0,581,13167,0,0;QS=3,0;MQSB=0.535133;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,211:8:0 0,30,255:10:0 +17 367 . T <*> 0 . DP=29;I16=16,13,0,0,1055,39149,0,0,1585,90605,0,0,579,13093,0,0;QS=3,0;MQSB=0.535133;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,204:8:0 0,30,255:10:0 +17 368 . A <*> 0 . DP=29;I16=16,13,0,0,1054,39632,0,0,1585,90605,0,0,576,12998,0,0;QS=3,0;MQSB=0.535133;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,208:8:0 0,30,255:10:0 +17 369 . T <*> 0 . DP=28;I16=16,11,0,0,1037,40275,0,0,1496,86164,0,0,548,12256,0,0;QS=3,0;MQSB=0.659218;MQ0F=0 PL:DP:DV 0,30,250:10:0 0,21,196:7:0 0,30,255:10:0 +17 370 . C <*> 0 . DP=28;I16=16,12,0,0,1045,40219,0,0,1556,89764,0,0,570,12790,0,0;QS=3,0;MQSB=0.705296;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,24,201:8:0 0,30,255:10:0 +17 371 . T <*> 0 . DP=29;I16=16,13,0,0,1155,46591,0,0,1616,93364,0,0,567,12725,0,0;QS=3,0;MQSB=0.744925;MQ0F=0 PL:DP:DV 0,30,255:10:0 0,24,227:8:0 0,33,255:11:0 +17 372 . C <*> 0 . DP=30;I16=16,14,0,0,1139,44019,0,0,1676,96964,0,0,564,12636,0,0;QS=3,0;MQSB=0.779025;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,215:8:0 0,33,255:11:0 +17 373 . A <*> 0 . DP=30;I16=16,14,0,0,1142,44118,0,0,1676,96964,0,0,561,12525,0,0;QS=3,0;MQSB=0.779025;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,220:8:0 0,33,255:11:0 +17 374 . T <*> 0 . DP=30;I16=16,14,0,0,1098,41180,0,0,1676,96964,0,0,556,12344,0,0;QS=3,0;MQSB=0.779025;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,221:8:0 0,33,255:11:0 +17 375 . A T,<*> 0 . DP=31;I16=17,13,0,1,1138,43798,14,196,1676,96964,60,3600,547,12177,4,16;QS=2.9661,0.0338983,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.763662;BQB=1;MQ0F=0 PL:DP:DV 0,36,255,36,255,255:12:0 0,24,218,24,218,218:8:0 0,18,255,30,255,255:11:1 +17 376 . G <*> 0 . DP=31;I16=17,14,0,0,1131,42581,0,0,1736,100564,0,0,547,12073,0,0;QS=3,0;MQSB=0.763662;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,24,220:8:0 0,33,255:11:0 +17 377 . T <*> 0 . DP=31;I16=16,14,0,0,1105,41629,0,0,1676,96964,0,0,518,11360,0,0;QS=3,0;MQSB=0.779025;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,24,211:8:0 0,33,255:11:0 +17 378 . T <*> 0 . DP=30;I16=18,12,0,0,1098,41066,0,0,1707,99723,0,0,541,11927,0,0;QS=3,0;MQSB=0.878946;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,186:7:0 0,30,255:10:0 +17 379 . G <*> 0 . DP=29;I16=18,10,0,0,1053,40181,0,0,1618,95282,0,0,534,11848,0,0;QS=3,0;MQSB=0.981777;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,187:7:0 0,30,255:10:0 +17 380 . C <*> 0 . DP=29;I16=18,10,0,0,1087,42743,0,0,1618,95282,0,0,514,11172,0,0;QS=3,0;MQSB=0.981777;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,177:6:0 0,30,255:10:0 +17 381 . T <*> 0 . DP=29;I16=18,11,0,0,1168,47412,0,0,1678,98882,0,0,537,11729,0,0;QS=3,0;MQSB=0.987702;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,21,212:7:0 0,30,255:10:0 +17 382 . T <*> 0 . DP=29;I16=17,11,0,0,1054,40450,0,0,1618,95282,0,0,510,11068,0,0;QS=3,0;MQSB=0.990092;MQ0F=0 PL:DP:DV 0,33,255:11:0 0,21,182:7:0 0,30,255:10:0 +17 383 . T <*> 0 . DP=29;I16=18,10,0,0,1052,39798,0,0,1618,95282,0,0,507,11013,0,0;QS=3,0;MQSB=0.981777;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,18,165:6:0 0,30,255:10:0 +17 384 . A <*> 0 . DP=31;I16=19,11,0,0,1077,39885,0,0,1738,102482,0,0,504,10988,0,0;QS=3,0;MQSB=0.985292;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,176:7:0 0,30,255:10:0 +17 385 . C <*> 0 . DP=31;I16=19,12,0,0,1118,41180,0,0,1798,106082,0,0,527,11569,0,0;QS=3,0;MQSB=0.989977;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,24,186:8:0 0,30,255:10:0 +17 386 . T <*> 0 . DP=30;I16=18,12,0,0,1158,45592,0,0,1738,102482,0,0,526,11556,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,191:7:0 0,30,255:10:0 +17 387 . T <*> 0 . DP=30;I16=18,12,0,0,1105,41821,0,0,1738,102482,0,0,525,11573,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,21,187:7:0 0,30,255:10:0 +17 388 . T <*> 0 . DP=29;I16=17,12,0,0,1089,41577,0,0,1678,98882,0,0,523,11519,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,180:6:0 0,30,255:10:0 +17 389 . G <*> 0 . DP=29;I16=17,12,0,0,1067,40095,0,0,1678,98882,0,0,520,11444,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,171:6:0 0,30,255:10:0 +17 390 . C <*> 0 . DP=29;I16=17,12,0,0,1071,40423,0,0,1678,98882,0,0,517,11399,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,162:6:0 0,30,255:10:0 +17 391 . A <*> 0 . DP=29;I16=18,11,0,0,1091,41603,0,0,1647,96123,0,0,515,11383,0,0;QS=3,0;MQSB=0.995968;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,18,163:6:0 0,30,255:10:0 +17 392 . T <*> 0 . DP=29;I16=18,11,0,0,1046,38838,0,0,1647,96123,0,0,515,11395,0,0;QS=3,0;MQSB=0.995968;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,153:5:0 0,33,255:11:0 +17 393 . A <*> 0 . DP=28;I16=17,11,0,0,1014,37582,0,0,1587,92523,0,0,517,11435,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,133:5:0 0,33,255:11:0 +17 394 . T <*> 0 . DP=28;I16=17,11,0,0,1022,38342,0,0,1587,92523,0,0,519,11503,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,141:5:0 0,33,255:11:0 +17 395 . T <*> 0 . DP=28;I16=17,11,0,0,1060,40596,0,0,1587,92523,0,0,521,11599,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,164:5:0 0,33,255:11:0 +17 396 . T <*> 0 . DP=28;I16=17,11,0,0,1032,39228,0,0,1587,92523,0,0,523,11723,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,158:5:0 0,33,255:11:0 +17 397 . T <*> 0 . DP=28;I16=17,11,0,0,1046,39510,0,0,1587,92523,0,0,524,11824,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:DV 0,36,255:12:0 0,15,149:5:0 0,33,255:11:0 +17 398 . A <*> 0 . DP=28;I16=17,11,0,0,1021,38105,0,0,1587,92523,0,0,524,11850,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,144:5:0 0,30,255:10:0 +17 399 . A <*> 0 . DP=28;I16=17,11,0,0,1015,38469,0,0,1587,92523,0,0,526,11900,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,140:5:0 0,30,255:10:0 +17 400 . A <*> 0 . DP=29;I16=17,12,0,0,1056,39702,0,0,1647,96123,0,0,526,11828,0,0;QS=3,0;MQSB=0.988062;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,159:5:0 0,33,255:11:0 +17 401 . A <*> 0 . DP=29;I16=17,11,0,0,1052,40302,0,0,1587,92523,0,0,501,11113,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,160:5:0 0,30,255:10:0 +17 402 . T <*> 0 . DP=29;I16=17,12,0,0,1082,41232,0,0,1647,96123,0,0,526,11680,0,0;QS=3,0;MQSB=0.988062;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,149:5:0 0,33,255:11:0 +17 403 . T <*> 0 . DP=29;I16=17,12,0,0,1085,40985,0,0,1647,96123,0,0,526,11654,0,0;QS=3,0;MQSB=0.988062;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,148:5:0 0,33,255:11:0 +17 404 . G <*> 0 . DP=29;I16=17,12,0,0,1074,40524,0,0,1647,96123,0,0,525,11609,0,0;QS=3,0;MQSB=0.988062;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,15,131:5:0 0,33,255:11:0 +17 405 . T <*> 0 . DP=27;I16=16,10,0,0,988,37870,0,0,1498,88082,0,0,519,11543,0,0;QS=3,0;MQSB=0.987578;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,9,103:3:0 0,30,255:10:0 +17 406 . G <*> 0 . DP=27;I16=16,11,0,0,976,36752,0,0,1558,91682,0,0,527,11601,0,0;QS=3,0;MQSB=0.992419;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,125:4:0 0,30,247:10:0 +17 407 . A <*> 0 . DP=27;I16=16,11,0,0,1007,38355,0,0,1558,91682,0,0,526,11538,0,0;QS=3,0;MQSB=0.992419;MQ0F=0 PL:DP:DV 0,39,255:13:0 0,12,125:4:0 0,30,255:10:0 +17 408 . C <*> 0 . DP=28;I16=16,11,0,0,1006,38136,0,0,1558,91682,0,0,521,11489,0,0;QS=3,0;MQSB=0.992419;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,110:3:0 0,30,244:10:0 +17 409 . T <*> 0 . DP=29;I16=17,12,0,0,1100,42734,0,0,1678,98882,0,0,525,11503,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,131:4:0 0,33,255:11:0 +17 410 . T <*> 0 . DP=29;I16=17,12,0,0,1035,38325,0,0,1678,98882,0,0,524,11432,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,12,125:4:0 0,33,255:11:0 +17 411 . T <*> 0 . DP=29;I16=17,10,0,0,1003,37747,0,0,1558,91682,0,0,496,10716,0,0;QS=3,0;MQSB=0.984677;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,104:3:0 0,30,255:10:0 +17 412 . C T,<*> 0 . DP=30;I16=17,12,1,0,1094,42458,14,196,1678,98882,60,3600,495,10659,25,625;QS=2.97455,0.0254545,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.991968;BQB=1;MQ0F=0 PL:DP:DV 0,30,255,42,255,255:15:1 0,12,124,12,124,124:4:0 0,33,255,33,255,255:11:0 +17 413 . A <*> 0 . DP=31;I16=18,13,0,0,1189,45985,0,0,1798,106082,0,0,520,11258,0,0;QS=3,0;MQSB=0.995005;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,9,102:3:0 0,33,255:11:0 +17 414 . T <*> 0 . DP=30;I16=18,12,0,0,1151,44355,0,0,1738,102482,0,0,523,11265,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,109:3:0 0,33,255:11:0 +17 415 . G <*> 0 . DP=30;I16=18,12,0,0,1131,43175,0,0,1738,102482,0,0,526,11306,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,110:3:0 0,33,255:11:0 +17 416 . G <*> 0 . DP=30;I16=17,12,0,0,1083,41273,0,0,1678,98882,0,0,514,11156,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,114:3:0 0,30,253:10:0 +17 417 . C <*> 0 . DP=30;I16=18,12,0,0,1114,42244,0,0,1738,102482,0,0,531,11439,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,108:3:0 0,33,255:11:0 +17 418 . A <*> 0 . DP=30;I16=18,12,0,0,1146,44248,0,0,1738,102482,0,0,532,11478,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,111:3:0 0,33,255:11:0 +17 419 . T <*> 0 . DP=30;I16=18,12,0,0,1117,42327,0,0,1738,102482,0,0,532,11498,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,112:3:0 0,33,255:11:0 +17 420 . A <*> 0 . DP=31;I16=18,13,0,0,1117,41011,0,0,1798,106082,0,0,532,11550,0,0;QS=3,0;MQSB=0.995005;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,108:3:0 0,36,255:12:0 +17 421 . A <*> 0 . DP=33;I16=19,14,0,0,1208,45398,0,0,1887,110523,0,0,533,11635,0,0;QS=3,0;MQSB=0.986656;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,113:3:0 0,42,255:14:0 +17 422 . A <*> 0 . DP=33;I16=19,13,0,0,1205,46441,0,0,1827,106923,0,0,510,11082,0,0;QS=3,0;MQSB=0.991023;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,116:3:0 0,39,255:13:0 +17 423 . T <*> 0 . DP=32;I16=19,13,0,0,1202,45416,0,0,1827,106923,0,0,538,11818,0,0;QS=3,0;MQSB=0.991023;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,110:3:0 0,39,255:13:0 +17 424 . A <*> 0 . DP=32;I16=19,13,0,0,1147,41685,0,0,1827,106923,0,0,539,11867,0,0;QS=3,0;MQSB=0.991023;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,106:3:0 0,39,255:13:0 +17 425 . A <*> 0 . DP=29;I16=16,13,0,0,1070,40616,0,0,1647,96123,0,0,542,11900,0,0;QS=3,0;MQSB=0.976248;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,111:3:0 0,33,249:11:0 +17 426 . T <*> 0 . DP=29;I16=16,12,0,0,997,36561,0,0,1587,92523,0,0,519,11287,0,0;QS=3,0;MQSB=0.982906;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,105:3:0 0,30,225:10:0 +17 427 . A <*> 0 . DP=29;I16=16,13,0,0,1024,37266,0,0,1647,96123,0,0,546,11952,0,0;QS=3,0;MQSB=0.976248;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,111:3:0 0,33,242:11:0 +17 428 . C <*> 0 . DP=29;I16=16,13,0,0,1064,39706,0,0,1647,96123,0,0,548,12020,0,0;QS=3,0;MQSB=0.976248;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,111:3:0 0,33,254:11:0 +17 429 . T <*> 0 . DP=30;I16=16,14,0,0,1150,44918,0,0,1707,99723,0,0,549,12067,0,0;QS=3,0;MQSB=0.969373;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,115:3:0 0,33,255:11:0 +17 430 . G <*> 0 . DP=30;I16=16,14,0,0,1113,42443,0,0,1707,99723,0,0,551,12145,0,0;QS=3,0;MQSB=0.969373;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,112:3:0 0,33,246:11:0 +17 431 . G <*> 0 . DP=30;I16=14,14,0,0,1003,36953,0,0,1587,92523,0,0,553,12255,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,101:3:0 0,30,225:10:0 +17 432 . T <*> 0 . DP=28;I16=14,14,0,0,1049,39621,0,0,1587,92523,0,0,556,12346,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,114:3:0 0,30,255:10:0 +17 433 . T <*> 0 . DP=28;I16=14,12,0,0,949,35443,0,0,1467,85323,0,0,509,11217,0,0;QS=3,0;MQSB=0.967472;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,9,112:3:0 0,27,227:9:0 +17 434 . T <*> 0 . DP=29;I16=15,14,0,0,1036,37654,0,0,1647,96123,0,0,561,12567,0,0;QS=3,0;MQSB=0.960561;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,98:3:0 0,30,243:10:0 +17 435 . A <*> 0 . DP=29;I16=15,13,0,0,1024,37970,0,0,1587,92523,0,0,556,12560,0,0;QS=3,0;MQSB=0.968414;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,9,103:3:0 0,30,237:10:0 +17 436 . T <*> 0 . DP=28;I16=14,14,0,0,998,36220,0,0,1587,92523,0,0,564,12654,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,110:3:0 0,27,223:9:0 +17 437 . T <*> 0 . DP=28;I16=13,14,0,0,990,36832,0,0,1558,91682,0,0,549,12435,0,0;QS=3,0;MQSB=0.999706;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,109:3:0 0,24,207:8:0 +17 438 . A <*> 0 . DP=28;I16=14,13,0,0,972,35640,0,0,1527,88923,0,0,540,12082,0,0;QS=3,0;MQSB=0.9585;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,107:3:0 0,24,216:8:0 +17 439 . C <*> 0 . DP=28;I16=14,14,0,0,1055,40273,0,0,1587,92523,0,0,563,12649,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,107:3:0 0,27,224:9:0 +17 440 . A <*> 0 . DP=28;I16=14,14,0,0,1095,43251,0,0,1587,92523,0,0,561,12615,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,115:3:0 0,27,247:9:0 +17 441 . G <*> 0 . DP=29;I16=15,14,0,0,1068,40344,0,0,1647,96123,0,0,559,12605,0,0;QS=3,0;MQSB=0.960561;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,9,104:3:0 0,27,198:9:0 +17 442 . A <*> 0 . DP=29;I16=15,14,0,0,1091,41507,0,0,1647,96123,0,0,558,12620,0,0;QS=3,0;MQSB=0.960561;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,9,112:3:0 0,27,233:9:0 +17 443 . A <*> 0 . DP=30;I16=15,14,0,0,1173,49439,0,0,1647,96123,0,0,557,12661,0,0;QS=3,0;MQSB=0.960561;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,9,129:3:0 0,27,246:9:0 +17 444 . G <*> 0 . DP=29;I16=15,13,0,0,1095,44661,0,0,1587,92523,0,0,557,12727,0,0;QS=3,0;MQSB=0.968414;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,6,91:2:0 0,27,227:9:0 +17 445 . C <*> 0 . DP=30;I16=16,13,0,0,1100,43706,0,0,1647,96123,0,0,557,12817,0,0;QS=3,0;MQSB=0.976248;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,9,111:3:0 0,27,219:9:0 +17 446 . A <*> 0 . DP=30;I16=16,13,0,0,1107,44265,0,0,1647,96123,0,0,557,12881,0,0;QS=3,0;MQSB=0.976248;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,9,115:3:0 0,27,232:9:0 +17 447 . C <*> 0 . DP=29;I16=16,12,0,0,1108,45364,0,0,1618,95282,0,0,555,12817,0,0;QS=3,0;MQSB=0.856268;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,114:3:0 0,27,235:9:0 +17 448 . T <*> 0 . DP=29;I16=16,12,0,0,1125,47237,0,0,1618,95282,0,0,553,12773,0,0;QS=3,0;MQSB=0.856268;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,118:3:0 0,27,240:9:0 +17 449 . A <*> 0 . DP=28;I16=15,12,0,0,1091,45981,0,0,1558,91682,0,0,552,12748,0,0;QS=3,0;MQSB=0.84246;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,90:2:0 0,27,245:9:0 +17 450 . G <*> 0 . DP=28;I16=15,12,0,0,1069,44603,0,0,1558,91682,0,0,551,12741,0,0;QS=3,0;MQSB=0.84246;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,91:2:0 0,27,233:9:0 +17 451 . A <*> 0 . DP=28;I16=15,12,0,0,1021,41371,0,0,1558,91682,0,0,550,12752,0,0;QS=3,0;MQSB=0.84246;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,6,93:2:0 0,27,244:9:0 +17 452 . A <*> 0 . DP=31;I16=18,11,0,0,1079,43353,0,0,1678,98882,0,0,530,12420,0,0;QS=3,0;MQSB=0.884952;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,9,110:3:0 0,24,225:8:0 +17 453 . A <*> 0 . DP=31;I16=17,11,0,0,1037,41069,0,0,1649,98041,0,0,508,11882,0,0;QS=3,0;MQSB=0.967085;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,9,111:3:0 0,21,221:7:0 +17 454 . A <*> 0 . DP=31;I16=18,12,0,0,1158,47028,0,0,1738,102482,0,0,554,12904,0,0;QS=3,0;MQSB=0.878946;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,9,113:3:0 0,30,255:10:0 +17 455 . T <*> 0 . DP=32;I16=17,13,0,0,1148,46574,0,0,1715,100251,0,0,550,12864,0,0;QS=3,0;MQSB=0.973855;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,9,113:3:0 0,33,255:11:0 +17 456 . G <*> 0 . DP=32;I16=17,13,0,0,1161,47287,0,0,1746,103010,0,0,534,12296,0,0;QS=3,0;MQSB=0.998031;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,9,116:3:0 0,30,245:10:0 +17 457 . C <*> 0 . DP=33;I16=19,13,0,0,1218,48642,0,0,1835,107451,0,0,563,12967,0,0;QS=3,0;MQSB=0.985204;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,9,118:3:0 0,33,255:11:0 +17 458 . A <*> 0 . DP=33;I16=19,13,0,0,1226,49034,0,0,1835,107451,0,0,568,12990,0,0;QS=3,0;MQSB=0.985204;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,9,111:3:0 0,33,255:11:0 +17 459 . T <*> 0 . DP=33;I16=18,13,0,0,1167,46981,0,0,1775,103851,0,0,565,12945,0,0;QS=3,0;MQSB=0.980167;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,6,92:2:0 0,33,255:11:0 +17 460 . G <*> 0 . DP=32;I16=19,12,0,0,1219,50105,0,0,1775,103851,0,0,575,12929,0,0;QS=3,0;MQSB=0.989977;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,9,116:3:0 0,30,255:10:0 +17 461 . T <*> 0 . DP=32;I16=19,12,0,0,1213,49819,0,0,1775,103851,0,0,577,12845,0,0;QS=3,0;MQSB=0.989977;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,9,115:3:0 0,30,255:10:0 +17 462 . G <*> 0 . DP=32;I16=19,12,0,0,1190,48962,0,0,1775,103851,0,0,580,12792,0,0;QS=3,0;MQSB=0.989977;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,119:4:0 0,30,241:10:0 +17 463 . G <*> 0 . DP=32;I16=19,12,0,0,1114,44214,0,0,1775,103851,0,0,584,12770,0,0;QS=3,0;MQSB=0.989977;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,114:4:0 0,30,221:10:0 +17 464 . A <*> 0 . DP=32;I16=18,11,0,0,1100,43908,0,0,1686,99410,0,0,556,12106,0,0;QS=3,0;MQSB=0.99095;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,12,133:4:0 0,24,213:8:0 +17 465 . C <*> 0 . DP=33;I16=20,11,0,0,1191,48085,0,0,1775,103851,0,0,586,12786,0,0;QS=3,0;MQSB=0.996597;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,140:5:0 0,27,231:9:0 +17 466 . A <*> 0 . DP=34;I16=21,12,0,0,1293,53311,0,0,1895,111051,0,0,597,12897,0,0;QS=3,0;MQSB=0.995633;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,154:5:0 0,30,255:10:0 +17 467 . A <*> 0 . DP=34;I16=21,11,0,0,1256,51450,0,0,1835,107451,0,0,597,12891,0,0;QS=3,0;MQSB=0.998231;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,15,157:5:0 0,27,248:9:0 +17 468 . A <*> 0 . DP=35;I16=22,12,0,0,1274,51268,0,0,1955,114651,0,0,604,12904,0,0;QS=3,0;MQSB=0.997406;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,154:5:0 0,30,251:10:0 +17 469 . A <*> 0 . DP=35;I16=22,12,0,0,1285,52989,0,0,1955,114651,0,0,608,12940,0,0;QS=3,0;MQSB=0.997406;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,146:5:0 0,30,255:10:0 +17 470 . G <*> 0 . DP=35;I16=22,12,0,0,1281,51055,0,0,1955,114651,0,0,612,13016,0,0;QS=3,0;MQSB=0.997406;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,148:5:0 0,30,238:10:0 +17 471 . T <*> 0 . DP=36;I16=22,11,0,0,1239,49021,0,0,1918,113282,0,0,599,12825,0,0;QS=3,0;MQSB=0.915545;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,150:5:0 0,27,232:9:0 +17 472 . T <*> 0 . DP=35;I16=21,12,0,0,1245,48915,0,0,1926,113810,0,0,595,12559,0,0;QS=3,0;MQSB=0.988858;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,153:5:0 0,27,237:9:0 +17 473 . G <*> 0 . DP=35;I16=21,12,0,0,1307,53473,0,0,1926,113810,0,0,599,12651,0,0;QS=3,0;MQSB=0.988858;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,141:5:0 0,27,249:9:0 +17 474 . G <*> 0 . DP=36;I16=22,12,0,0,1284,51708,0,0,1986,117410,0,0,602,12734,0,0;QS=3,0;MQSB=0.986937;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,131:5:0 0,30,255:10:0 +17 475 . G <*> 0 . DP=36;I16=23,12,0,0,1311,51609,0,0,2015,118251,0,0,631,13485,0,0;QS=3,0;MQSB=0.998642;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,141:5:0 0,33,252:11:0 +17 476 . A <*> 0 . DP=36;I16=23,12,0,0,1312,52078,0,0,2015,118251,0,0,634,13606,0,0;QS=3,0;MQSB=0.998642;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,157:5:0 0,33,255:11:0 +17 477 . T <*> 0 . DP=36;I16=23,12,0,0,1318,52668,0,0,2015,118251,0,0,637,13773,0,0;QS=3,0;MQSB=0.998642;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,148:5:0 0,33,255:11:0 +17 478 . T <*> 0 . DP=38;I16=25,12,0,0,1338,51774,0,0,2135,125451,0,0,637,13833,0,0;QS=3,0;MQSB=0.999868;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,18,154:6:0 0,33,255:11:0 +17 479 . A <*> 0 . DP=38;I16=25,12,0,0,1420,57788,0,0,2135,125451,0,0,639,13935,0,0;QS=3,0;MQSB=0.999868;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,18,163:6:0 0,33,255:11:0 +17 480 . G <*> 0 . DP=37;I16=25,11,0,0,1438,60172,0,0,2075,121851,0,0,641,14029,0,0;QS=3,0;MQSB=0.999853;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,165:6:0 0,33,255:11:0 +17 481 . G <*> 0 . DP=37;I16=25,11,0,0,1392,55824,0,0,2075,121851,0,0,642,14112,0,0;QS=3,0;MQSB=0.999853;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,165:6:0 0,33,255:11:0 +17 482 . A <*> 0 . DP=37;I16=24,11,0,0,1352,55134,0,0,2015,118251,0,0,618,13608,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,15,143:5:0 0,33,255:11:0 +17 483 . G <*> 0 . DP=37;I16=24,12,0,0,1417,57747,0,0,2075,121851,0,0,642,14240,0,0;QS=3,0;MQSB=0.999437;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,18,165:6:0 0,33,255:11:0 +17 484 . A <*> 0 . DP=36;I16=24,11,0,0,1340,53992,0,0,2015,118251,0,0,643,14281,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,168:6:0 0,33,255:11:0 +17 485 . G <*> 0 . DP=35;I16=23,12,0,0,1329,51411,0,0,2015,118251,0,0,669,14931,0,0;QS=3,0;MQSB=0.998642;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,160:6:0 0,33,255:11:0 +17 486 . A <*> 0 . DP=34;I16=22,12,0,0,1311,51523,0,0,1955,114651,0,0,671,14989,0,0;QS=3,0;MQSB=0.997406;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,173:6:0 0,33,255:11:0 +17 487 . G <*> 0 . DP=34;I16=22,12,0,0,1306,50760,0,0,1955,114651,0,0,672,15030,0,0;QS=3,0;MQSB=0.997406;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,169:6:0 0,33,255:11:0 +17 488 . A <*> 0 . DP=35;I16=22,12,0,0,1274,48140,0,0,1986,117410,0,0,646,14380,0,0;QS=3,0;MQSB=0.986937;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,177:6:0 0,30,255:10:0 +17 489 . A <*> 0 . DP=35;I16=23,12,0,0,1264,46916,0,0,2015,118251,0,0,671,15015,0,0;QS=3,0;MQSB=0.998642;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,175:6:0 0,33,255:11:0 +17 490 . A <*> 0 . DP=36;I16=24,12,0,0,1332,50280,0,0,2075,121851,0,0,671,15061,0,0;QS=3,0;MQSB=0.999437;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,188:7:0 0,33,255:11:0 +17 491 . T <*> 0 . DP=36;I16=24,12,0,0,1284,46802,0,0,2075,121851,0,0,671,15093,0,0;QS=3,0;MQSB=0.999437;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,178:7:0 0,33,255:11:0 +17 492 . G <*> 0 . DP=35;I16=21,12,0,0,1252,48326,0,0,1926,113810,0,0,621,13859,0,0;QS=3,0;MQSB=0.988858;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,172:6:0 0,30,251:10:0 +17 493 . A <*> 0 . DP=34;I16=22,11,0,0,1273,49481,0,0,1926,113810,0,0,650,14672,0,0;QS=3,0;MQSB=0.981935;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,186:7:0 0,24,240:8:0 +17 494 . A <*> 0 . DP=34;I16=22,12,0,0,1326,52604,0,0,1986,117410,0,0,672,15182,0,0;QS=3,0;MQSB=0.986937;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,196:7:0 0,27,255:9:0 +17 495 . G <*> 0 . DP=34;I16=21,12,0,0,1255,48577,0,0,1926,113810,0,0,647,14611,0,0;QS=3,0;MQSB=0.988858;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,168:6:0 0,27,244:9:0 +17 496 . A <*> 0 . DP=34;I16=22,12,0,0,1250,46926,0,0,1986,117410,0,0,670,15220,0,0;QS=3,0;MQSB=0.986937;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,186:7:0 0,27,249:9:0 +17 497 . C <*> 0 . DP=34;I16=22,12,0,0,1250,47006,0,0,1986,117410,0,0,665,15087,0,0;QS=3,0;MQSB=0.986937;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,164:7:0 0,27,239:9:0 +17 498 . A <*> 0 . DP=34;I16=22,12,0,0,1286,49158,0,0,1986,117410,0,0,661,14987,0,0;QS=3,0;MQSB=0.986937;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,185:7:0 0,27,252:9:0 +17 499 . T <*> 0 . DP=34;I16=23,11,0,0,1224,45284,0,0,1986,117410,0,0,659,14919,0,0;QS=3,0;MQSB=0.979712;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,183:7:0 0,30,255:10:0 +17 500 . A <*> 0 . DP=34;I16=23,11,0,0,1230,45152,0,0,1986,117410,0,0,657,14833,0,0;QS=3,0;MQSB=0.979712;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,179:7:0 0,30,255:10:0 +17 501 . T <*> 0 . DP=33;I16=23,10,0,0,1241,47167,0,0,1926,113810,0,0,656,14778,0,0;QS=3,0;MQSB=0.972757;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,186:7:0 0,27,241:9:0 +17 502 . G <*> 0 . DP=33;I16=23,10,0,0,1215,45829,0,0,1926,113810,0,0,655,14753,0,0;QS=3,0;MQSB=0.972757;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,183:7:0 0,27,235:9:0 +17 503 . T <*> 0 . DP=34;I16=23,11,0,0,1194,43366,0,0,1986,117410,0,0,654,14758,0,0;QS=3,0;MQSB=0.979712;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,177:7:0 0,27,234:9:0 +17 504 . C <*> 0 . DP=34;I16=23,11,0,0,1218,45552,0,0,1986,117410,0,0,651,14643,0,0;QS=3,0;MQSB=0.979712;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,183:7:0 0,27,219:9:0 +17 505 . C <*> 0 . DP=35;I16=23,11,0,0,1207,44321,0,0,1986,117410,0,0,641,14509,0,0;QS=3,0;MQSB=0.979712;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,189:7:0 0,27,221:9:0 +17 506 . A <*> 0 . DP=35;I16=24,11,0,0,1266,46776,0,0,2046,121010,0,0,646,14504,0,0;QS=3,0;MQSB=0.977529;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,188:7:0 0,27,231:9:0 +17 507 . C <*> 0 . DP=35;I16=23,11,0,0,1220,45016,0,0,1986,117410,0,0,635,14401,0,0;QS=3,0;MQSB=0.979712;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,183:7:0 0,27,226:9:0 +17 508 . A <*> 0 . DP=34;I16=24,10,0,0,1204,44542,0,0,1986,117410,0,0,643,14491,0,0;QS=3,0;MQSB=0.970272;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,189:7:0 0,27,220:9:0 +17 509 . C <*> 0 . DP=34;I16=24,10,0,0,1272,48272,0,0,1986,117410,0,0,640,14430,0,0;QS=3,0;MQSB=0.970272;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,186:7:0 0,27,241:9:0 +17 510 . A <*> 0 . DP=34;I16=22,11,0,0,1194,44196,0,0,1926,113810,0,0,613,13773,0,0;QS=3,0;MQSB=0.981935;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,187:7:0 0,24,221:8:0 +17 511 . A <*> 0 . DP=34;I16=23,11,0,0,1222,45562,0,0,1986,117410,0,0,637,14395,0,0;QS=3,0;MQSB=0.979712;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,195:7:0 0,24,233:8:0 +17 512 . A C,<*> 0 . DP=33;I16=22,10,0,1,1121,40793,13,169,1866,110210,60,3600,628,14340,9,81;QS=2.97719,0.022807,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.981935;BQB=1;MQ0F=0 PL:DP:DV 0,39,255,51,255,255:18:1 0,21,183,21,183,183:7:0 0,24,231,24,231,231:8:0 +17 513 . A <*> 0 . DP=32;I16=20,10,0,0,1115,42183,0,0,1746,103010,0,0,598,13624,0,0;QS=3,0;MQSB=0.980594;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,175:6:0 0,24,233:8:0 +17 514 . A T,<*> 0 . DP=32;I16=20,9,0,1,1066,40004,16,256,1686,99410,60,3600,586,13500,11,121;QS=2.97075,0.0292505,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.980594;BQB=1;MQ0F=0 PL:DP:DV 0,31,255,45,255,255:16:1 0,18,171,18,171,171:6:0 0,24,235,24,235,235:8:0 +17 515 . C <*> 0 . DP=32;I16=18,10,0,0,1010,37294,0,0,1626,95810,0,0,561,12915,0,0;QS=3,0;MQSB=0.986018;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,167:6:0 0,24,211:8:0 +17 516 . C <*> 0 . DP=32;I16=21,10,0,0,1100,40570,0,0,1806,106610,0,0,612,13954,0,0;QS=3,0;MQSB=0.977926;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,187:7:0 0,24,215:8:0 +17 517 . T <*> 0 . DP=33;I16=23,10,0,0,1269,49995,0,0,1926,113810,0,0,636,14626,0,0;QS=3,0;MQSB=0.972757;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,201:7:0 0,24,242:8:0 +17 518 . G <*> 0 . DP=34;I16=24,10,0,0,1247,46839,0,0,1986,117410,0,0,636,14696,0,0;QS=3,0;MQSB=0.970272;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,182:7:0 0,24,220:8:0 +17 519 . T <*> 0 . DP=36;I16=25,11,0,0,1283,46693,0,0,2106,124610,0,0,636,14742,0,0;QS=3,0;MQSB=0.975394;MQ0F=0 PL:DP:DV 0,63,255:21:0 0,21,177:7:0 0,24,224:8:0 +17 520 . T <*> 0 . DP=36;I16=24,11,0,0,1238,44894,0,0,2046,121010,0,0,613,14193,0,0;QS=3,0;MQSB=0.977529;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,21,180:7:0 0,24,223:8:0 +17 521 . C <*> 0 . DP=34;I16=25,9,0,0,1280,49454,0,0,1986,117410,0,0,641,14875,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,21,191:7:0 0,21,204:7:0 +17 522 . A <*> 0 . DP=32;I16=24,8,0,0,1158,43228,0,0,1897,112969,0,0,646,14960,0,0;QS=3,0;MQSB=0.872525;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,21,185:7:0 0,15,170:5:0 +17 523 . T G,<*> 0 . DP=32;I16=23,8,1,0,1184,45708,15,225,1837,109369,60,3600,626,14446,25,625;QS=2.9794,0.0206044,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.872525;BQB=1;MQ0F=0 PL:DP:DV 0,44,255,57,255,255:20:1 0,21,191,21,191,191:7:0 0,15,166,15,166,166:5:0 +17 524 . T <*> 0 . DP=32;I16=24,7,0,0,1084,39474,0,0,1837,109369,0,0,629,14483,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,21,194:7:0 0,12,140:4:0 +17 525 . G <*> 0 . DP=32;I16=24,7,0,0,1181,45669,0,0,1837,109369,0,0,631,14495,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,21,188:7:0 0,12,129:4:0 +17 526 . C <*> 0 . DP=32;I16=24,7,0,0,1146,43950,0,0,1860,111600,0,0,633,14531,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,21,185:7:0 0,12,131:4:0 +17 527 . A <*> 0 . DP=33;I16=24,8,0,0,1209,46265,0,0,1897,112969,0,0,636,14634,0,0;QS=3,0;MQSB=0.872525;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,194:7:0 0,18,181:6:0 +17 528 . G <*> 0 . DP=33;I16=24,8,0,0,1256,49824,0,0,1897,112969,0,0,634,14484,0,0;QS=3,0;MQSB=0.872525;MQ0F=0 PL:DP:DV 0,60,255:20:0 0,18,169:6:0 0,18,193:6:0 +17 529 . C <*> 0 . DP=32;I16=24,7,0,0,1148,44362,0,0,1837,109369,0,0,633,14357,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,187:7:0 0,18,184:6:0 +17 530 . T <*> 0 . DP=32;I16=25,7,0,0,1244,49168,0,0,1897,112969,0,0,657,14883,0,0;QS=3,0;MQSB=0.850154;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,196:7:0 0,18,202:6:0 +17 531 . T <*> 0 . DP=32;I16=25,7,0,0,1177,44171,0,0,1897,112969,0,0,654,14714,0,0;QS=3,0;MQSB=0.850154;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,181:7:0 0,18,193:6:0 +17 532 . T <*> 0 . DP=32;I16=24,7,0,0,1153,43543,0,0,1837,109369,0,0,630,14116,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,181:7:0 0,18,192:6:0 +17 533 . C <*> 0 . DP=32;I16=24,7,0,0,1142,43940,0,0,1837,109369,0,0,619,13649,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,178:7:0 0,18,180:6:0 +17 534 . T <*> 0 . DP=31;I16=24,6,0,0,1212,49426,0,0,1777,105769,0,0,615,13479,0,0;QS=3,0;MQSB=0.82403;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,205:7:0 0,18,205:6:0 +17 535 . A <*> 0 . DP=31;I16=24,6,0,0,1080,39870,0,0,1777,105769,0,0,611,13341,0,0;QS=3,0;MQSB=0.82403;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,194:7:0 0,18,189:6:0 +17 536 . C <*> 0 . DP=31;I16=24,7,0,0,1097,40707,0,0,1837,109369,0,0,631,13809,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,184:7:0 0,18,157:6:0 +17 537 . C <*> 0 . DP=31;I16=22,7,0,0,1034,38564,0,0,1717,102169,0,0,587,12861,0,0;QS=3,0;MQSB=0.854582;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,172:7:0 0,18,183:6:0 +17 538 . A <*> 0 . DP=31;I16=24,7,0,0,1138,42478,0,0,1837,109369,0,0,620,13536,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,189:7:0 0,18,181:6:0 +17 539 . T <*> 0 . DP=31;I16=24,7,0,0,1134,42070,0,0,1837,109369,0,0,614,13422,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,178:7:0 0,18,181:6:0 +17 540 . C <*> 0 . DP=31;I16=24,7,0,0,1148,43768,0,0,1837,109369,0,0,608,13340,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,177:7:0 0,18,178:6:0 +17 541 . A <*> 0 . DP=32;I16=24,6,0,0,1083,40483,0,0,1777,105769,0,0,551,11991,0,0;QS=3,0;MQSB=0.82403;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,180:8:0 0,15,150:5:0 +17 542 . C <*> 0 . DP=33;I16=25,6,0,0,1123,41759,0,0,1837,109369,0,0,570,12552,0,0;QS=3,0;MQSB=0.822578;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,172:8:0 0,18,174:6:0 +17 543 . C <*> 0 . DP=34;I16=25,9,0,0,1219,45959,0,0,1986,117410,0,0,601,13245,0,0;QS=3,0;MQSB=0.621145;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,27,194:9:0 0,18,188:6:0 +17 544 . A <*> 0 . DP=33;I16=24,8,0,0,1170,43898,0,0,1866,110210,0,0,570,12506,0,0;QS=3,0;MQSB=0.579578;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,24,192:8:0 0,18,180:6:0 +17 545 . A <*> 0 . DP=33;I16=25,8,0,0,1174,43602,0,0,1926,113810,0,0,587,12951,0,0;QS=3,0;MQSB=0.576102;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,24,190:8:0 0,18,184:6:0 +17 546 . A <*> 0 . DP=32;I16=24,8,0,0,1126,41444,0,0,1866,110210,0,0,580,12802,0,0;QS=3,0;MQSB=0.579578;MQ0F=0 PL:DP:DV 0,57,255:19:0 0,21,166:7:0 0,18,193:6:0 +17 547 . A <*> 0 . DP=32;I16=24,7,0,0,1129,42381,0,0,1806,106610,0,0,547,12009,0,0;QS=3,0;MQSB=0.525788;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,180:7:0 0,18,195:6:0 +17 548 . A <*> 0 . DP=33;I16=23,9,0,0,1153,42673,0,0,1866,110210,0,0,561,12489,0,0;QS=3,0;MQSB=0.628357;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,181:7:0 0,21,211:7:0 +17 549 . T G,<*> 0 . DP=32;I16=22,8,0,1,1101,40987,20,400,1746,103010,60,3600,530,11716,25,625;QS=2.96748,0.0325203,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.632337;BQB=1;MQ0F=0 PL:DP:DV 0,31,255,48,255,255:17:1 0,21,168,21,168,168:7:0 0,21,208,21,208,208:7:0 +17 550 . T <*> 0 . DP=32;I16=22,9,0,0,1052,37298,0,0,1806,106610,0,0,548,12176,0,0;QS=3,0;MQSB=0.632337;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,150:7:0 0,21,220:7:0 +17 551 . G <*> 0 . DP=31;I16=22,9,0,0,1121,41639,0,0,1806,106610,0,0,541,12045,0,0;QS=3,0;MQSB=0.632337;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,172:7:0 0,21,208:7:0 +17 552 . C <*> 0 . DP=30;I16=21,9,0,0,1093,41365,0,0,1746,103010,0,0,535,11947,0,0;QS=3,0;MQSB=0.636601;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,21,167:7:0 0,21,208:7:0 +17 553 . A <*> 0 . DP=30;I16=20,8,0,0,981,35387,0,0,1626,95810,0,0,485,10831,0,0;QS=3,0;MQSB=0.596163;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,150:6:0 0,21,194:7:0 +17 554 . A <*> 0 . DP=30;I16=19,9,0,0,975,35601,0,0,1626,95810,0,0,488,10906,0,0;QS=3,0;MQSB=0.646113;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,139:5:0 0,24,211:8:0 +17 555 . A <*> 0 . DP=30;I16=20,10,0,0,1024,36526,0,0,1746,103010,0,0,514,11392,0,0;QS=3,0;MQSB=0.679025;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,150:6:0 0,21,211:7:0 +17 556 . C <*> 0 . DP=29;I16=20,9,0,0,1055,39195,0,0,1709,101641,0,0,509,11219,0,0;QS=3,0;MQSB=0.894839;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,158:6:0 0,18,186:6:0 +17 557 . A <*> 0 . DP=27;I16=18,9,0,0,987,36749,0,0,1589,94441,0,0,506,11074,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,157:6:0 0,18,186:6:0 +17 558 . A <*> 0 . DP=27;I16=18,8,0,0,948,35808,0,0,1560,93600,0,0,477,10281,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,143:5:0 0,18,177:6:0 +17 559 . C A,<*> 0 . DP=27;I16=17,8,0,1,908,33726,14,196,1500,90000,29,841,448,9516,25,625;QS=2.92708,0.0729167,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.90038;BQB=1;MQ0F=0 PL:DP:DV 0,42,255,42,255,255:14:0 0,4,116,15,119,123:6:1 0,18,169,18,169,169:6:0 +17 560 . C <*> 0 . DP=28;I16=19,9,0,0,992,36552,0,0,1649,98041,0,0,494,10654,0,0;QS=3,0;MQSB=0.896555;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,160:6:0 0,21,181:7:0 +17 561 . A <*> 0 . DP=28;I16=18,9,0,0,963,35455,0,0,1589,94441,0,0,466,9946,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,158:6:0 0,21,194:7:0 +17 562 . C <*> 0 . DP=28;I16=18,9,0,0,1006,38392,0,0,1589,94441,0,0,463,9893,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,18,153:6:0 0,21,187:7:0 +17 563 . A <*> 0 . DP=27;I16=17,9,0,0,893,32413,0,0,1529,90841,0,0,460,9820,0,0;QS=3,0;MQSB=0.90038;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,15,149:5:0 0,21,179:7:0 +17 564 . C <*> 0 . DP=27;I16=18,9,0,0,859,28747,0,0,1589,94441,0,0,482,10402,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,121:5:0 0,21,182:7:0 +17 565 . G <*> 0 . DP=30;I16=17,9,0,0,818,26928,0,0,1560,93600,0,0,454,9764,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,12,96:4:0 0,21,154:7:0 +17 566 . C <*> 0 . DP=29;I16=15,11,0,0,903,33405,0,0,1529,90841,0,0,424,9084,0,0;QS=3,0;MQSB=0.927041;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,155:5:0 0,18,167:6:0 +17 567 . C <*> 0 . DP=30;I16=15,12,0,0,932,33774,0,0,1589,94441,0,0,462,10178,0,0;QS=3,0;MQSB=0.935229;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,15,155:5:0 0,21,196:7:0 +17 568 . C <*> 0 . DP=29;I16=15,13,0,0,1057,40817,0,0,1649,98041,0,0,482,10438,0,0;QS=3,0;MQSB=0.942064;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,18,183:6:0 0,18,189:6:0 +17 569 . T <*> 0 . DP=30;I16=16,12,0,0,1056,41296,0,0,1649,98041,0,0,493,10655,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,18,190:6:0 0,21,213:7:0 +17 570 . T <*> 0 . DP=30;I16=16,12,0,0,954,34972,0,0,1680,100800,0,0,472,10086,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,15,157:5:0 0,21,195:7:0 +17 571 . C <*> 0 . DP=31;I16=17,12,0,0,1061,40675,0,0,1740,104400,0,0,472,10158,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,15,155:5:0 0,21,193:7:0 +17 572 . A <*> 0 . DP=31;I16=18,12,0,0,1102,42642,0,0,1769,105241,0,0,499,10887,0,0;QS=3,0;MQSB=0.929991;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,203:7:0 0,18,175:6:0 +17 573 . A <*> 0 . DP=31;I16=18,12,0,0,1057,38473,0,0,1769,105241,0,0,501,10975,0,0;QS=3,0;MQSB=0.929991;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,199:7:0 0,18,178:6:0 +17 574 . C A,<*> 0 . DP=31;I16=18,11,0,1,1088,41328,15,225,1740,104400,29,841,478,10422,25,625;QS=2.94071,0.0592885,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.929991;BQB=1;MQ0F=0 PL:DP:DV 0,48,255,48,255,255:16:0 0,9,170,21,173,177:8:1 0,18,173,18,173,173:6:0 +17 575 . T <*> 0 . DP=30;I16=16,10,0,0,1024,41260,0,0,1560,93600,0,0,448,9842,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,42,255:14:0 0,21,209:7:0 0,15,163:5:0 +17 576 . G <*> 0 . DP=30;I16=17,12,0,0,1047,40077,0,0,1709,101641,0,0,507,11087,0,0;QS=3,0;MQSB=0.931617;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,208:8:0 0,15,151:5:0 +17 577 . G <*> 0 . DP=30;I16=16,12,0,0,999,37747,0,0,1649,98041,0,0,489,10755,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV 0,45,255:15:0 0,24,204:8:0 0,15,146:5:0 +17 578 . G <*> 0 . DP=29;I16=16,13,0,0,975,34803,0,0,1709,101641,0,0,520,11286,0,0;QS=3,0;MQSB=0.940317;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,198:8:0 0,15,151:5:0 +17 579 . G <*> 0 . DP=30;I16=15,13,0,0,1028,38752,0,0,1649,98041,0,0,484,10514,0,0;QS=3,0;MQSB=0.942064;MQ0F=0 PL:DP:DV 0,48,255:16:0 0,24,224:8:0 0,12,145:4:0 +17 580 . A C,<*> 0 . DP=30;I16=15,14,1,0,1060,39178,16,256,1709,101641,60,3600,510,11078,17,289;QS=2.97338,0.0266223,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.946202;BQB=1;MQ0F=0 PL:DP:DV 0,34,255,48,255,255:17:1 0,24,221,24,221,221:8:0 0,15,155,15,155,155:5:0 +17 581 . A <*> 0 . DP=31;I16=16,15,0,0,1083,39215,0,0,1829,108841,0,0,530,11384,0,0;QS=3,0;MQSB=0.951229;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,24,223:8:0 0,15,153:5:0 +17 582 . C <*> 0 . DP=31;I16=15,15,0,0,1080,39870,0,0,1769,105241,0,0,519,11211,0,0;QS=3,0;MQSB=0.952765;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,207:8:0 0,15,151:5:0 +17 583 . T <*> 0 . DP=30;I16=16,14,0,0,1136,43996,0,0,1769,105241,0,0,539,11523,0,0;QS=3,0;MQSB=0.946202;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,238:8:0 0,15,163:5:0 +17 584 . C <*> 0 . DP=31;I16=16,13,0,0,1051,39351,0,0,1709,101641,0,0,499,10619,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,207:7:0 0,15,157:5:0 +17 585 . A <*> 0 . DP=31;I16=17,14,0,0,1096,39866,0,0,1798,106082,0,0,549,11751,0,0;QS=3,0;MQSB=0.998229;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,24,211:8:0 0,15,157:5:0 +17 586 . T <*> 0 . DP=31;I16=16,14,0,0,1081,39839,0,0,1738,102482,0,0,546,11796,0,0;QS=3,0;MQSB=0.999136;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,24,212:8:0 0,15,156:5:0 +17 587 . C <*> 0 . DP=31;I16=17,13,0,0,1070,39402,0,0,1769,105241,0,0,532,11350,0,0;QS=3,0;MQSB=0.963674;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,201:7:0 0,15,155:5:0 +17 588 . A <*> 0 . DP=31;I16=17,14,0,0,1126,41642,0,0,1798,106082,0,0,562,12140,0,0;QS=3,0;MQSB=0.998229;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,24,222:8:0 0,15,164:5:0 +17 589 . A <*> 0 . DP=31;I16=17,14,0,0,1157,43973,0,0,1798,106082,0,0,568,12340,0,0;QS=3,0;MQSB=0.998229;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,24,236:8:0 0,15,165:5:0 +17 590 . C <*> 0 . DP=32;I16=16,14,0,0,1094,41302,0,0,1769,105241,0,0,549,11951,0,0;QS=3,0;MQSB=0.958545;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,18,192:6:0 0,18,175:6:0 +17 591 . A <*> 0 . DP=31;I16=16,15,0,0,1165,44163,0,0,1798,106082,0,0,579,12695,0,0;QS=3,0;MQSB=0.999805;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,209:7:0 0,18,188:6:0 +17 592 . A <*> 0 . DP=31;I16=15,15,0,0,1114,42144,0,0,1738,102482,0,0,571,12651,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,215:7:0 0,18,182:6:0 +17 593 . C <*> 0 . DP=31;I16=15,14,0,0,1065,39889,0,0,1709,101641,0,0,550,12132,0,0;QS=3,0;MQSB=0.954405;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,18,191:6:0 0,18,174:6:0 +17 594 . A <*> 0 . DP=33;I16=16,16,0,0,1163,42917,0,0,1858,109682,0,0,572,12672,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,205:7:0 0,24,212:8:0 +17 595 . A <*> 0 . DP=33;I16=17,16,0,0,1130,39996,0,0,1918,113282,0,0,589,12905,0,0;QS=3,0;MQSB=0.999838;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,198:7:0 0,24,213:8:0 +17 596 . A <*> 0 . DP=33;I16=16,16,0,0,1059,37039,0,0,1858,109682,0,0,590,12952,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,169:7:0 0,24,230:8:0 +17 597 . C <*> 0 . DP=33;I16=17,16,0,0,1196,44890,0,0,1918,113282,0,0,592,12990,0,0;QS=3,0;MQSB=0.999838;MQ0F=0 PL:DP:DV 0,54,255:18:0 0,21,204:7:0 0,24,220:8:0 +17 598 . T <*> 0 . DP=33;I16=16,16,0,0,1214,47104,0,0,1858,109682,0,0,593,13013,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,217:7:0 0,24,239:8:0 +17 599 . T <*> 0 . DP=33;I16=16,17,0,0,1183,43669,0,0,1918,113282,0,0,599,13095,0,0;QS=3,0;MQSB=0.999838;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,197:7:0 0,27,247:9:0 +17 600 . G <*> 0 . DP=32;I16=15,17,0,0,1174,44066,0,0,1858,109682,0,0,601,13145,0,0;QS=3,0;MQSB=0.999287;MQ0F=0 PL:DP:DV 0,51,255:17:0 0,21,194:7:0 0,24,232:8:0 diff --git a/test/mpileup/mpileup.2.sam b/test/mpileup/mpileup.2.sam new file mode 100644 index 000000000..337c037ab --- /dev/null +++ b/test/mpileup/mpileup.2.sam @@ -0,0 +1,248 @@ +@HD VN:1.0 SO:coordinate +@SQ SN:17 LN:4200 M5:a9a06ca09c111789d92723fbf39820f6 AS:NCBI37 SP:Human +@RG ID:ERR229776 LB:HG00101_I_bc_pelib_1018 SM:HG00101 PI:510 CN:MPIMG PL:ILLUMINA DS:SRP001294 +@PG ID:bwa_index PN:bwa VN:0.5.9-r16 CL:bwa index -a bwtsw $reference_fasta +@PG ID:bwa_aln_fastq PN:bwa PP:bwa_index VN:0.5.9-r16 CL:bwa aln -q 15 -f $sai_file $reference_fasta $fastq_file +@PG ID:bwa_sam PN:bwa PP:bwa_aln_fastq VN:0.5.9-r16 CL:bwa sampe -a 1530 -r $rg_line -f $sam_file $reference_fasta $sai_file(s) $fastq_file(s) +@PG ID:sam_to_fixed_bam PN:samtools PP:bwa_sam VN:0.1.17 (r973:277) CL:samtools view -bSu $sam_file | samtools sort -n -o - samtools_nsort_tmp | samtools fixmate /dev/stdin /dev/stdout | samtools sort -o - samtools_csort_tmp | samtools fillmd -u - $reference_fasta > $fixed_bam_file +@PG ID:gatk_target_interval_creator PN:GenomeAnalysisTK PP:sam_to_fixed_bam VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T RealignerTargetCreator -R $reference_fasta -o $intervals_file -known $known_indels_file(s) +@PG ID:bam_realignment_around_known_indels PN:GenomeAnalysisTK PP:gatk_target_interval_creator VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T IndelRealigner -R $reference_fasta -I $bam_file -o $realigned_bam_file -targetIntervals $intervals_file -known $known_indels_file(s) -LOD 0.4 -model KNOWNS_ONLY -compress 0 --disable_bam_indexing +@PG ID:bam_count_covariates PN:GenomeAnalysisTK PP:bam_realignment_around_known_indels VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T CountCovariates -R $reference_fasta -I $bam_file -recalFile $bam_file.recal_data.csv -knownSites $known_sites_file(s) -l INFO -L '1;2;3;4;5;6;7;8;9;10;11;12;13;14;15;16;17;18;19;20;21;22;X;Y;MT' -cov ReadGroupCovariate -cov QualityScoreCovariate -cov CycleCovariate -cov DinucCovariate +@PG ID:bam_recalibrate_quality_scores PN:GenomeAnalysisTK PP:bam_count_covariates VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T TableRecalibration -R $reference_fasta -recalFile $bam_file.recal_data.csv -I $bam_file -o $recalibrated_bam_file -l INFO -compress 0 --disable_bam_indexing +@PG ID:bam_calculate_bq PN:samtools PP:bam_recalibrate_quality_scores VN:0.1.17 (r973:277) CL:samtools calmd -Erb $bam_file $reference_fasta > $bq_bam_file +@PG ID:bam_merge PN:picard PP:bam_calculate_bq VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_mark_duplicates PN:picard PP:bam_merge VN:1.53 CL:java $jvm_args -jar MarkDuplicates.jar INPUT=$bam_file OUTPUT=$markdup_bam_file ASSUME_SORTED=TRUE METRICS_FILE=/dev/null VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.1 PN:picard PP:bam_mark_duplicates VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +ERR229776.1434662 163 17 1 29 63S38M = 189 288 TCTATGACAGGGAGGTCATGTGCAGGCTGGAGAAGGGGACAAGAGGTCCCCAACTTCTTTGCAAAGCTTCTCACCCTGTTCCTGCATAGATAATTGCATGA ?FIFEDHEHF@EJEHCFEGIFHHHJIIKIIKFKMHLILKJJJFGCF@DHILJMHMDEKDGBIJJJGGK@HMKKFJHJIHCIHLHJIIIIKEIJFEGGGDDF MD:Z:38 RG:Z:ERR229776 AM:i:29 NM:i:0 SM:i:29 MQ:i:29 XT:A:M BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@iiffj_gljjeigihgbhgkgihhhhjdhiedfffcce +ERR229776.44080430 163 17 1 29 33S68M = 200 299 AGAAGGGGACAAGAGGTCCCCAACTTCTTTGCAAAGCTTCTCACCCTGTTCCTGCATAGATAATTGCATGACAATTGCCTTGTCCCTGCTGAATGTGCTCT CEHIFEEEIFFKIHIHEBFHGIKGLJLMKKKKJMLBJKCJLJJGIIJFJKJILJMKKJIKKJLKGFJJKBKJKEDAIKHIFHKLHHLHGLFJJH?CCDFDH MD:Z:68 RG:Z:ERR229776 AM:i:29 NM:i:0 SM:i:29 MQ:i:29 XT:A:M BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@lkaijbikiifhhieijihkiljjihjjikjfeiijajijdc`hjghegjkggkgfkeiig^bbcecg +ERR229776.67863896 163 17 1 29 70S31M = 243 336 TCCTTTCTCTATGACAGGGAGGTCATGTGCAGGCTGGAGAAGGGGACAAGAGGTCCCCAACTTCTTTGCAAAGCTTCTCACCCTGTTCCTGCATAGATAAT ?EEIBDFJFJFGHHHHCA7JII@HIIGHFIIJFILIGDAJLICBIGIGMKLFAFJJILIMILIKF@JGGGJJHILEJMICEGFJIHDIHL?G0=>AH@D@GGG@LDAGFDC@GFF?C6BADEA## X0:i:1 X1:i:0 XC:i:100 MD:Z:63T36 RG:Z:ERR229776 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A@@ +ERR229776.5202330 113 17 20 37 101M * 0 0 TGCATAGATAATTGCATGACAATTGCCTTGTCCCTGCTGAATGTGCTCTGGGGTCTCTGGGGTCTCACCCACGACCAACTCCCTGGGCCTGGCACCAGGGA FFFHGKHJIHHHJIIKLKIHGHGIHBCCHEHDDFFFDFIAHI@CE@EHIHBJIKJKLGJKJFIHJFAJGH=:A6JIHFEDGGHGIGH=HFABDA@EIDEEB X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 XT:A:U BQ:Z:A@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.96861155 99 17 29 60 38M63S = 245 315 AATTGCATGACAATTGCCTTGTCCCTGCTGAATGTGCTCTGGGGTCTCTGGGGTCTCACCCACGACCAACTCCCTGGGCCTGGCACCGGGGAACTTAACAA =BE:CD5=@;3BC5</>E&%()4'5+')=1,)4?C3B5D?:JH'.5>BH5A;*0$;666@FCHCIEIHHIICGDC:GDGFD? MD:Z:8T0G13G0T1T39C34 RG:Z:ERR229776 AM:i:29 NM:i:6 SM:i:29 MQ:i:29 XT:A:M BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.18900347 177 17 69 37 101M * 0 0 GGGGTCTCTGGGGTCTCACCCACGACCAACTCCCTGGGCCTGGCACCAGGGAGCTTAACAAACATCTGTCCAGCGAATACCTGCATCCCTAGAAGTGAAGC DCCBFBGCGFFFHKDJDBGGIC?IIBHHGDLIFJKLJKDGIJJJJLJMMLLNLKLFJIHKBFJJKJJJKLILLBLJIHIKKIKIIJJJIHIHHKEGFGIFC X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 XT:A:U BQ:Z:EBA@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@E +ERR229776.10174020 147 17 73 60 101M = 32 -141 TCTCTGGGGTCTCACCCACGACCAACTCCCTGGGCCTGGCACCAGGGAGCTTAACAAACATCTGTCCAGCGAATACCTGCATCCCTAGAAGTGAAGCCACC CEGFHGHHGJIKDBGGIJAIGDHIFGJFIKJJJKFKKMMLKMLMLMMNMMMJKJKKJHKJLKJKKLKMLBKJIIEKLIKJIKKJKIKJIKDGHHKGDFHBC X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@B +ERR229776.54549035 163 17 122 60 101M = 343 321 CTTAACAAACATCTGTCCAGCGAATACCTGCATCCCTAGAAGTGAAGCCACCGCCCAAAGACACGCCCATGTCCAGCTTAACCTGCATCCCTAGAAGTGAA CIFFIEGJJFFHIKIHKJIKJBJLIIJLMKLJJLLLMJMLNMJJLMMJLKKMFGIJDED=?DA?=FIGGBBCE>C;?EJFGFHFCFCHCHDAHEBCHJHGDJDEADFDFI@GJJE>J@A>D=E>D>:7;@:DDCFA= X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:29 NM:i:0 SM:i:29 MQ:i:29 XT:A:U BQ:Z:A@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.67863896 83 17 243 29 5S60M1I35M = 1 -336 CACGCCCATGTCCAGCTTATTCTGCCCAGGTCCTCCCCAGAAAGGCTGCATGGTTGACACACAGTAGCCTGCGACAAAGCTGAATGCTATCATTTAAAAAC ######HIJEG0>><CBCJ9BD:1;.;2>AG;7?8&/7.C8D;>9,>;B87E>A:3:BHBE@A:EA X0:i:1 X1:i:0 XC:i:96 MD:Z:24T5T64 RG:Z:ERR229776 AM:i:29 NM:i:3 SM:i:29 MQ:i:29 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.96861155 147 17 245 60 58M1I42M = 29 -315 ATGTCCAGCTTATTCTGCCCAGTTCCTCTCCAGAAAGGCTGCATGGTTGACACACAGTAGCCTGCGACAAAGCTGAATGCTATCATTTAAAAACTCCTTGC CD6;=?GB=-EEDH>IG<=?L@DHBBDCDHHMFCDLGEGG?CJFHGF:EAB0CFHLC>MKGFJI?D@FIILH>IIIIHG;F7A69B=;CA7GEFH/=CB?0 X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR229776 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.70166645 16 17 256 37 47M1I53M * 0 0 ATTCTGCCCAGTTCCTCTCCAGAAAGGCTGCATGGTTGACACACAGTAGCCTGCGACAAAGCTGAATGCTATCATTTAAAAAATCCTTGCTGGTTTGAGAG AIIAMHABJNHLI>COB?CJPHJGPJIHOKC;EJGQGKKI>CFBLGOLDAK6=2G@HLKHH(NHKGPHKN?K>LPB88?A8'&5=FJIJEKCCIM;3MEM< X0:i:1 X1:i:0 MD:Z:81C18 RG:Z:ERR229776 NM:i:2 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.109178428 147 17 278 29 25M1I75M = 49 -328 AAAGGCTGCATGGTTGACACACAGTAGCCTGCGACAAAGCTGAATGCTATCATTTAAAAACTCCTTGCTGGTTTGAGAGGCAGAAAATGATATCTCATAGT ACICF>FF=CFFFEDFG-6CFDMHHLFACFJ5LKJK@MIIKLKJJJCGHKAJLLIJJHJFHGIKLHEJI@HGKFHLJLHHIKJGIHHCIHAGH:DB<=CC: X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR229776 AM:i:29 NM:i:1 SM:i:29 MQ:i:29 XT:A:U BQ:Z:@AD@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.33489754 163 17 286 60 17M1I83M = 565 379 CATGGTTGACACACAGTAGCCTGCGACAAAGCTGAATGCTATCATTTAAAAACTCCTTGCTGGTTTGAGAGGCAGAAAATGATATCTCATAGTTGCTTTAC CGFFDGHFIFFGHHHKHGKJKLJKBKJJMLLLMKLMJLKMKKLIJLKJMNNNKNMMMLLMNLMJKKIKLGGHHIHJHHHGIJHIKINIJIIIIFHHKCCE= X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR229776 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.67002924 99 17 287 60 101M = 567 362 ATGGTTGACAGACAGTGCCTGCGACAAAGCTGAATGCTATCATTTAAAAACTCCTTGCTGGTTTGAGAGGCAGAAAATGATATCTCATAGTTGCTTTACTT 7<937;A%6@AB5AGBCBG4GEE=;?BDHG;9@D@=;BB@GJ@KKKJDB;:@>C?9C??AEAICI6/9@CEDEMFIEDH?C?GC?DD:DB X0:i:1 X1:i:0 MD:Z:10C90 RG:Z:ERR229776 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@FG +ERR229776.39811680 163 17 292 60 11M1I89M = 579 387 TGACACACAGTAGCCTGCGACAAAGCTGAATGCTATCATTTAAAAACTCCTTGCTGGTTTGAGAGGCAGAAAATGATATCTCATAGTTGCTTTACTTTGCA ?CGCFE@E;GHC@EFKB=76DDJDI@BGKCLK8JD6JJAIJBGEBBF?>CCAGCDGEIIFCJGGC;FCEDD@HADHE::=IEGJIGIKIJKDHFKIILIIJJJLLLM?KJKMJJGMJLGCIHLFLHJLKJLMNFIKJIJJJNJKJGCAFFJMHFIGLHIHIJKFFDCC=9DHEBD X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:29 NM:i:0 SM:i:29 MQ:i:29 XT:A:U BQ:Z:A@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A +ERR229776.47122623 83 17 316 60 4S97M = 19 -393 AAAGCTGAATGCTATCATTTAAAAACTCCTTGCTGGTTTGAGAGGCATAAAATGATAGCTCATAGTTGCTTTCCTTTGCATATTTTAAAATTGTGACTTTC #####GA7>;IDG@D5LNHDB>8.0DF.FFC::HAA?DD3-BMA;;6+=D=HDD<75'8=<@F@F@<5(G5(%>D>;3*6<'62+7 X0:i:1 X1:i:0 XC:i:97 MD:Z:43G9T14A28 RG:Z:ERR229776 AM:i:37 NM:i:3 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.54549035 83 17 343 60 101M = 122 -321 GCTGGTTTGAGAGGCAGAAAATGATATCTCATAGTTGCTTTACTTTGCATATTTTAAAATTGTGACTTTCATGGCATAAATAATACTGGTTTATTACAGAA CFGFDJKJJOHLIJJHGHHIIILJJJLMLKKJMJMJLMMMIJLLMJKIJJFMLLIJJIHJIIIJHKLKJIGEJJGHGIGGGFCGGGFHEIEBDHBFEIFEC X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A +ERR229776.24914793 99 17 348 60 101M = 613 365 TTTGAGAGGCAGAAAATGATATCTCATAGTTGCTTTACTTTGCATATTTTAAAATTGTGACTTTCATGGCATAAATAATACTGGTTTATTACAGAAGCACT A@EEFE>ED?;EHGIEGDD@FGEEGEGGDEFIJKFIFFKJIHGEIGIKJIELMMJKEBJFHIGEIJJJLKIJDILKJNDKIKKEJKKEIKKGJHJLGCEEI X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@D +ERR229776.100438586 99 17 384 60 101M = 443 159 ACTTTGCATATTTTAAAATTGTGACTTTCATGGCATAAATAATACTGGTTTATTACAGAAGCACTAGAAAATGCATGTGGACAAAAGTTGGGATTAGGAGA AACAECGDFCHHIKKFCGHGHLGEIJ=GGJDHJDKMFFHELJHHLBEKKHKIHEHEIJLJNNIGAIIEGEHHGBDCC X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@B +ERR229776.100438586 147 17 443 60 101M = 384 -159 AGCACTAGAAAATGCATGTGGACAAAAGTTGGGATTAGGAGAGAGAAATGAAGACATATGTCCACACAAAAACCTGTTCATTGCAGCTTTCTACCATCACC HDBEFGHFHFHIJFCELJLKLFFKIGLEJKAIFEJJMJFMJHJKBJKGBJJMJJFIJFGHGAFEHJHBICCAIEFEGDCF@D@@KHEDFG7CHDBC@;230 X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:C@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.105883979 163 17 445 60 101M = 610 265 CACTAGAAAATGCATGTGGACAAAAGTTGGGATTAGGAGAGAGAAATGAAGACATATGTCCACACAAAAACCTGTTCATTGCAGCTTTCTACCATCACCAA CGEJFGIJJJDHIHHJHFKKIILLLLIJILLKJKJMLKJJKKKLNMKLLMMLKKKKKLKLLKKKKKNNNMJJOKIAKKKFIKLIKMFFIMKGHIHGHDEFD X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@HI +ERR229776.41759951 163 17 452 60 101M = 681 323 AAATGCATGTGGACAAAAGTTGGGATTAGGAGAGAGAAATGAAGACATATGTCCACACAAAAACCTGTTCATTGCAGCTTTCTACCATCACCAAAAATTGC :DEEEG=*BCB.F6FGI==IIF1BDIAIJI,FEH=BFFHD,AECEBFFEF=8DFIGJGF4<++*@KEHDGIJKHHG-?C=DHLIF8GFEIDFGE?BBDBAD X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@IG@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.103175593 163 17 462 60 101M = 681 314 GGACAAAAGTTGGGATTAGGAGAGAGAAATGAAGACATATGTCCACACAAAAACCTGTTCATTGCAGCTTTCTACCATCACCAAAAATTGCAAACAACCAC .6:AFFEEB?<8;:IG?DHH?FI9EIIJJHFGK+:BF8DFAF@DGDJEHHCFECHDC6BE@BEEIBGJMJHKOHDEIEFC=BED6:FEEF=G-9AFE=@BA X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.28425582 99 17 465 60 101M = 698 315 CAAAAGTTGGGATTAGGAGAGAGAAATGAAGACATATGTCCACACAAAAACCTGTTCATTGCAGCTTTCTACCATCACCAAAAATTGCAAACAACCACACG ADD=7HEG2;>@CD7C=@C=@E?CF@?4>BJ>;;9FGH=FGDJHJJJBDC;8=DCEGJGGEHIKHHJEE5@B06C?DHBEHED@# X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.445065 163 17 478 60 101M = 793 406 TAGGAGAGAGAAATGAAGACATATGTCCACACAAAAACCTGTTCATTGCAGCTTTCTACCATCACCAAAAATTGCAAACAACCACACGCCCTTCAACTGGG ?FEDFGHFHHDKKEHEJGJ3HHIIIIKKHIJIJLLLLJILAFJJFJKJ?FGIMKIILJHHFEEFH7IFELLDHKFILFGGKGHJGGGAJIIMHEHIEI7;5 X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.76793083 163 17 490 60 101M = 728 338 ATGAAGACATATGTCCACACAAAAACCTGTTCATTGCAGCTTTCTACCATCACCAAAAATTGCAAACAACCACACGCCCTTCAACTGGGGAACTCATCAAC ?EDHDGHDFHDHHEHGHCHHIKLKJFHJHJKIIIJHIJFHKJJJLJJBFDJKHIJMBIF>AGHGMHIJMIJJJKC=IGDCDGJFHMIE@CKDCMHHFFGB# X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.7941745 163 17 541 60 101M = 806 357 ACCAAAAATTGCAAACAACCACACGCCCTTCAACTGGGGAACTCATCAACAACAAACTTGTGGTTTACCCACACAATGGAAGACCACTTAGCAACAAAAAG ?>?FIJJJHH?GDGCEHIHEG7H<:IKKLJKJLADHCFIGKGMIICBILHJLBHIAGL6C8BA2*;BAAAFE>CH=.C;5AE,5)/<4C=3'=8;;*);10*HHH>?CEC(B9)@@(<:(=>;.G762*6JIB>,6(56--/'GF:7D=486A=BA XC:i:88 MD:Z:17C14C0T17C22A13 RG:Z:ERR229776 AM:i:29 NM:i:5 SM:i:29 MQ:i:29 XT:A:M BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.33489754 83 17 565 60 101M = 286 -379 GCCCTTCAACTGGGGAACTCATCAACAACAAACTTGTGGTTTACCCACACAATGGAAGACCACTTAGCAACAAAAAGGACCAAACTCCTGGTACATGCAAC :?DFIJHHICIHFELHIHJHJIHEHGKIKKB=JMJDJFG.>665CE@HFI>G474>9DF>@?FEA=>=JB:GEE@B>: X0:i:1 X1:i:0 XC:i:83 MD:Z:83 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.89263281 163 17 572 60 101M = 706 234 AACTGGGGAACTCATCAACAACAAACTTGTGGTTTACCCACACAATGGAAGACCACTTAGCAACAAAAAGGACCAAACTCCTGGTACATGCAACTGACAGA CHEJFEEEFIDKIHHKIKIILIILLJLKKJIIIIJJJMMKHJKJNJJLLNMLKMKKMLKKMKNIJMNMMKEKIHIGHGMFHMIGJIGJHHIJIGLGHDGEF X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:AC@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A +ERR229776.40976938 163 17 574 60 101M = 796 322 CTGGGGAACTCATCAACAACAAACTTGTGGTTTACCCACACAATGGAAGACCACTTAGCAACAAAAAGGACCAAACTCCTGGTACATGCAACTGACAGATG ?HDDDEIJFJFHGDHKIHKIIKKGLJIEHIGIIIIIKJHIJJHIJJKLILJMKKMLJKLKNJKMMMNJHLEGHGGGMIHKIGHIGJIHJJHGLHIFHFGDD X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.39811680 83 17 579 60 101M = 292 -387 GAACTCATCAACAACAAACTTGTGGTTTACCCACACAATGGAAGACCACTTAGCAACAAAAAGGACCAAACTCCTGGTACATGCAACTGACAGATGAATCT DAFCCC7EA@GFGFHC:0KCFBBD8MLJEA;?><=:HB?3JIKBBAFBHD?FCE2CG:HEGJE<<@ACDFA8BGFDEB<(GEHGFCA?E@:@9E=F@D?8A X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.96748390 1107 17 579 60 101M = 292 -387 GAACTCATCAACAACAAACTTGTGGTTTACCCACACAATGGAAGACCACTTAGCAACAAAAAGGACCAAACTCCTGGTACATGCAACTGACAGATGAATCT FDGFIEFE@@G>B0CC@0>@FCE=F@MIEGJIDIDE@EGFG?K=BIIJGFBJHE@=9C@HFJE@G:@@?E=D<5>8BH==@@<;@= X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:A@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.65100219 99 17 604 60 35M66S = 847 335 TTTACCCACACAATGGAAGACCACTTAGCAACAAAAAGGACCAAACTCCTGGCACATGCAACTGGCAGATGAATCTCAAACGCATTCCTCCGTGTGACAGA 15))2*4?0<4CC>A9<#################################################################################### X0:i:1 X1:i:0 XC:i:35 MD:Z:35 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.105883979 83 17 610 60 101M = 445 -265 CACACAATGGAAGACCACTTAGCAACAAAAAGGACCAAACTCCTGGTACATGCAACTGACAGATGAATCTCAAACGCATTCCTCCGTGTGAAAGAAGCCGG CGFGGEJIHIFMIIGIJHHKLHHEHGJJJIKHHHFIIEBHKLLILIHJJIFLIJILIKHJLKIIJJIHHJHEFB?HIHIIIHGI?EFFGGBBGECIEC:EC X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A +ERR229776.24914793 147 17 613 60 101M = 348 -365 ACAATGGAAGACCACTTAGCAACAAAAAGGACCAAACTCCTGGTACATGCAACTGACAGATGAATCTCAAACGCATTCCTCCGTGTGAAAGAAGCCGGACT @D>GHGHFLFCEHJIHILHDFGDIIEDLGIHEHGC@BGDKJHGJGJJJGJIJKIKJLMICIJJIKEJHJIF>GGILGKJJH=HGHGJDIKFHJFE>DEHE? X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.50340221 99 17 667 60 95M6S = 960 393 GACAGAGGAATCTCAAACGCATTCCTCCGTTTAAAAGAAGCCGGACTCATAGGGCAACACACTATCTGACTGTTTCATGGGAAAGTCTGGAAACGGCAACA =FCDEG*.@56BFHG<58&3)1AJ6(>6'=13=.A3:)2DC@:DA(@;D)B@>B89>BG?;8)@EG@3%;A+>GGKHABEBB####### X0:i:1 X1:i:0 XC:i:95 MD:Z:6T23G1G16C45 RG:Z:ERR229776 AM:i:37 NM:i:4 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.103175593 83 17 681 60 5S96M = 462 -314 ATCTCAAACGCATTCCTCCGTGTGAAAGAAGCCGGACTCACAGGGCAACACACTATCTGACTGTTTCATGGGAAAGTCTGGAAACGGCAACACCATTGAGA ######@E;EBD8+8)1$4:>FAJJKMG?H:*6@<>;:=A@D>9G;0@;06JIG@CA/9F>E??C>F>@AD>DF>A@32>@;')8=;.7F70HHIHIC@EA34IHHE@::*-(<:3H7@CF57>F;B3:07C68;,6A8(<;3563C>;E>= X0:i:1 X1:i:0 XC:i:95 MD:Z:95 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.7320258 99 17 683 60 101M = 985 402 ACGCATTCCTCCGTGTGAAAGAAGCCGGACTCACAGGGCAACACACTATCTGACTGTTTCATGGGAAAGTCTGGAAACGGCAGCACCATTGAGACAGAAAA B+)=AC/=8@4D<6>948=57D;CA@96A;DIB>AG:8>C;;@@EGIA6?FH>EI8CCGJFD=;>20>)1?@8FHC69BI>ABF=C: X0:i:1 X1:i:0 MD:Z:82A18 RG:Z:ERR229776 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A@B@ +ERR229776.28425582 147 17 698 60 18S83M = 465 -315 CAAACGCATTCCGCCGTGTGAAAGAAGCCGGACTCACAGGGCAACCCACTATCTGACTGTTTCATGGGAAAGTCTGGAAACGGCAACACCATTGAGACAGA ###################HD@HDELF6=HHGGIE7DEIGFDBG9%B6FF>:BDF@FF@FJHFEHEEEHHKCG?CHF81I;GC2B>ECCCAEGFKGFED9: X0:i:1 X1:i:0 XC:i:83 MD:Z:27A55 RG:Z:ERR229776 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.89263281 83 17 706 60 101M = 572 -234 GCCGGACTCACAGGGCAACACACTATCTGACTGTTTCATGGGAAAGTCTGGAAACGGCAACACCATTGAGACAGAAAACAGGTGAGTGGTTGCCTGGGGCC >D>FHGHJHGFMHHIIFGIHHEHIKLJJJJKJHLLLKJJJLLKJLGLJJIEIEB@KKFHFCCKJILIDFH>AKIIIGFGJIFFII?GHEIBE>3IJEE;CFHGBJ=8<8IILFEEIIHJGGHDHIF@7CLGH?0094=094%492;>B=CB'%6BBIED@ X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.76793083 83 17 728 60 101M = 490 -338 CTATCTGACTGTTTCATGGGAAAGTCTGGAAACGGCAACACCATTGAGACAGAAAACAGGTGAGTGGTTGCCTGGGGCCAGGGAACTTTCTGGGGTCATAT D=JCDB>CB>EFGBA?E>DGEB?CDBFGCI@BEHCAJGCCK=C@F??EA16>>DCMII@LE@CGDI;@DIIHCGG?@=1= X0:i:1 X1:i:0 MD:Z:75T5G19 RG:Z:ERR229776 AM:i:37 NM:i:2 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.98656758 163 17 764 60 101M = 1003 339 AACACCATTGAGACAGAAAACAGGTGAGTGGTTGCCTGGGGCCAGGGAACTTTCTGGGGTCATATTCTCTGTGTTGATTCTGGTGGTGGAAACAAGACTGT CHEFDFGHHHHIHEHKJKLLIILKIIKJEGIJJKLLMLLLLMLJMLLLMKNLLMMLLLMFKJKJKJJNJOJJHJJCLIFHMIGHIGJIGHHJGGCGHDJEE X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:AC@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.20493064 99 17 765 60 101M = 1017 352 ACACCATTGAGACAGAAAACAGGTGAGTGGTTGCCTGGGGCCAGGGAACTTTCTGGGGTCATACTCTCTATGTTGATTCTGGTGGTGGAAACAAGACTGTC CDGCDEBFDCCHEFIGIJIFGIHCGFHCEDBIIJIKHHKKKKIKKKJLJLEJKKIILK?HIGIELHLILHIGGJHIIEJLHFHHGDDGJHHGIHGJEKFGE X0:i:1 X1:i:0 MD:Z:63T5G31 RG:Z:ERR229776 AM:i:37 NM:i:2 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@G +ERR229776.445065 83 17 793 60 9S92M = 478 -406 CAGGTGAGTGGTTGCCTGGGGCCAGGGAACTTTCTGGGGTCATATTCTCTGTGTTGTTTCTGGTGGTGGAAACAAGACTGTCCCAGCCTGGGTGATACAGC ##########CFJE@CGDD@EA;G>>GE8?9?/;AFCHFJJJGBFIDHHIF411A=9>$FC@?FAHDFEC<:8A=GG@;DI=8>E;5:GC4BG:BCE;@A-:>EHJFFHICDGHIG?GEKIHLIIKCHEFB>>=IAIBHHCEE<9BGDA@GBJH8=JD@CGDIJG?FFE X0:i:1 X1:i:0 MD:Z:10T5G84 RG:Z:ERR229776 AM:i:37 NM:i:2 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.59614566 163 17 820 60 101M = 1133 408 GGGTCATACTCTCTATGTTGATTCTGGTGGTGGAAACAAGACTGTCCCAGCCTGGGTGATACAGCGAGACCCCATCTCTACCAAAAAATTAAAAATTAGCT :;@=AHGFFKFKIHHIFCHHKBHHLIEIIIAFEKLLJJLKLKDHJJHIIKMMLFJJ7=GGIGJLJBLJLEIIGIEHMILFGHJD?JDDEFFIJHGHBFDEF X0:i:1 X1:i:0 MD:Z:8T5G86 RG:Z:ERR229776 AM:i:37 NM:i:2 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@B@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A +ERR229776.65100219 147 17 847 60 8S93M = 604 -335 GATTCTGTTGGTGGAAACAAGACTGTCCCAGCCTGGGTGATACAGCGAGACCCCATCTCTACCAAAAAATTAAAAATTAGCTGGGCATGGTGGTGCATGCC #########FDGFF:DCFDLEA=0D;BBHLF;6GA-6IJJIH=KI9>G@2019BCAB,F>F=AJBFHA?6?DJJDIEH;HCH>BCA;ACA3;;?G>;C8=. X0:i:1 X1:i:0 XC:i:93 MD:Z:93 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.70908663 16 17 916 37 1S100M * 0 0 TCAGCTGGGCATGGTGGTGCATGCCTGTAGTCCCAGCTATTCACAGTGCTGAGGTCGGAAGATGCCTGAGCCCAGGCGTTCAAGGCTGCAATGAGCTATGA ##J@<:7FM?IMHGLGINGEEJH=>I:MPGD9:NNM?MIQNNMPRJNEMQKLA9D"MLMMM6L2,&PMQJ8?B2I@+:KMN>=2E?AI@HDIFNG8< X0:i:1 X1:i:0 XC:i:100 MD:Z:0T53G9T10A24 RG:Z:ERR229776 NM:i:4 XT:A:U BQ:Z:@@E@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.33718464 147 17 927 60 101M = 717 -310 GGTGGTGCATGCCTGTAGTCCCAGCTATTCACAGTGCTGAGGTGGGAAGATGCTTGAGCCCAGGAGTTCAAGGCTGCAATGAGCTATGATTGCGCCACTGC ;@FCAHGCHGGEHJHIJCJEF?LJIHDED@7CKD;HGJFEIIJGDGBAE5A?IMJLMJGIFLGBIBBJF>LEIJIIF@EIJKICFBHFGKBG?FEFAEGB7 X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.53110448 99 17 947 29 2S31M68S = 1224 373 TACCATCTATTCACAGTGCTGAAATGGGAAGATTCTTGAGCCCAGGAGTTCAATGCTGTAATTACATATGTTATCGACACTGCATTTTGGCCTGGATGAGA B7:11()8::@A?IJIHJJLKIGJEJFHIIGGEFKHHGGFCB0>EEFDG? X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.7320258 147 17 985 60 101M = 683 -402 CCCAGGAGTTCAAGGCTGCAATGAGCTATGATTGCGCCACTGCACTTTGGCCTGGACAACAGAGCAAAACCCTGTCTCTAAAAAAAGAAAAGAAAAGAAAA ?CEIDBKGJJIFLFIIJIIFHCGLCCFFJGDDHJBK?GKGIH=GBCFACECHJHJJIFFJKGJJIJIIFIIJIHGJJJHJIIGBHKHFAGFHHHHKFGCC? X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@A@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@IHIG +ERR229776.98656758 83 17 1003 60 101M = 764 -339 CAATGAGCTATGATTGCGCCACTGCACTTTGGCCTGGACAACAGAGCAAAACCCTGTCTCTAAAAAAAGAAAAGAAAAGAAAAACTCACTGGATATGAATG EGGHGLIGIIJIIHJIAIEHHHIIHIHMLJFJIIIHMIJJJHLILIGJJIDLKLIHJCHI>JJJJJJIGIFEJJIIIJIHHFCFGBFAHFABDEBEEEEFC X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.50998015 0 17 1012 37 100M1S * 0 0 ATGATTGCGCCACTGCACTTTGGCCTGGACAACAGAGCAAAACCCTGTCTCTAAAAAAAGAAAAGAAAAGAAAAACTCACTGGATATGAATGATACAGGTT 327C$2FG8CGM@H?563@3I@%2==H;?*@H;E?BF;M>N7FFHGA8GEGHHJIIJIIHJIIFHLCLKIIKKOJNKIKKKJMJMKJLKLKKLLLLLKMJLLLMILKLMKJKJJJJKIJGIKLIIIIKIIIKHHIFKFEJGFJEFC X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.2114306 163 17 1033 60 101M = 1337 404 GGCCTGGACAACAGAGCAAAACCCTGTCTCTAAAAAAAGAAAAGAAAAGAAAAACTCACTGGATATGAATGATACAGGTTGAGGATCCATTATCTGAAATG :;D=IFE9@FED@DHIJGKJKEGELGF>JELIHKKHLLEKLMMKKJLMKGLDLMEGJFHHJFDEKGF@6HJHEKGIHJHDFHFHGCCGDD X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.69497113 83 17 1057 60 45S56M = 717 -395 ATGATTGCGGAACTGGTTTTTGGAGTTTACAACAGAGCAAAAATGTGTCCATAAAAAAAGAAAAGAAAAGAAAAACTCACTGGATATGAATGATACAGGTT ##############################################@J:+B@;91-=/4*GHF9:H<:04+'751:<48A6:0FC4D;A?;<8==CGD>BB X0:i:1 X1:i:0 XC:i:56 MD:Z:4T0C50 RG:Z:ERR229776 AM:i:37 NM:i:2 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.83355002 99 17 1066 60 101M = 1294 328 AAAAAGAAAAGAAAAGAAAAACTCACTGGATATGAATGATACAGGTTGAGGATCCATTATCTGAAATGCTTGGACCAGATGTTTTGAATTTTGGATTTTTT ABD>CCDHGDHJIJJB?>DCDHIHDID,;5(A:@23?838D87<,<7;-EJH@JHCCC>ED<:BKGFBEB98;F?D8AE11665G6DF:+ X0:i:1 X1:i:0 XC:i:82 MD:Z:82 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.69297552 163 17 1080 60 101M = 1344 364 AGAAAAACTCACTGGATATGAATGATACAGGTTGAGGATCCATTATCTGAAATGCTTGGACCAGATGTTTTGAATTTTGGATTTTTTCATATTTTGTAATC ?CHADJJDJHFGKEHIHDAGHLCIIIIIJJIEHIKJILJLLJJKJJLMJLMMJJLMKJJKILJKGDKHKJLKGLJKKIKIKHHKKLFIJIFIFJEGECFEC X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.44123845 163 17 1082 60 101M = 1361 379 AAAAACTCACTGGATATGAATGATACAGGTTGAGGATCCATTATCTGAAATGCTTGGACCAGATGTTTTGAATTTTGGATTTTTTCATATTTTGTAATCTT CHHIIEKGGFIHHJHIHFJLIJKIIJJJIJJIJJIKILKJJKJKLMJLMMJJMNIHJLILKKCGIKJKKJLLKJKIKKMFLLLBILJJKKKKKHFGHFGCD X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:EIGGD@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@EI +ERR229776.59579091 99 17 1088 60 101M = 1308 320 TCACTGGATATGAATGATACAGGTTGAGGATCCATTATCTGAAATGCTTGGACCAGATGTTTTGAATTTTGGATTTTTTCATATTTTGTAATCTTTGCAGT CBGCIE@GEBBGHIGFIGCFGIHFGCGHGFEKIFIJIHJLHIKIIHJLJKFLHLJLKIKJKKKKLKIIKKJILJKKKKKJKKKJFKKHKIHIHMEEGGGFF X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@B +ERR229776.33511586 163 17 1116 60 101M = 1421 405 GATCCATTATCTGAAATGCTTGGACCAGATGTTTTGAATTTTGGATTTTTTCATATTTTGTAATCTTTGCAGTATATTTACCAGTTCAGCATCCCTAACTC CGFFEGHHGHFKHJKKIFKLJJKKIJILKIKJJIJIKLJKLLKLLKKLKKLMKKKKLLLLJJLKMNLLLLKMKKKKKLJIJEJIKLLLHLJKIJHJGDAIC X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.65575982 147 17 1120 60 101M = 818 -402 CATTATCTGAAATGCTTGGACCAGATGTTTTGAATTTTGGATTTTTTCATATTTTGTAATCTTTGCAGTATATTTACCAGTTCAGCATCCCTAACTCAAAA ACGFDCGIIFDGJJJNLHIH@=NKKKJLNJKKKKMLMIEFKLIGINLJJJHLMHJKJKJEFLLJJHMJIIJILKGIIILHLJGIFFCDEEGGCFHIFGFC? X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@IKIG +ERR229776.45364215 163 17 1122 60 101M = 1385 363 TTATCTGAAATGCTTGGACCAGATGTTTTGAATTTTGGATTTTTTCATATTTTGTAATCTTTGCAGTATATTTACCAGTTCAGCATCCCTAACTCAAAAAT CEFFFKHIJIFHIKIHHJHKIJJIIIJIIIKLJJKJILKHKLKLLJJJJJLLLLJJMJMLKKHLJKKJJKKKKKKJKILIKLHLKLLKINKHGKHHFEEDE X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:A@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@G +ERR229776.59614566 83 17 1133 60 5S96M = 820 -408 GAAATGCTTGGACCAGATGTTTTGAATTTTGGATTTTTTCATATTTTGTAATCTTTGCAGTATATTTACCAGTTCAGCATCTCTAACTCAAAAATTCAAAA ######GJJ@=GEHICDIFNGCFDA@MMLE=AJLEEIIGA5@D>GLICGBAC>EJCD3IA@6F9KH:;BHF=JH@H=@?B=69FF@>GGG7BEEEGCEGGGFACEF:CCB@DCHHEGJHEJCLFCBJEGIJJH;CGCIJIBELGJJC8F X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:DDC@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A +ERR229776.10204227 99 17 1173 60 101M = 1423 350 TTGTAATCTGTGCAGTATATTTACCAGTTCAGCATCCCTAACTCAAAAATTCAAAAATCTGAAATCCCAAACGCGCCAATAAGCATTCCCTTTGAGCGTCA :5=DC<<=G++:?>GAF=88=BDFFA9-.8:D9@FJHJEJAB?=D@BCKKFJKJLMCCB:FH68B8@3<;FJHH@D?B?@CBDJFJJC,6,?9BJ?:8:ICICIIMK?IDJDDIKIIJ@;@@B?HC### X0:i:1 X1:i:0 XC:i:99 MD:Z:99 RG:Z:ERR229776 AM:i:25 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A@@@ +ERR229776.53110448 147 17 1224 29 4S97M = 947 -373 AATTAAAAAATCTGAAATCCCAAACGCGCCAATAAGCATTCCCTTTGAGCGTCATGTCGGTGCTTGGAATGTTTGGGGTTTTGGATTTACAGCTTTGGGAC #####C@CEE6,JC+6.I7CD5:22;1A&=FBFABADLKKG>DGG?5H:ACCEJJH>:=C8662CC;E?E6);,4-20,)=(B44316)92:4@DAHH8HF;@CA>?>9ADE8/<8BF:F57C3:9><;C?A2= X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.69297552 83 17 1344 60 101M = 1080 -364 CTGATTTTAAAAAAGTTTGGGGGGATTCCCCTAAGCCCGCCACCCGGAGACAGCGGATTTCCTTAGTTACTTACTATGCTCCTTGGCCATTTCTCTAGGTA CGFFIJIIFFHFFLEDBCFFDAAC;F9:1EG>CKLIJDLJ@IHIGKIHIKGIFH98I<7.GB6GEBHBHFFF=BAFH8>>B1 X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.31884178 163 17 1349 29 101M = 1660 348 TTTAAAAAAGTTTGGGGGGATTCCCCTAAGCCCGCCACCCGGAGACAGCGGATTTCCTTAGTTACTTACTATGCTCCTTGGCCATTTCTCTAGGTATTGGT &BH>7GDDFGHF@=CDKC@DKHGEILJEJHC&88F=GFIHDIIHC?.@DEA6 X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:29 NM:i:0 SM:i:29 MQ:i:29 XT:A:U BQ:Z:@AD@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.44123845 83 17 1361 60 101M = 1082 -379 TGGGGGGATTCCCCTAAGCCCGCCACCCGGAGACAGCGGATTTCCTTAGTTACTTACTATGCTCCTTGGCCATTTCTCTAGGTATTGGTATATTGTGTCTG FECDEEFDCGGGGIIFIIBF@FB@=BHAJKMDJJLKCLMIMMLKLMJKHJBFIJI=JGHFJGJGIKIJIDCBDHJFHHEJIFFGJEHFGGBBGE?DCFEFC X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:A@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.72241554 163 17 1365 60 101M = 1597 332 GGGATTCCCCTAAGCCCGCCACCCGGAGACAGCGGATTTCCTTAGTTACTTACTATGCTCCTTGGCCATTTCTCTAGGTATTGGTATATTGTGTCTGCTGT CBBHFHGFEGIHKJJJJ"1BHGJJ@GIJKHJJIAIKJKJLMKJHKJJIIMIIGMIJGILIFKCFDGFHGDDKMHLJCFBAFHIGHIIIILIJIHHLGFIBE X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:HGD@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.45364215 83 17 1385 60 101M = 1122 -363 ACCCGGAGACAGCGGATTTCCTTAGTTACTTACTATGCTCCTTGGCCATTTCTCTAGGTATTGGTATATTGTGTCTGCTGTGAACTGTCCTTGGCCTGTTT />=?GHLHICII?EIHMJLEHGHGFDDDGI=EJGG?GIKLJDIIKEIFKKDBKHIJHIHGHH>HIHF?JH@EDGJGGGCEG;DGGEGFFGE@CA:CECDBA X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A +ERR229776.26840652 99 17 1389 60 101M = 1635 346 GGAGACAGCGGATTTCCTTAGTTACTTACTATGCTCCTTGGCCATTTCTCTAGGTATTGGTATATTGTGTCTGCTGTGAACTGTCCTTGGCCTGTTTGGTG <?ABECCIJJLJ@BCFAHIJILLCGJIDDGDGBEDJ@+>EGFKHN@CMKIJ;1+C?C3@ICF=D@I?GBA<IEGHIHJCDHCDJIB@DFHKJJHKHJLEIIILJFHJJJJMKJJGK@JJFKJJLJFKJJKCHLJKKIHIIKLIJHIEA&GHHFIKEHJF:KDEFG? X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.33511586 83 17 1421 60 101M = 1116 -405 GCTCCTTGGCCATTTCTCTAGGTATTGGTATATTGTGTCTGCTGTGAACTGTCCTTGGCCTGTTTGGTGACGGGTGAGGAGCAGGGACAGAAGGGTCCTGC CCE@GGIHF=D:EHKEJHHKHFHDBHJEGDEFKIFHEDJGH@IEDIIIKIEKIJKFJHCIDILKIJHCFE7IIHHHJJGIH;BFA:E>F(15.)1'0%1?EB1E(/;3?HHJ5)=CE>5=/8:D89;;EDF=%:A6=#################################### X0:i:1 X1:i:0 XC:i:66 MD:Z:60T5 RG:Z:ERR229776 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.10204227 147 17 1423 60 101M = 1173 -350 TCCTTGGCCATTTCTCTAGGTATTGGTATATTGTGTCTGCTGTGAACTGTCCTTGGCCTGTTTGGTGACGGGTGAGGAGCAGGGACAGAAGGGTCCTGCGT D>AGEGF@8EBKKDH?DLDB=@HKGCHFGJGKIHDGFFEDHHFHC7KKJKDHMFIHGCJELLFKHIJI>IHCIILC>LGIKHGEHEJGIKEGFIEGFE:C? X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.66536220 99 17 1466 60 101M = 1680 314 GAACTGTCCTGGGCCTGTTTGGTGACGGGTGAGGAGCAGGGACAGAAGGGTCCTGCGTGCCCTGCCTTCACAAGCCCCTGGAAGGAAAGTTGTTTTGGGAT A@DBIE==>>/<>>HHEDD@GGCDHH8BG>?JE:DIJHGDBD=AIJLJHH0G(>;D;=DHF:G?BEHFEEDHICFGD=6A;>EB=?KJD7>E13?EA2=CD X0:i:1 X1:i:0 MD:Z:10T90 RG:Z:ERR229776 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.46562341 99 17 1476 60 101M = 1781 398 TGGCCTGTTTGGTGACGGGTGAGGAGCAGGGACAGAAGGGTCCTGCGTGCCCTGCCTTCACAAGCCCCTGGAAGGAAAGTTGTTTTGGGATCTCTGCACCC AABECG5A8>E@C;FD>3F=;=CCEDGCHFC7C6D?@?F@B>CK=EC?ACB?=;6@93E*A??B690<<935:FB>1--?@KC@HE7= X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.93812627 163 17 1518 60 82M19S = 1829 411 CTGCGTGCCCTGCCTTCACAAGCCCCTGGAAGGAAAGTTGTTTTGGGATCTCTGCACCCTCAGCCTGGACAACTTGTGCCCATCTGGTGACCCCTCACTCA CHFF=GHHFHIHIGKJKGIIKJKKKKLICKMJCKMLMJJJJKKKJLJLD@C?:<>@=DIH,GCCEEBA+6DGC0BCBADCH#################### X0:i:1 X1:i:0 XC:i:82 MD:Z:82 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.9004658 163 17 1520 60 99M2S = 1782 362 GCGTGCCCTGCCTTCACAAGCCCCTGGAAGGAAAGTTGTTTTGGGATCTCTGCACCCTCAGCCTGGACAACTTGTGCCCATCTGGTGACCCCTCACTCAGC 7E:EEGFEHFBCKFHBCFAFHHHGKIFJHJEGLKHIJHEJKHJJGFFFMJMGHJHIILLKFCEKDEGCEBCIHHHIIIHCHILH2@?CFHFFIDHBJF### X0:i:1 X1:i:0 XC:i:99 MD:Z:99 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.78137857 147 17 1530 60 101M = 1262 -368 CCTTCACAAGCCCCTGGAAGGAAAGTTGTTTTGGGATCTCTGCACCCTCAGCCTGGACAACTTGTGCCCATCTGGTGACCCCTCACTCAGCCACCAGACTT ABFCBF?CIG>:EHJIIFMHICFMDKIFGLJGIIJJLKLKJKKHJLKLJLMJMJLJJLJJKBJHIHLEHIJJJLIHIEKIKKJFHKJIKHEGGEHKFGCH? X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@C@ +ERR229776.95913538 83 17 1542 60 66S35M = 1208 -368 TTGCTTTTGTGCTACATGTGCAGGGTTGTGTACTCAAGTAGTCGGATTTCCCTCTTTTCCAAAGCTCCTCGAAGGAAAGTTGTTTTGGGATCTCTGCTCCC #######################################################################>D:3EHI?IE5(9=?>*B7/&<-1%')&(+ X0:i:1 X1:i:0 XC:i:35 MD:Z:3G27A3 RG:Z:ERR229776 AM:i:25 NM:i:2 SM:i:25 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.72241554 83 17 1597 60 101M = 1365 -332 CCATCTGGTGCCCCCTCACTCAGCCACCAGACTTCCACGACAGGCTCCAGCCTCGGCACCTTCAGCCATGGACAGTTCCGCCAGCGTTGCCCTCTGTTCTG AFD@BGEBA;"GGBFAB:E>CG@=@@DEKA5AGF?>;:GACD@BADBEGG:CGAEED>G?IDHKJJJFFJIGIKHJII?HGFIH?BIDGCB>FEBCGEEFA X0:i:1 X1:i:0 MD:Z:10A90 RG:Z:ERR229776 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:CH@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.50673799 83 17 1617 29 13S87M1S = 1336 -367 GTGACCACTCCCTCAGCCACCAGACTTCCACGACAGGCTCCAGCCTCGGCACCATAAGCCCTGAACAATTCCGCCAGCGTTGCCATCTGTTCTGATGTTTG ##############IG@:;@@:B>DC7#8E;D5,*=:#57*824:?GE@<;,9GAAC53?@EGGHLHLHFHIHKHIHHGHHFFHGFJFB X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:A@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@AA +ERR229776.26840652 147 17 1635 60 101M = 1389 -346 GACAGGCTCCAGCCTCGGCACCTTCAGCCATGGACAGTTCCGCCAGCGTTGCCCTCTGTTCTGCTGTTTTCTCTACCAGAAGTGCCCTTCCCTCCTCACCT @==<5E?8GIMJCDHAIIHIE?EJ?MHED?IHFAGDBEAB.5:>9A6>BB@)=?EI################################ X0:i:1 X1:i:0 XC:i:70 MD:Z:70 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.76819541 99 17 1638 60 101M = 1879 341 AGGCTCCAGCCTCGGCACCTTCAGCCATGGACAGTTCCGCCAGCGTTGCCCTCTGTTCTGCTGTTTTCTCTACCAGAAGTGCCCTTCCCTCCTCACCTGAC A@BDIEAE>'?CB@FHJ:JJDD==8EIHJ?KJLFCGGKHCEED:BHIKDHAF>FDAIGGGICHIHIEHLI4AFIFDJAHD X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@F +ERR229776.37392358 99 17 1651 60 49M52S = 1874 323 GGCACCTTCAACCATGGACAGTGCCGCCAGCGCTGCCCTCTGTTCTGCTGCTTTCTCTACCAGAAGTGCCCTGCCCTCCTCACCAAACCACTCTGGGGAAA +(23:@9=7:':++?;8E:@E?('1*?EFE=2&225(6;=+5::AAEH##################################################### X0:i:1 X1:i:0 XC:i:49 MD:Z:10G11T9T16 RG:Z:ERR229776 AM:i:25 NM:i:3 SM:i:25 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.5880975 147 17 1658 60 37S64M = 1423 -298 CACCAGACTTCCACGACAGGCTCCAGCCTCGGCACCTTCAGCCATGGACAGTTCCGCCAGCGTTGCCCTCTGTTCTGCTGTTTTCTCTACCAGAAGTGCCC ######################################CKEAGEDB@?CKCKLF+35/*:4+&+&/1410')677 XC:i:38 MD:Z:8A5C18T4 RG:Z:ERR229776 AM:i:29 NM:i:3 SM:i:29 MQ:i:29 XT:A:M BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.25705936 99 17 1670 60 101M = 1870 298 AGTTCCGCCAGCGTTGCCCTCTTTTCTGCTGTTTTCTCTACCAGAAGTGCCCTTCCCTCCTCACCTGACCACTCTGGGGAAATCCCTCAGCACCCTCCCTG 9FD8A?B>;GHIFJC<7@CEJHEBE=HKI@?AHD;A#@/<>C*5DFGFIJCDAK?A>G@ X0:i:1 X1:i:0 MD:Z:22G78 RG:Z:ERR229776 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.66536220 147 17 1680 60 101M = 1466 -314 GCGTTGCCCTCTGTTCTGCTGTTTTCTCTACCAGAAGTGCCCTTCCCTCCTCACCTGACCACTCTGGGGAAATCCCTCAGCACCCTCCCTGAGCATACCCT E=DEHEFGIJIJHIKIJIIJGFHKKGJHIHEGKGJKDGJGGKMJILKKIIHC@JKIIFFF@JKKJLLLKJKIKLKJKJLIHCKFIJJJHHFKGHHGDD@CB X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.46562341 147 17 1781 60 7S94M = 1476 -398 ATACCCTACTCTGGCACAAGCCCACCCTGCAAAGCCCCTGAGGCCCGCCCTGTGGCGTCTCTCCCTCCCTTGCTGTCAGGACAGTGGTCCTGGCCACCGGG ########CGDDFFIHD@FC8?DICDBFEHDF4684;EA>;8EHE<<5CCC=;7@:0<>@:D=CA>7:49*:CIHIFCH>?GJ;86/9<;??F=1+A?3(=64;:?::,CABHJIHIFIGLFEHGKBECBGA@FAB>>C<;ADCDECA>:AEIEH>BHHIHFIJH@HHEEFFEFDHGJFGCGECGEGG@BCE<@C?F@C X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.59635540 99 17 1831 60 101M = 2100 369 TCTCTCCCTCCCTTGCTGTCAGGACAGTGGTCCTGGCCACCGGGGCTCACGGAGCCGCCCTGTGCCGTGTACCTCTGAGCCCTCTGCACAGTGCCTTCTGC =BH99E@;GBAECD9;GFFJJDAFGF=;?DHKFH:4CEJ>C9B@@B?GBD?1083@;AKHLGIGHGFLHMIIAE:?HHIHKDGJF> X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.80549332 99 17 1853 60 69M32S = 2041 288 GACAGTGGTCCTGGCCTCCGGGGCTCACGGAGCCGCCCTGTGCCGTGTACCTCTGAGCCCTCTGCACAGTCCCTTCTGCTTGCCTGTGGCTTTGAGAAGAA 9>;>5D<6:5;?EAD@@98.8??<+:4@HG:)./=:GE.)337?BJ:GB=;=E################################# X0:i:1 X1:i:0 XC:i:69 MD:Z:16A52 RG:Z:ERR229776 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.25705936 147 17 1870 60 2S99M = 1670 -298 CTCCGGGGCTCACGGAGCCGCCCTGTGCCGTGTACCTCTGAGCCCTCTGCACAGTGCCTTCTGCTTGCCTGTGGCTTTGAGAAGAAACCCCTTCTGGTTAT ###8DBED@G@G69@8GCMCIFGFKG;>E9=BH>B@0FCEHKIJHEF7@JJHIFIJJLIDGC5D=AAEHCI??EIHD?BGEF:G@CH=AFKEC;E4 X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.11564716 99 17 1934 60 101M = 2208 374 GCCTGTGGCTTTGAGAAGAAACCCCTTCTGGTTATACATAAGACAGCCAGAGAAGGGAGTTGCCCAGGGTGGCACAGCACGTTGCTGCCAGTTACTGCCAT +9DH=77>D@7G;?E=F:@CJG=BFIFFH:7HDCF?A@CHEIBDH?IHILFHKKDIE;9;9AEECHFC82:AHJIIGHIF@GFCIL>IFJIGE X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@G +ERR229776.65159506 163 17 1948 60 101M = 2208 360 GAAGAAACCCCTTCTGGTTATACATAAGACAGCCAGAGAAGGGAGTTGCCCAGGGTGGCACAGCACGTTGCTGCCAGTTACTGCCATTTTCACAGGCATGA 4DEEEFCDEEAKDFJCDCDGHHGHHHBJDGFFIKJJIBJLCIJHKGCICIJIKCCDFBJKIJKKJHBIJHIMHIHKGIHDGLEIHJIHFFGJGGGAEEE@F X0:i:1 X1:i:0 MD:Z:93G7 RG:Z:ERR229776 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@H +ERR229776.44568317 99 17 2014 60 101M = 2277 363 GTTGCTGCCAGTTACTGCCATTTTCACGGGCATGAAATGGAGATAACAACAGGAGCGACCGCACAGGCTGCTGAGCGCGTCACACGCAGCCATCGCGCAGC ADBEEIBEC@@EGAFEFIH@GEEHGGG?GDBHGBJKJGFGHFIFFKGJLFEKJGCFABGG?BGABEDEGFDKGIGH@H@FDGFIG97AE@FBH>@D599*/FHEC@47?560FEGBHEA:AB6-E1+A8?*+:LGHHCC2>+>2>HEACGFH:A/A>: X0:i:1 X1:i:0 MD:Z:0G100 RG:Z:ERR229776 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:gPC@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.71965236 163 17 2100 60 101M = 2416 416 CAGCCATCGCGCAGCTCAGGGATATTACGTGTAACTCGACATGTCAGCGATTGTCACAGGCACTGCTACTCCTGGGGTTTTCCATCAAACCCTCAAGAGCT BGEFEGHG=H>HHJIKKHKKKKIIIJIIAIGIIKHMKAJJKKJJJKMMCLKLJKKJGGKGJJHLDIKHEKGHKHEBC8C4DHHHJEDCKHEEDBHDDHCFB X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.59635540 147 17 2100 60 101M = 1831 -369 CAGCCATCGCGCAGCTCAGGGATATTACGTGTAACTCGACATGTCAGCGATTGTCACAGGCACTGCTACTCCTGGGGTTTTCCATCAAACCCTCAAGAGCT AF>>BHJ>G:IHLFDEILDDDCFFFFH>FHGHDELL=JKGKKJLCNJ;EILIGLJJHMHF;5JIFJIFE@CFIKHGFILKJF>EEGHG@KI;JHIIGEIFHG>GCBBJEIBJFCGJBGBFLJHMGHNJHAD111AJECDFHMDDHFIHHD;HDCLF9:@CJDCBB6>DCDHD X0:i:1 X1:i:0 MD:Z:0A100 RG:Z:ERR229776 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@CB +ERR229776.8956867 163 17 2145 60 98M3S = 2440 388 AGCGATTGTCACAGGCACTGCTACTCCTGGGGTTTTCCATCAAACCCTCAAGAGCTGGGCCTGGGGTCAACTTCCGGCCTGGGGAAACTGGGGCAAGTATC :CE=FGDF9>@BGGD?F@<;GECFLIHKI>FA.>?@>GIIDILLH?EJFFCDKKJIDFGF=CGFFDCC>HEDHLHECBFGBB#### X0:i:1 X1:i:0 XC:i:98 MD:Z:98 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.11564716 147 17 2208 60 101M = 1934 -374 GGGTCAACTTCCAGCCTGGGGAAACTGGGGCAAGTATCACCAGAGATGAGCTTTATAAAAATAATGGTGCTAGCTGGGCATGGTGGCTTGCACCTGTAATC BDDHFEGHHJGIMJDCLIKKICHLJKMJLLILNJJJECBJJLMMLJKLMLJLMJKKLLKKKJJKJKIIHLJLLLJJJJGHIHHGJKIHHG?CDHGEFGFG? X0:i:1 X1:i:0 MD:Z:12G88 RG:Z:ERR229776 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:GIF@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A +ERR229776.65159506 83 17 2208 60 101M = 1948 -360 GGGTCAACTTCCAGCCTGGGGAAACTGGGGCAAGTATCACCAGAGATGAGCTTTATAAAAATAATGGTGCTAGCTGGGCATGGTGGCTTGCACCTGTAATC B@?IBDAGFFGIMIGIJHHF@JKKDKJGJJFJMGEECBBBFLIFKIIKLKGLJIIIJIIJHIIHCJE>GGBDFDFDBE>GB<1=CEEEDA X0:i:1 X1:i:0 MD:Z:12G88 RG:Z:ERR229776 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:GEA@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@C +ERR229776.13912851 0 17 2209 37 101M * 0 0 GGTCAACTTCCGGCCTGGGGAAACTGGGGGAAGTATCACCAGAGATGAGCTTTATAAAAATAATGGTGCTAGCTGGGCATGGTGGCTTGCACCTGTAATCC G>@GOFHFC>LGG@95'JIG;MCHHI"7::5G:FDH3K8LDFFP?IEPG@IHMPOPJBPRH@B?@=,:DLOFDEJQDDC<>?KL=CB0=INF5AEF>:5@GIKIIJJLIHJOKGFGMMKLLJMHEJ?JLLKJIMMMIJFKAJLMJKKHJEBJJJLHLLIHEF=JEKGEHHFHEFGFFC X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.68077221 99 17 2314 60 39M62S = 2563 345 TCTTTGGGAGGCCGAGCTAGGAGAATCGTTTGATTCCAGCAGTTTGAGACCAGCCTGCCCGATACGGCAAATCCCAGTCTCTATAAAAAATACAAAAAAAA +-;)5(221::@C/3&8F842:3'0.:",+0D;)8+?B############################################################### X0:i:1 X1:i:0 XC:i:39 MD:Z:0A22G9G5 RG:Z:ERR229776 AM:i:25 NM:i:3 SM:i:25 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.60999876 83 17 2359 60 18S83M = 2117 -324 GTTTGAGCCCAGCAGTTTGAGACCAGCCTGGCCAATACGGCAAAACCCAGTCTCTACAAAAAATACAAAAAACAACTAGCCAGGCGTGGTGGTGCACTCCT ###################KF=>C=:%+.80/;CB@30C3==;.G::HD<*(G>4-34(;8<6/209>(364-/+);7B X0:i:1 X1:i:0 XC:i:83 MD:Z:79A3 RG:Z:ERR229776 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.71965236 83 17 2416 60 101M = 2100 -416 CTAGCCAGGCGTGGTGGTGCACACCTGTAGTCCCAGCTACTCAGGAGGCTGAGGGGGAAGGACTGCTTGAGCCCAGGAGTTTGAGGCTGCTGTGAGCTGTG @FJEBBBDE:EGEDEFGI@=0<=DHIHJNHIC=@HID@=HHDJEIIKJEI>JDIGEDB@D@CFHHCIJIKHIJGJJEHJHGGFGGB@EEFECEDDA X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.2016000 163 17 2435 60 101M = 2660 325 CACACCTGTAGTCCCAGCTACTCAGGAGGCTGAGGGGGAAGGACTGCTTGAGCCCAGGAGTTTGAGGCTGCTGTTAGCTGTGATCGCATCACTGCATTCCA ?GEFDFKHHGGIIJJHGFKHILLIJKGHEILHKHILLFKMMCKJMJLMJBLBHFIJGHLJEGIBJCDHKGFKHIDIIHL?BCHII=FEFEJGMHHHGGFDF X0:i:1 X1:i:0 MD:Z:74G26 RG:Z:ERR229776 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A +ERR229776.101388755 99 17 2440 60 101M = 2722 382 CTGTAGTCCCAGCTACTCAGGAGGCTGAGGGGGAAGGACTGCTTGAGCCCAGGAGTTTGAGGCTGCTGTGAGCTGTGATCGCATCACTGCATTCCAGCCCG :A=DCC7@?;FBBGB::?8*=@5>D7>HBF3B?C?F8@EG?BBCC:??EIE?FH8=:B/<=>HFGGG?CA8G@2AJHKHCF>D@H<=CDC; X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.8956867 83 17 2440 60 7S94M = 2145 -388 TGCCCACCTGTAGTCCCAGCTACTCAGGAGGCTGAGGGGGAAGGACTGCTTGAGCCCAGGAGTTTGAGGCTGCTGTGAGCTGTGATCGCATCACTGCATTC ########JC@GC<>6&):BC;<;AA=81?E=DEDD@9 X0:i:1 X1:i:0 XC:i:94 MD:Z:94 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.13231970 99 17 2448 29 6S29M66S = 2649 301 ATAATGCCAGCTACTCATGGGGCTGAGGGTTAAGGACGGGTTGAGCCCAGGAGTTTGAAGCTGCTGTGAGCTCTGATGGCATCACTGCATTCCAGCCCGGG +2;*;'0.135EB7H?<.2.=&01>3>B<######################################################################## XC:i:35 MD:Z:11G1A9G0G4 RG:Z:ERR229776 AM:i:29 NM:i:4 SM:i:29 MQ:i:29 XT:A:M BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.25467915 99 17 2456 60 101M = 2477 121 TCAGGAGGCTGAGGGGGAAGGACTGCTTGAGCCCAGGAGTTTGAGGCTGCTGTGAGCTGTGATCGCATCACTGCATTCCAGCCCGGTGACAGAGTGAGTCA BBFCAGBCDE@HHHFGIIIHIIEIEHJI:@CHIJFKKIGGGIJJJKKLFHDJHHHFGHDGFFHEKJJJJJLLMJILLIKIIJIFDBG/GIIFHJGHHJEFEC X0:i:1 X1:i:0 MD:Z:87A13 RG:Z:ERR229776 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@B +ERR229776.3800945 83 17 2522 60 9S92M = 2266 -347 TGTGATCGCCTCCCTGCATTCCAGCCCGGTGACAGAGTGAGTCACTGTCTCAAAAAAGAAAGGAAGAAATAAAGAAAACAAATAAAAATAATAGTGCAGAC ##########G@=CCE>,EA<<>4:JCGBE<==KJGIGID@G<7?IEB@'C@91F>9EB<(5=G?>JGCB@7AGE;41D;95BF<:DCH6FC:29('/EBFDE=AAEEGGIEGJ';FIIKGHEJHEJKKKHILHIIFFJHLKJJLKGKJILMKALILCJJDLIKHMKKKJKJINJKKKLJKJMGHAIMIHJHIE>FA X0:i:1 X1:i:0 MD:Z:18A82 RG:Z:ERR229776 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:GLI@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@C +ERR229776.13231970 147 17 2649 29 101M = 2448 -301 ATCAACCGCTAGATACGTCCCTCCCTTTCTTCTGGGGCACAGGTCACACTCTCTTCCAGGTCTAGGATGCAGCTGAGGGGTGCCCCTCTTACCATCTAATC 6F=CA96B-EEGF620>,*965AB>=EF?,DCKEEE>?HBE@B@0 X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:29 NM:i:0 SM:i:29 MQ:i:29 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.44981660 163 17 2656 60 101M = 2879 323 GCTAGATACGTCCCTCCCTTTCTTCTGGGGCACAGGTCACACTCTCTTCCAGGTCTAGGATGCAGCTGAGGGGTGCCCCTCTTACCATCTAATCTGTGCCC ?EIFFHHGF?FIIJJIJHLJJKLJIIIICBIIIJHIEHEHJIMLJJMBIIJHFJJKJ>?FGJKKMMNIJHKHBACEGIHFIMFIGIJHILFEHHGDFEFED X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ACD +ERR229776.2016000 83 17 2660 60 101M = 2435 -325 GATACGTCCCTCCCTTTCTTCTGGGGCACAGGTCACACTCTCTTCCAGGTCTAGGATGCAGCTGAGGGGTGCCCCTCTTACCATCTAATCTGTGCCCTTAT B?C4=DGB8HJCCIKFGBDHCFGGGHHHGLHDGFCEBBKBIJIHEDLKHKDJLKJHGDEGA;GJKJF@GHBBB>C>EDDGF;CCEBGAIGB@DA:=:CE9A X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@C +ERR229776.74190027 163 17 2668 60 98M3S = 3014 419 CCTCCCTTTCTTCTGGGGCACAGGTCACACTCTCTTCCAGGTCTAGGATGCAGCTGAGGGGTGCCCCTCTTACCATCTAATCTGTGCCCTTATTTCCTCTG CEIFEFKHHHIIIHIJHJIIHIJKFHGGHGKKLKLJMMJKLFJLJKLKJJMKMMMLLKMMJFKJIIINGKJJIHJHJMIFKIMHJIJIIMFIIJJEF#### X0:i:1 X1:i:0 XC:i:98 MD:Z:98 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:EG@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.31785601 117 17 2710 0 35M66S = 2710 0 AGGCAGAGACCTGATCACGGATCACAGCCGCCTCAAACTGTTGGGCTCAACCTGAACGTCCCTTCTTGCCTGGTTAGTTGTTCGGACTACAGGTGTGCGCC ########################################################################################B37.<90;7((/= XC:i:35 RG:Z:ERR229776 +ERR229776.31785601 185 17 2710 37 101M = 2710 0 CTAGGATGCAGCTGAGGGGTGCCCCTCTTAGCATCTAATCTGTGCCCTTATTTCCTCTGCGTTAGTGAGGAAGAGGCCCCTGGTCCATGAAGGGGCCTTTC >AF>>=C6,*58,CCC(%(,9FB?E8$4EIA7/,E@HCC@G?.IGHGC7FB7FF-C=@E;DGGABBEGEEDEG: X0:i:1 X1:i:0 MD:Z:30C29T40 RG:Z:ERR229776 AM:i:0 NM:i:2 SM:i:37 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.101388755 147 17 2722 60 101M = 2440 -382 TGAGGGGTGCCCCTCTTACCATCTAATCTGTGCCCTTATTTCCTCTGCTTTAGTGAGGAAGAGGCCCCTGGTCCATGAAGGGGCCTTTCAGAGACGGGGAC 5BFEDECIICCBFJHKFIEEHEHIIIJHJEIIBA>KHGKHKDFCFBGBALIGIIIILJCIGLIIIF=HIKHKIIIIKJKHHHC8BKJE=JAIF??FDEFG? X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A +ERR229776.3777343 99 17 2723 60 101M = 2891 268 GAGGGGTGCCCCTCTTACCATCTAATCTGTGCCCTTATTTCCTCTGCTTTAGTGAGGAAGAGGCCCCTGGTCCATGAAGGGGCCTTTCAGAGACGGGGACC A@BCCA28?A:FJFG>FFH>FIHHKGIKG8@HIGIIFHIJFJKKKCGLJJ8FDFHCEEJFE;>@GHHK@DCCGGIGIIGD?@FFIHHIJHJA:?:>E@C9: X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.16418187 163 17 2727 60 94M7S = 2953 318 GGTGCCCCTCTTACCATCTAATCTGTGCCCTTATTTCCTCTGCTTTAGTGAGGAAGAGGCCCCTGGTCCATGAAGGGGCCTTTCAGAGACGGGGACCCCTG ?=GEEFFEJFEDGCHG?B8@JHIKG7CFHHGAFIJJKEFJ9=FABI@C1;HIFHEIHIJJ>EILKBE9EA>CLGH7:C(<0EDGJDKFKH:@@######## X0:i:1 X1:i:0 XC:i:94 MD:Z:94 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:B@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.60225376 163 17 2734 60 88M13S = 3018 318 CTCTTACCATCTAATCTGTGCCCTTATTTCCTCTGCTTTAGCGAGGAAGAGGCCCCTGGTCCATGAAGGGGCCTTTCAGAGACGGGGACCCCTGAGGAGGC 4ED@3FDDF@=JG?HEB=2;ACGD>EFJ>>8@FLA5C>BGF*08=&*4<*7%<))4@?:HAFJ>?HD>EJD:@,<:=CC############## X0:i:1 X1:i:0 XC:i:88 MD:Z:41T46 RG:Z:ERR229776 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.107194084 163 17 2742 60 101M = 3015 367 ATCTAATCTGTGCCCTTATTTCCTCTGCTTTAGTGAGGAAGAGGCCCCTGGTCCATGAAGGGGCCTTTCAGAGACGGGGACCCCTGAGGAGCCCCGAGCAG ?EFJFJHGJGFHIJJKIHIJJKHLILIKMJKHJFJGJJKMMLKJAIILMLMJMMIJLLMIGFDFJMKJKKJMKJG>GGC;@GFFB=E@CC@FEHH@2;AD@ X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.107791703 99 17 2817 29 1S34M66S = 3127 380 GGGGTACCCCTGATGAGCCCCGTGAAACAGCCGTCGATTCTCACCCGGGGGGTCGGAAACAGGTGGGGAGGTCTGGGGAGGGGCGTGGCGCAGCTGCGGGG ##################################################################################################### XC:i:35 MD:Z:3G8G8A1C1G8 RG:Z:ERR229776 AM:i:29 NM:i:5 SM:i:29 MQ:i:29 XT:A:M BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.11825404 97 17 2834 37 101M * 0 0 CCCGAGCAGCAGCCGTCGTGTCTCACCCAGGGTGTCTGAAACAGATGTGGAGGTCTCGGGTGAGGCGTGGCTCAGATACAGGGAGTGGCCCACAGCTCGGC AE<EFC?E?>D>GFDFKGIGIHGFIGEGGC5<@FIHFGFCEKG5)+9<:AA=E9;7/"FC?D@7CK8BE@FDFEAH;96D=52;AE7-A8<88CGAB X0:i:1 X1:i:0 XC:i:82 MD:Z:82 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.52739527 147 17 2867 60 101M = 2567 -400 GTCTGAAACAGATGTGGAGGTCTCGGGTGAGGCGTGGCTCAGATACAGGGAGTGGCCCACAGCTCGGCCTGTCTTTGAAAGGCCACGTGACCTGGCCCACG BGDEGGC9EMIIJHHFIIFDDFHAHFFIGIGH?GIIIGKJMIJIJJMIIJMHIFHLMJJJLKJFCLKEKJIKJMMILJJLKJKFHAHFIH4HGFHEDFF:? X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A +ERR229776.44981660 83 17 2879 60 101M = 2656 -323 TGTGGAGGTCTCGGGTGAGGCGTGGCTCAGATACAGGGAGTGGCCCACAGCTCGGCCTGTCTTTGAAAGGCCACGTGACCTGGCCCACGGCTGGCAGGTGG FEGDHIE?F;G9HHEG>HEA8FIFHGICNGFEBJIKJHHH>CBB8:62:A@6?HGCH37(;9@;?ABD>BF<>CC7,2::8>G)17?GBF-:@CH<;CCHAE=:;DBCAEC@(9>B:?D48AKHFGHFDD:CFIHGFICA#### X0:i:1 X1:i:0 XC:i:98 MD:Z:6G90T0 RG:Z:ERR229776 AM:i:37 NM:i:2 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.3777343 147 17 2891 60 101M = 2723 -268 GGGTGAGGCGTGGCTCAGATACAGGGAGTGGCCCACAGCTCGGCCTGTCTTTGAAAGGCCACGTGACCTGGCCCACGGCTGGCAGGTGGGACCCAGCTGCA DEAGCHE=>EIHIIKFHDKIIFMHIIIFFFGAECECHFDFAHICGJHLHMKIJJKLHJG:<1<@C6*>EA6*07D;A@D? X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@C@ +ERR229776.16418187 83 17 2953 60 8S93M = 2727 -318 AAGGCCACGTGACCTGGCCCACGGCTGGCAGGTGGGACCCAGCTGCAGGGGTCCAGCAGCACCCACAGCAGCCACCTGTGGCAGGGAGGAGCTTGTGGTAC #########GAG=;7FE7:)C>E?;:EF???JBJCE:GEA=9<77IE@<=F?>@BCJKGGJ>97-<5?A?EA@D;HDI@GI;67A7ECBED= X0:i:1 X1:i:0 XC:i:93 MD:Z:93 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.89222254 163 17 2970 60 96M5S = 3189 319 GGGCAGGTGGGACCCAGCTGCAGGGGTCCAGCAGCACCCACAGCAGCCACCTGTGGCAGGGAGGAGCTTGGGGTACAGTGGACAGGCCCTGCCCAGATGGC 05=DFGE/BD@I+:FG?E6EGIJBFG?DEHFH@AFDBGG:ED;DICIHIGHMF1;@ECBD@+<:+>)@9B&=66<:=BB>>>6>DC*?@EC:BEG###### X0:i:1 X1:i:0 XC:i:96 MD:Z:0T69T25 RG:Z:ERR229776 AM:i:37 NM:i:2 SM:i:37 MQ:i:60 XT:A:U BQ:Z:CFK@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.25895864 99 17 2976 60 101M = 3273 397 GTGGGACCCAGCTGCAGGGGTCCAGCAGCACCCACAGCAGCCACCTGTGGCAGGGAGGAGCTTGTGGTACAGTGGACAGGCCCTGCCCAGATGGCCCCCCG CECCCG@DEA:DJ@HEGGBB8B@FEHHJAEGII>EBC@D>AGGFHKIIF<@IJIAEA@=>EGIB@EDBCBFA4<D=)8?ACC. X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.74190027 83 17 3014 60 27S74M = 2668 -419 CTGCGGGGGTCCAGCAGCACCCACAGCAGCCACCTGTGGCAGGGAGGAGCTTGTGGTACAGTGGACAGGCCCTGCCCAGATGGCCCCCCGCCTGCCTGTGG ############################D?8789?>6?51:D>5.@4:9<:92:5295A3.38;:37:52DE@CECGEC X0:i:1 X1:i:0 XC:i:74 MD:Z:74 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A +ERR229776.107194084 83 17 3015 60 6S95M = 2742 -367 CCAGCAGCCACCTGTGGCAGGGAGGAGCTTGTGGTCCAGTGGACAGCCCCTGCCCAGATGGCCCCCCGCCTGCCTGTGGAAGTTGACCAGACCATCTGTCA #######??68;7GC=7+0FDEED77(+DG76<3/%*=4-<<1+21"A8;<&<43-:6,5@AACGD?>A@9BB>B8:AIHJBDFC@BDJE9ADEDEECFAA X0:i:1 X1:i:0 XC:i:95 MD:Z:29A10G54 RG:Z:ERR229776 AM:i:37 NM:i:2 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.60225376 83 17 3018 60 66S35M = 2734 -318 CGGGGCCTGGCCCTGGGCTGGCAGGTGGCCCCCAGCTGCTGGGGTCCAGCAGCCCCCACAGCAGCCACCTGTGGCAGGGAGGAGCTTGTGGTACAGTGGAC ########################################################################7E=CA(5.6;4=DE?= X0:i:1 X1:i:0 XC:i:35 MD:Z:35 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.4450150 163 17 3027 60 101M = 3312 354 AGGGAGGAGCTTGTGGTACAGTGGACAGGCCCTGCCCAGATGGCCCCCCGCCTGCCTGTGGAAGTTGACCAGACCATCTGTCACAGCAGGTAAGACTCTGC ?C@DCGEFFGFIGFHGE@@HIIIIK?FJIFHKMKKIIJHLJLFJJLHII5 X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.49925000 147 17 3075 60 101M = 2880 -295 CGCCTGCCTGTGGAAGTTGACCAGACCATCTGTCACAGCAGGTAAGACTCTGCTTTCTGGGCAACCCAGCAGGTGACCCTGGAATTCCTGTCCATCTGGCA DFCCIKEEIHFAJIHJIFHKFKGEDLB>LIJJMACCJJMJIEJGJJIF4FLIJ@HDDLJJKFFNHJKJIGIJCEIJE@@CBCGJHHHGDHCI@> X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.107791703 147 17 3127 29 30S71M = 2817 -380 AGACCATCTGTCACAGCAGGTAAGCCTCTGCTTTCTGGGCAACCCAGCAGGTGACCCTGGAATTCCTGTCCATCTGGCAGGTGGGCATTGAAACTGGTTTA ###############################IG++HE>E<12.@99BCEF@6EG6BC,E(BF:>:>GELHDAC9@9GEF>G>CAE;& X0:i:1 X1:i:0 XC:i:71 MD:Z:71 RG:Z:ERR229776 AM:i:29 NM:i:0 SM:i:29 MQ:i:29 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.99540436 147 17 3147 60 101M = 2895 -352 GTGACCCTGGAATTCCTGTCCATCTGGCAGGTGGGCATTGAAACTGGTTTAAAAATGTCACACCATAGGCCGGGCACAGTGGCTCACGCCTGTAATCCCAG CDDFEFHKHIFIHHGIJGJGIGJHIFJILGHKIIKKKMJJKKGKKMKNMJLKKKJIHJIFB:LJJJLKKI>LLKIIJLJIJHKJIHAGEIFFGHHIDDDH? X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.89222254 83 17 3189 60 101M = 2970 -319 ACTGGTTTAAAAATGTCACACCATAGGCCGGGCACAGTGGCTCACGCCTGTAATCCCAGCCCTTTGGGAGGCCAGGGTGGGTGGATCACTTGAGGTCAGGA FCEFEJGIFHFHEHHJCGHIDBD@LEB=8@DG>B:>53+14)A:2'DEFGA5-<39?C9DBGK?HEC>ED9#7HA2>C1ED@E6AH<@GD@GCIDBA X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:A@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.27664076 99 17 3197 60 101M = 3465 347 AAAAATGTCACACCATAGGCCGGGCACAGTGGCTCACGCCTGTAATCCCAGCCCTTTGGGAGGCCAGGGTGGGTGGATCACTTGAGGTCAGGAGTTCAAGA ABGGGEB;@78DCAFCGH8@F?=6;%806CHHI?H018D0;AGH@HHH<;GAB/?AF8EA)9@H@A@??HBEEGCFF2>:<:GBBF?IF=BHCEFGCJI?=:GFEAIFGHG8DD@HJKJLFBHHI5AJEJFFEE33?E@DJEFIIFHHFIGGHHEHID5DC<JMMBJLKIEKJLLKJIIFKJKKKJLILKIJIJG=EGJIHJI>DGGGHEFFEFC X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@E +ERR229776.31259015 99 17 3281 60 101M = 3514 333 AGGTCAGTATTTCAAGACCAGCCTGGCCAACATGGTGAAACCCCGTCTACTAAAAATACAAAAATTAGCCTGGCGTGGTGGCGCATGCCTGTAATCCCAGC 7<8ACD<-.&)9:<<@7;9@HDCI>>/:<@@HFBBIBAI;=7;DAFC8<-@@==+,BFFC7ADBJBGE:I9;)B?CA;;;=3FFHFBD;HLG################## X0:i:1 X1:i:0 XC:i:84 MD:Z:84 RG:Z:ERR229776 AM:i:0 NM:i:0 SM:i:37 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.32427229 99 17 3347 60 101M = 3572 325 AGCCTGGCGTGGTGGCGCATGCCTGTAATCCCAGCTACTTGGGAAGCTGAGGGATGAGAACTGCTTGAACCTGGGAGGCAGACGTTGCAGTGAGCTGAGAT A@FDIE@E<;BFD@?C?IFEHHFIIEGKEFFJHJKKIHLIHKKDLIKLJKGJLIIIJGEJFIIEKGFFJGFKGEEGBFFIHJFAGCDIJIIHJHILGIFGE X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.26612274 83 17 3349 60 101M = 3093 -356 GCTGGCGTGGTGGCGCATGCCTGTAATCCCAGCTGCTTGGGAAGCTGAGGGATGAGAACTGCTTGAACCTGGGAGGCAGACGTTGCAGTGAGCTGAGATCA #BDDB:FIECE==:A@AJGDA57C;A@='>?CCFEHF?@C@LDF>HHIKHHE4C@DJHH:?FGHAA@?IEDB;D7>@D79G:?BE<9?BICDGAA X0:i:1 X1:i:0 MD:Z:0C33A66 RG:Z:ERR229776 AM:i:37 NM:i:2 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@F@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.38128366 99 17 3399 60 101M = 3700 401 GATGAGAACTGCTTGAACCTGGGAGGCAGACGTTGCAGTGAGCTGAGATCACGCCACTGCACTCCAGCCTGGGCAACAGAGTAAGACTCTGTCTCAAAAAA =@ECEC9@>E?IDACD8?>HG;C?@=9FCE5?BDCGA>D?>AI=74CH376*:+0;EHKDB->;E;B6,57,I>=FB)20=2490BFGGBDGD?;C,0@07H@0CF10+9D14:CDEEE9@@GCDBD>>@ X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A +ERR229776.27664076 147 17 3465 60 21S80M = 3197 -347 AGACCACGCCACTGCACTCCAGCCTGGGCAACAGAGTAAGACTCTGTCTCAAAAAAAAAAAAATCACACCATTTTGGCTTCAGATTGCATATCCTCCTGCA ######################CDIGFIBHGBG9C>ECG9:6A;.<4:<=ACIIKKJJHLKKIFEEBAJHHCMKJJKIEJGLHAGHHEHGFIGFHEEFEC? X0:i:1 X1:i:0 XC:i:80 MD:Z:80 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A +ERR229776.46260219 147 17 3469 60 101M = 3225 -344 GGGCAACAGAGTAAGACTCTGTCTCAAAAAAAAAAAAATCACACCATTTTGGCTTCAGATTGCATATCCTCCTGCAAGGATATATACGCGTGAAATTCAAG B?@ABG;AFE,=D@>;FG7B956B9AABEDDDKKGIKJLGGGKCJJACFGJMKMKJMMKNKJJIJIGEHCLLIKIJLHIIHHGDHHAJ@GDHHHHJFEBHC X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:A@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.51706669 163 17 3478 60 93M8S = 3757 379 AGTAAGACTCTGCCTCAAAAAAAAAAAAATCACACCATTTTGGCTTCAGATTGCATATCCTCCTGCAAGGATATATACGCGTGAAATTCAAGTCAATGAAA BEFFIGIEJHIH:CKHHKGKLLLLLLMLMFBD48?CCC@CHIDHJCGECEDCFAHFAEH@EHGADHIJGAA-6>A@EH6/;3+;CB=DBGJC######### X0:i:1 X1:i:0 XC:i:93 MD:Z:12T80 RG:Z:ERR229776 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.38173578 147 17 3478 60 26S75M = 3262 -290 CCACTGCACTCCAGCCTGGGCAACAGAGTAAGCCTCTGTCTCAAAAAAAAAAAAATCACACCATTTTGGCTTCAGATTGCATATCCTCCTGCAAGGATATA ###########################E@FEB/<:=C?A:DB<>EEA8B;?;@6>A632:CIICIE##################################################################################### XC:i:35 MD:Z:18C6T6T2 RG:Z:ERR229776 AM:i:29 NM:i:3 SM:i:29 MQ:i:29 XT:A:M BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.31259015 147 17 3514 60 101M = 3281 -333 ATTTTGGCTTCAGATTGCATATCCTCCTGCAAGGATATATACGCGTGAAATTCAAGTCAATGACAAATCAGAAGAAAAAACATATATATACGCAAACCAGT C@AHHEHGJGFLIAKJIHFEC=BDI?HJJGDIA?DFCAKIF=L?EKLJKJLC;JLJLHKJJDJAJBF:JLIIIIIHJCIGHHD=EHHCGE9HFCDGC>I@: X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.89637749 163 17 3537 60 101M = 3762 325 CTCCTGCAAGGATATATACGCGTGAAATTCAAGTCAATGACAAATCAGAAGAAAAAACATATATATACGCAAACCAGTATCCTACTGTGTGTGTCGTTTGT ?K+=EFHGJH@JHHHIIGIAKBIIKLMJKLJMLIJJMKJLJKMMKLJCKMJLNNNMMKKKJKJKJKJHBKHFGFEJGHHGIHNIGMIMIJIJIIH@HCCAC X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@E +ERR229776.109591233 147 17 3541 60 101M = 3310 -331 TGCAAGGATATATACGCGTGAAATTCAAGTCAATGACAAATCAGAAGAAAAAACATATATATACGCAAACCAGTATCCTACTGTGTGTGTCGTTTGTTGTG EFECKIJJKKIIIJ?J?GJIFFIHKIELIKHJGKFKJJJJKJMKJMKKLLKKHJJJJJJIIIJAJIJJJLIMIIIJILIIKIHGIHHFGJ:FJJGEIFEGC X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.32427229 147 17 3572 60 101M = 3347 -325 AATGACAAATCAGAAAAAAAAACATATATATACGCAAACCAGTATCCTACTGTGTGTGTCGTTTGTTGTGTTTTCGACAGCTGTCCGTGTTATAATAATTC DEFECGJFIGIMIFFFFFFKFDIKHHJJGDFE?HBIIFDGLGFJKGKJHKIKJKKJKJJ?HJNKIMJJJIMMMKBLIJLKKIIHHAHFGKFHGHHGGFEG? X0:i:1 X1:i:0 MD:Z:15G85 RG:Z:ERR229776 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:B@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A +ERR229776.40459217 99 17 3602 60 35M66S = 3843 307 TACGCAAACCAGTATCCTACTGTGTGTGTCGTTTGCTGTGTTTTCGACAGCCGTCCGCGTTATAATAACCCCCCTACCTCAAATTTATTCACTTTCAACTC =4>@G:=EG=FKHFGG@HE6>FGA?GIIHE?HE6FJFI.:HGFJLJAJ+-5D??B9AAFEEFDD9A1@EBDIDDF?C.CDDHIFGHHHF?8DCICEF X0:i:1 X1:i:0 MD:Z:52C48 RG:Z:ERR229776 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@B +ERR229776.104546030 163 17 3615 60 101M = 3837 322 ATCCTACTGTGTGTGTCGTTTGTTGTGTTTTCGACAGCTGTCCGTGTTATAATAATTCCTCTAGTTCAAATTTATTCATTTTTAACTTCATAGTACCACAT CEFEJGEKGHFIHGGHH>HIJIIJIFGIIKKHALJJJMMJJKLBJJGJJJJNKJNKLMMNMNJLJKKJMMKKKKKIHKLFKKKIMHMKIJKKHIHFGGDFE X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@G +ERR229776.37380040 1187 17 3615 60 101M = 3839 322 ATCCTACTGTGTGTGTCGTTTGTTGTGTTTTCGACAGCTGTCCGTGTTATAATAATTCCTCTAGTTCAAATTTATTCATTTTTAACTTCATAGTACCACAT ?EFEIGEJGGAGGCGHC:EGIGIJJEHHIJJIAKIJMIKFJJI?FFGBEIJMJJCGJHJMLMFCECJIMMJKKHHFHILIKKKFEHMKIJHFHHHFFGD:B X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@D +ERR229776.83861944 163 17 3622 60 101M = 3858 336 TGTGTGTGTCGTTTGTTGTGTTTTCGACAGCTGTCCGTGTTATAATAATTCCTCTAGTTCAAATTTATTCATTTTTAACTTCATAGTACCACATTCTACAC 4=EAF@DADF9HDG=E?;DEDAACE@EFIHHLJEEH=4A@BACECFELDIDDJIA8CJJKIFDGIGBGHKIFFEJFDDBCHIHFCHHFDEGCHJDHJDJJHNNLBKKKNKMJJLLAJJJMJJJKJJHILKLLKGJLILIGIJILLIHLJGFKKJJHIHJKIGGGEAFBBFAGGECEE=DDEGDA X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:AEAD@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.25245101 99 17 3650 60 101M = 3870 320 AGCTGTCCGTGTTATAATAATTCCTCTAGTTCAAATTTATTCATTTTTAACTTCATAGTACCACATTCTACACACTGCCCATGTCCCCTCAAGCTTCCCCT A@=H=A<@,5:BF=FAIGBC>G?MAB-=GDEDB>A=GIKJKHDEFJJJB4>DACEIC6F?IEH+?@KEAEDDI X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@D +ERR229776.38128366 147 17 3700 60 101M = 3399 -401 CTTCATAGTACCACATTCTACACACTGCCCATGTCCCCTCAAGCTTCCCCTGGCTCCTGCAACCACAAATCTACTCTCTGCCTCTGTGGGTTGACCTATTC AHBEKFBFGHFEGCBDFGJJMKJMLFCFKJLLMLIIJKJKJIHJIJJJKJIIHDHJJIHHJJCIIHJGEIGFFEGFEEGB X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.45938508 99 17 3704 60 97M4S = 4005 401 ATAGTACCACATTCTACACACTGCCCATGTCCCCTCAAGCTTCCCCTGGCTCCTGCAACCACAAATCTACTCTCTGCCTCTGTGGGTTGACCTATTCTGGA BEECEE@D?@;GGHGBFG@CGD>C>:BEE=8BBC>CEGDFHEGHJJKH@2;?>H>9FFGI.0A?IGJM5B.;IEHGJ=GD:1319:GFBFBHD@FG##### X0:i:1 X1:i:0 XC:i:97 MD:Z:97 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.94413412 147 17 3754 29 1S100M = 3490 -363 CCCCTGCAACCACAAATCTACTCTCTGCCTCTGTGGGTTGGCCTATTCTGGACACGTCATAGAAATAGAGTCCTGCAACACGTGGCCGTCTGTGTCTGGCT ##?>@E>6AA@CHDGE;FBH<9<->:>BD>CHDC?EC6G-+@CD8IBB/>DDF?;A:FFDMGHFIDLJKGJCCHAIADF?2+D=??G>6?=44:B>>(:F>=97-$65=.6:<: X0:i:1 X1:i:0 XC:i:46 MD:Z:37A8 RG:Z:ERR229776 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.51706669 83 17 3757 60 101M = 3478 -379 TGCAACCACAAATCTACTCTCTGCCTCTGTGGGTTGACCTATTCTGGACACGTCATAGAAATAGAGTCCTTCAACACGTGGCCGTCTGTGTCTGGCTTCTC H6<6>CDGHFD>AIGHEH?A;HB;.;A12000BC<=:D1FJEIGFEIIGHKHGHH?91'::G@E?FCFD57GHCGFGEDCDD?.<0(,9+<2+7E@@/CAFHHIFJFE4GIICE<3HFFC-CBA<7GFIEC6GIJEFGGGGAD@+DFEDEFDIHJJAJLKKHJKLKKLMMMKKLMKCLMMJMLKJKJMIILLKKJJKJIJJIJEGGFHKDFEFC X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.21787291 163 17 3825 37 98M3S = 4149 374 CTGCAACACGTGGCCGTCTGTGTCTGGCTTCTCTCGCTTAGCATCTTGTTTCCAAGGTCCTCCCACAGTGTAGCATNCACCTGCTACACTCCTTCTTAGGG ?HDEFFDGF>>F6@H?IIIHJJJLMKBCFJ@DFLFCGHJJJJIBC757?FHCDFF#67:FH8CIHHJHIDHLHHJF#### X0:i:1 X1:i:0 XC:i:98 MD:Z:76G21 RG:Z:ERR229776 AM:i:0 NM:i:1 SM:i:37 MQ:i:0 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.104546030 83 17 3837 60 101M = 3615 -322 GCCGTCTGTGTCTGGCTTCTCTCGCTTAGCATCTTGTTTCCAAGGTCCTCCCACAGTGTAGCATGCACCTGCTACACTCCTTCTTAGGGCTGATATTCCAC C?>EIHIGICJIJFHHHJHHHI@JJMJNJKJLJLJJMMLIJIKIIKIHKIAHHKLHHIILJHIGFF@JJHFIHGD;HBHIJGHJGHHHGGBBDEBGFCCDC X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.37380040 1107 17 3839 60 2S99M = 3615 -322 GCCGTCTGTGTCTGGCTTCTCTCGCTTAGCATCTTGTTTCCAAGGTCCTCCCACAGTGTAGCATGCACCTGCTACACTCCTTCTTAGGGCTGATATTCCAC ###BIHIGICGDG=)HJHDEHI<@GGEIAGBKHLJGMKKIFKJD@DDEEG>F>EK@ICILJJHHHF;JHHFEEGC8JI=IHGDJGAFEGGB@@EBGFBEDC X0:i:1 X1:i:0 XC:i:99 MD:Z:99 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.40459217 147 17 3843 60 34S67M = 3602 -307 GGATAGAAATAGAGGCCTGGAACGCGTGGCCGTCTGTGTCTGGCTTCTCTCGCTTAGCATCTTGTTTCCAAGGTCCTCCCACAGTGTAGCATGCACCTGCT ###################################CG?+GB*7*C;F;4=HF;?F3@ECBCF(ECKHGG>9HB@<@9>9BEACF-8EE907EED?: X0:i:1 X1:i:0 XC:i:67 MD:Z:67 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.83861944 83 17 3858 60 101M = 3622 -336 TCGCTTAGCATCTTGTTTCCAAGGTCCTCCCACAGTGTAGCATGCACCTGCTACACTCCTTCTTAGGGCTGATATTCCGCGCACCTGCTACACTCCTTCTT D;GFIF=CD>D:CJHIJJEHGJD:<9:8?<:9JEHEE?<>A?BD6?C>.EJ??>AGJBGFB8694BAHHF@>?<>=9=D=F@B<3+7G@EGFB:9 X0:i:1 X1:i:0 MD:Z:78A22 RG:Z:ERR229776 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.22665016 83 17 3861 60 3S98M = 3604 -354 TCGCTTAGCATCTTGTTTCCAAGGTCCTCCCACAGTGTAGCATGCACCTGCTACACTCCTTCTTAGGGCTGATATTCCGCGCACCTGCTACACTCCTTCTT ####HHI?9>A+CJHJIIA377&041;57:=D;=3++.(:>CB=;+ X0:i:1 X1:i:0 XC:i:98 MD:Z:75A22 RG:Z:ERR229776 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.26430745 99 17 3863 60 101M = 4142 374 TAGCATCTTGCTTCCAAGGTCCTCCCACAGTGTAGCATGCACCTGCTACACTCCTTCTTAGGGCTGATATTCCACGCACCTGCTACACTCCTTCTTATGGC BEEEEEBIE>-EFFHEJHH@IFGHJHHHBCBFCCIJIIFJHHKIJKKIGI@MKLMKLJKDJBFFLJKJIDJKIJJCKIIGMHKMKGJGMIHHHHKGGDF;> X0:i:1 X1:i:0 MD:Z:10T90 RG:Z:ERR229776 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.25245101 147 17 3870 60 101M = 3650 -320 TTGTTTCCAAGGTCCTCCCACAGTGTAGCATGCACCTGCTACACTCCTTCTTAGGGCTGATATTCCGCGCACCTGCTACACTCCTTCTTATGGCTGATATT CDDHHIDHFB@,;@DICEHHEFEHHJLFE?D??ABCCGCDGCFGEJKMKHKJMIICIIFJJILKC?H?EF=IJIIJGFFAH>CB@IIHHHBGFFGGEEFA? X0:i:1 X1:i:0 MD:Z:66A34 RG:Z:ERR229776 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:A@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229776.106927739 99 17 3903 20 101M = 4098 295 ACCTGCTACACTCCTTCTTAGGGCTGATATTCCGCGCACCTGCTACACTCCTTCTTATGGCTGATATTCCACGCACCTGCTACACTCCTTCTTAGGGCTGA CDEIEEFECAAIGHIFIJGEJIHJJIJHAEHKJ8IAJHFKKHKKIJIILLELKMMKGAJJIIJHGHGIHHIG;HHCGJHHLHGCGLIELFILHC=>BBJ@G X0:i:1 X1:i:2 XA:Z:17,+4162,101M,2;17,+4088,101M,2; MD:Z:33A67 RG:Z:ERR229776 AM:i:0 NM:i:1 SM:i:20 MQ:i:1 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@C +ERR229776.86454710 161 17 3912 37 101M * 0 0 ACTCCTTCTTAGGGCTGATATTCCGCGCACCTGCTACACTCCTTCTTATGGCTGATATTCCACGCACCTGCTACACTCCTTCTTAGGGCTGATATTCCACA CEIFEKHGJHFIHJIKIJIIIJJK@KBLJJKLJKLIHJIJJIMKMMKIFHJJKJLJFJKLLJI=KJHE@JICDF-DIF9## X0:i:1 X1:i:0 XC:i:100 MD:Z:100 RG:Z:ERR229776 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ diff --git a/test/mpileup/mpileup.3.bam b/test/mpileup/mpileup.3.bam new file mode 100644 index 0000000000000000000000000000000000000000..90b325eeab72c40a2a16ba92c1349085145e2eb7 GIT binary patch literal 27569 zcmV)MK)AmjiwFb&00000{{{d;LjnLg1jSX)bJ{oq;)$nQXt(FJ8R4JclaydZTf5~nhFTjI@TwH$}Q z`3|7o0@wxW0yJ|H;YAeFy(FM1VdZ2!VNQ}KsU9dCO2^l)sHg>YObArQ6D@HZrF54* zc`kj)>_h&s&V>(4I%0E?@#qg4Vt>nv$BHbA^OBsPD`~+NG{6UD8f{BAjE{m|xfX09 zdIwbBUDpWx3##cnV+ByTY8g6qId9i~~kVkuf3Dh^ARWdnt+U^Clm|{%byHnxBp?et6sld54R_~ylVA>?1NE9P@D#2kf~p7Rl*G|8rOcC5`db1( zo$r^zrD&E+^Q{HyO`6@MpecW3NAG4tOH@6{S+i}Lgr)^2m95hd*Y`YE@QWh7y?9$B zuM{|3v<;f2by9&{B{fHZx@BmW+WeYK>UcT;TB`%pB;ym{vornMaq-j{e*g8o1KzwBmj4E=3?-mW(;iSV#-wo?;+Ar8+A|@9U}vsAQM3iL5QG^U>m^> zf?WiU5i}4yLC{3HhIGD1NB^L2XyUyW@^8cm2}fL^RaMJ2{$X|2~MH z#s*Qk4yxGWv%yP@e8$80b_9>duG4gF;8^YykZk&>0#4evIwZ>sZL;-|oFAFAMt9hlcMIclnU{wE_;^>i+HCl`h5!>qTp+9Y!7;#J$10_&248ibo$>;U3)xq zyhjuXyTRdl6?2BWTjDXt0QU*qzS3;o#JpUk$-z z$SL<-e8K6S$_F`J$MNfH5|mr;KrK&-{XevS*Jw0;;~!`=zW>o^{0E)$m{>9k001A0 z2m}BC000301^_}s0sy*A)xBwqBx!mcR@2k>SrHXg8JTf@_ZJbF!@3VbvMaK4rgK+Z za+e%Z%O#iGV`g`bU6Wi>l4T20S1QC!in2&yX_*j3%Ldn$FTn&&QIIUkG$0d@YyvbO zOQHb_G;E9ZAAyi<$OH)4@AG9HnOWK0)oo9ADZ4APDl@BR@Wh+X_q_KPUt2o8tt21w zuPpui(!0k$e~rHWd-{6wJHK;t^I&gp=Z($H_3eZGovo#-*Orz(NxvHOM}a@GV{5~j z4eG%t9QK2LQ`fd&mS6MslSx5sN(Gwy>%t6T_rrCd>0y zqD{u=*-n(N+(=T+!ywDjTi)H(wRkmseKlu7i&d>nsiijbMiVn-OWPJQ7tADFS^0^< zXEryMzVp#%PXFJR>Q6jOzWoyqm%fW0Kk=!D$*140KhgixXAb{=zP@4olJ zd*A!TcRu&U&wu%|UwHSucb2{|1+(v9{^BXjze``=|JpRn+q+vkTkG3PKTWUvDj_|# z_#e;rs8u{}sCX>Id}G2Oqru;rkza6>s?v z_h0$&y{~@w75t@le?U)t<%4%W_s*BU^py{O=)*6+`=$5a`^tMCy!-CE@BH9rmcIBD zWBxt*`oS5L_jWfnx3@Pomi{)q^iu@$ys7rXAS8&%vcrathuroXuW2S218m0gj0vkG zfx#F7V{~DpE$E>D?6xTB0^q^&(#R~LA4(3ewYA-nej}Dz(uJsSUFa$h_^INC_iUx; z(~zn%r%wuudH>+KjhPJbOYeXAo%i0ShxY;dd+&enHY72=S%O

    KHg{}gD{{!!S;mcq6>U$r)`_4O`|ABWu_}rJ@`NBI( z?;XRu3YdT2$Nbl(jQJY9_Fc0uZ|>|6()&xFyuP$_0n@FCGPoV|?SS!M5af((PFrIL zR(b%Kw!%Gu2FvbtRoN{Zg0Shz(7mN^dR0L$ktLU9mrOkG0({jq%5<%!YgJgfN}7Jm zbD7IeuRnb4(;E+$2HKR;Ca}DMRL6YI;== zVUtnAvdhxJ+a*KSET#)!^FmbwZlSA+?7X7qapA~{ORaQ8q^;ORu|CFm@DgAioZ57> zz@|I&+Gl5NdTVd{V0~lV;ryHiZIAqArpTC$yG=~n5D9C`wJJH;XF&$;2%3yqF(BHd zA9ZTG6+J_*#T8Grl9iQoi5UG_A+D!Ps#cOLccNIPT&L=i+Vt=gYrX($POp7&7VC}m z-QC^wO^5Y!nX|_{HhN637y*chM+jG^HdGG*f9uA_`1B|a{? zrbln<8ctWNt4OTSKV^At1zi~nMqK^(TA=ZHs$uMH@J2)k0+5S^&B z!huLQ(wRvoKmo_Rg&1vVX9@ zzrMaV;g5>}Os|c-iD4h6T5wK~l=w?$BJ3Grgmksdc}e(^kS;*Iwjw>zEi-!39iTQL z4k@})=c3SwlEl*1D!kAYsWb zwg?)p&v>7Ef$#TuNUzbm+_hM~a>WYC$nOU4T1CE$E=4L$p0K>*KxgEkC_3ecFz70D zA)KM<$|A3zM2LvUK}jTm4PR3b!;>ZAcn{$z^o#6fHhY#Ozn6E$6mziMRe+ihs ze~kIp;h4|y_D|AlUzxG*-JPwS9r|B(wEbj^?G(n&-uuqp53_a{Nxpg~3Lk_#OH-l! zi1=3$%Kp6@*Kggs?u&5M7m?^Jhwb!cc=z>ABCciO{RdIl5{%O+D0DlOaUzoF_WjOU z-j0o2TfVuvoUF7XPE4{kW!^j6_4e*U1Apz682AUrVE;P{$mC1(T6YHQorCS&z5Shu z7#Tc;Hh}(M-onTEwSasX;s%lpMBqhI3Smjn(ZOgUcOd49)Sn^O(LnhX>K@ZVm6B{+ zx461TI=akdsIG^3e0No^8MC~S#xf>nC?`IbsYu!MA-P^JGVND~_J_x4|D|K;cjc+l zZ*yahPRWhUB}q@O!>xG=aZDNY+0_UiU%7IHft!_3NxX`~O_Ka0*Dy;H1E0q@go$K` z9k^1OlnA|_9Cjjc9H3T2tl)IS(odC1l*$YplM-BFDr1OV1e>ChFCqYSJ~Hwu6kxsd z)nmASet`n~CcXCVtXH$Wx3#^#H#sSvfpZ@?_s?)1H9TLto$zJSc6a@2ENaWVeWSIS zhl#S!bI@J>RO5!J-ExM<&AzP-8FQsUi-`}n`~_EZ|`kR0Kd3R z6V_}vvNmrg`mqyxz zk((nzN$(T*9N12fGYEDaD=zQHL{pM@>GHblC(`7%kFkDzin;&(xscyJ$?eU9^{u5J zzPhyJ(OZ6lUS0?*54@n?ux8l!z8@U*ZNDZ{Cx?@4cKkTkqUTkn59?TVqR-eOenKa&B3g2vLxfvCHY5P>NewA~FI$ zp27Um@b|;Rr5`%R9Qgs{3|?RQ#*7^N=0Bg7gC{wIPrg2Z{CBPpxJ+?*+CF`$wa2?0NpkHg+&>mWe0mEF_PG%)O_DMTE7;ZLgHo z8~+cGtXNeL@I8cIOZ>$JqGv2FOXhw=&{mN+pO3m;8qBA>9%K$C z)N*F#$T0ksS;YbPzEQxOWadcTv! z2{}P5oRWy2gGAi9EUZ3d?tFo{BOv~Bv(TRezkhXU0{dg6gP+bPLC_C8uL(oTj)sjL z`{O3h$zNe)r>0As4#qB7fut~aq+60fJHcJJOpeuUa+5U3g%o*(zX+F;{o@}%SQddS z924|K4k;6)akN(1i=3nnUnb_oYvlkC_XE5L%_O8Ltd-lYlKM$JX6$uSa(-TS?!5&#P`lPk?I>RRsIf^K^-n zVCa|CYx&WxSU1Zkhcu-Va=-Y`BCO6wG1 z*>Ym8uv+44vgn>6#x4Xvr6ZH9-F7GG;tCieWoawq=t;;}NuLSCXeC`Y!dW2mEJ?7F zt19PZ%f;0BN6+SmQ$gDL6zenDf`r7+%wRo}e7G>g!`hBn(+|Dnl-zKlkfM~i;pFRd zOVcBatI~9PCFBU1H`%jOEzm1aBy@(-drS{f1$j*pJ4m)cLgFMv*1;AwN3xlyMDVrC z=?T?mSU-I2yw~~NS0+L6semE*L3=x!8 z@wOnW2Xn#M?Y-U2o&6WZnmHAYq$6zG5ijIl136RgWgNc_@c{qY5M{ey({ADvC~Y_IQb?HwFr{j8(#$P1gsACJNT zJMxY~zd6i8uO0HXOxk40iHSIunQq6Oa4pL6OqN-e=OW8OGG#>nh}flZNd+yk!e7le z@kKW+NHZ3J^tlGc{CccRCJJMTzm;ZJE+^LgvpD#-FR<%RTsc<&vA?@@uy-&iHmRQz z>EU=e)uL3YL@}V1+*pRQ4Y3ijRZgOt$k)|75TzGPp^QqnIurPmMBZf&mTquN_N>Oo zp@hTV>rE=#x>`z^WG@s4|IBy21iViz`%4Ry2r?0WZ{~EI$vRvN;qZvn0kdEj_E;cA zW2F>jnN${Px?3ny^>9aCJsota+a=yDjH_m=EKjS#636FpcK;sF9UxBBFne zY+OjDNWe=d5&Ay6oR&SE!d!qg(wcv9HfA-QE*^!=G|KjAC^t=ge{upy5XooOT}@3K%>k`E=l%v3!$=zh@WYu*7)i(?0a## z_+?`K^##oRW9OKg^vL$X-u{G3=JkemM9So7><3=oKO&;(hr@yIdBbK99u0yZ@WMkn z9GS~tmdv7F2W6K;7NtOC6+umuELB&DN&JuAm=ir08Z{B5N_wR$SE&jQ`i0I##;ls? zadIHx=+LKSF8+O)xa7;nSR)PZ&v`XS*Z=ekmrSSTpAY6b@WW-!L(YYtazQFu8v&oN z)Kwu{i6jrw6qOMn9f`fPs8p_F-PH($=fvpRkbAEY6zmekTPP|WZp%W!h&N_LXWO?eUrwSL%R#tIs6`iOmE4w_EHjbi*xx_x{5k`_QCkMxL z3o>XXjo@0E7xC3!0?<uHp?wQdtiQZ2{D%}z)ze3s@azZr{yr76F8^KN@3?L@ieR%B&)wZn=C^Hdo1{4tA~NhDcbcf_xl~z7SsJ=w%?T(1u)jsWQtH zDeg?DO>&+rTp=QHGpqeFoXQADE(7Z5~V z!A{bX2&%k6cRfS~t#viAC>BRC@+A$9eC*>(KX8oouf29sMZf%%QmT!uz3u(=jY)v@ z#Ek8e%$SY)fgM|)jeL4y-1nC0uoGR~O^e8C&3gRSw^S~Cw^3Galp83N>LU5L!4#ou z*QH8`aN1qjwOuKedudgzm+KNbtbWgS{SJ5ny>~GJa4QKu3 z_1_H6toiRRa2!!|GMfcHEiiEscunK@z$P@6pPN& z$rF)u@{Wm97SO?&E6J0)H`X%VV!4Q<@Oc!cclcR~v$y@0a-5$J0Fhm!LNd%eP&lTdV^oHIf@lJGNTzxoCQ5Gna7B3?A z9=_Dn%s*X#^*_2YX`-I$-`m++8}LUUAH7%LZ*Zfmy@L* zo)rY%zj7Yye@4%JVg~Dty@U1j6OZvC=r$xzd{}%##?Me0Pd2DY9}6<%c|kcU7#K66BTzV>Urwwa z)~7*LdyMsTTl@XjCn=jLzDBjqF8x2FCj`AA7cysi)TbxC0eu22e;hGEj(NK!GoR6c zc31LNN9SrSj;=(jVJAtWwl?k524So-5^#e1;`%DNHk_=uEz_jKbW9hR7{jzzQyHzM zT1es!ZiHM7(pbwYSEj0Tp41oeYB29lwJLne0xo%rF#q9ME;%62as8xka-n4p7h1MI zvV$Y`n9yPIvR0}jT(yZ+#86UZ722)~ZdZwJN?mayxxSjDI)*!wih}H$yhF}cBaWaS zSu{aT4!aHGT|g&(tDW`NRS?L6U5)C~7((_Eh4Sz}t}F z`$1TTmU)tm$w&d3kqoVqf|WeyjQ*siw51?FMxtfJbcJ3CQj69Em@c9p?QrF~lT^OJ!Il^N_eih|8Ly>7Qc#sRfpO`1-uxxVyEpLu_*FqdzCoe3Yjm zind*~wuUEO zxf*rpQWobJl{*45x^^_~~s7fshjL#6ZmFYFX`5MC93eE4Z zUR0QIB;O_R5UvABz?>yYk*A~MLL`!Op+<^^$tZ1KQrbRC(I6c&pAAFW=0BUw8%(8W zo`I{ZEn@>xf6Ruqw!<-N4s+IuTRBR}c%~+^jEu<*mvkC(0$pm!Gs!?D8rk2LC`e}z zji*IL$`1^L>Jaj9N`&|<4-`t{HM&cbR8~qOFKOD~(Nscx0c(H#oEn))@{)LNhJM)h zY|ZM%8;v}_AC4>^4r{Lt_`o0e!GQU`e>7_R2FbI-)fOY+R>+j6ajUR#kkOG=7_?WT zz?x}#{$5(JJlAo)B6Cy33RODfLmHD2bqm8{qmopqgruJ`9rBPe@@~{x*2&_Ip9*$K zeVeI_!7nYK5Ja|T<9;(y?5BWQdqX?$d_2j^EGb+I8CW+{p-sz3jQdJ{O7Vk*{95ArIUo%~0-YQLaryUy<@A+J;Z5$`?yLzKl@R z*^HxKUSQXV1^$<_G1lq0-*ZDfc$^xka-LK&*BOuVj9hf`4ku;rMsYgx2u&gcl75m9 z1hmE}6_Rx@aGRlFI7vF_U{!Q-#)1w|vWrM|WCxubPY)-FDR7+a>umoMpipw<5ZguiU?>+c&LvKs;SqVTG2a z72S?wRpli8N)muVq@+T=;4%jF#zwvK_CdX|RnzzM_k52H(vUYk;%SQuZ%hBmNxJ3~ z{4+yGmDHb}mE9*5QU43Q{fEf|Vm0#`IyF7t8;&^9%#lY{T~BPkf6n&%18@1tbKN+P zZhP%^`=$}ujaIbE)4Y==adPMS+KnXhlhq`Oqvg)+wRS7XSF-Txy<5?PwOa)KKEU6s zw|45Shl?jKzWz!OKbbY~j}}l1Lf^kIgZNCC`{^_??%TnD2LsQJF(4`QN28<1xx^ew z-Ok|X7-h3gQW&BMlUWdSLF|FnJ@`D(fR>I&gIPToZ&zAQ#$7U7$_yF>sbW-VlF2Kp zqbO|&j6C7f4*bE^+dGdIv&+kGegA`h@NGAh1h@Zffe-%=$%5aW%_1JGy?O{7b#g5KZ$)wIoowW=`SZX+ywlrm8;pcRjE(H;{%0SW<34}rxmShPNwi1<~ zdrSYy+Rc=%6w+>V<WaS_F|55Mo=zAShj9=>&Ya{gaePV&E>dg>I$&8^+NlUg(h z{&rOD9aD8fG~Q=}+8<-^7ds*|42MlPYKDWR_SkZsCgjOyh`}mIjV{JqDuq!{rOXL0&&W-GKD}^G<;v@`S!TbyQ9U}@S#HE6-qm7u!EbOfl-kaM`#{1=E%7f52oH6fWU5eeZ}A|BEe+>K^L%DpS4M6V<> z424sOM4{Ny@LZDx3y5z_V3S;Gp;9ebigInzE;D_=yZgX;aqRU~*!JNm-pC}(D{y2S zetA|Eo@5ssbw8ar281%5p(I>5qxTH!BX&r55dWHrYXxi*0nw}l?@1(ZOjYR)+)Ysx zbQMHqNwLQdbe9BsQE^u)qTu_xkzZuS*0^a@C^#nFBV%Ij*i1X|+dG8!_Tm{auLkdv ziBpHKpSN$s31>Z?nfU7yVeQv7=b^R8Uxr7XHxBHeAJQ8Sl`u#wN|i-qm2DA6*`1Zn z1D24yY2nkAEyG|n&4%m3~*vi~`{@S712 zh*Fx+4`kqTMyAd^!W*#nn*nPMr*$5A^=&O>8r~F9%+d#8axb~RoVs)a+8whj4KO7w zG*uL}(zQD*&9V%g?L1_dw`w9VR~Dx^N>sGem(_0zAPuaN&bA^nZn ztl9eB*5*k_@Hs#xqqpH`nUT$L%aqJ>6iyMWq9d)tm#0n>xaS+O-$pZaIm_KQWakNyuS}SHU_Fhiy92PTR5Hi9L>< zC(%YBaVJ|LyQeP;XqxFJUIJy!QUkK3WO1aokV zv_JBjLk36{rY1^f$Bv}Y_EqJMpk314l?A%2@FegJ$EMfoxv?lKPFDKT6v&^J-_2g(gv+K{&bHA`O%hv}x7&GdQ#^=MisrfQFDsCGHYIP9O zbE6q5+jX}B(3X=K4LvkKLWT6It_z8{nJ;kcF<0KWN#~ROIHm0s&fB-$LQ53;T>8pw z@9KF9u|y&N#w>+w?{07GZ*Bd5!x|;2gf*JR$TKXCv92aqgCA5?b$i4WT?{HZhc(Cp zSQm@2ej&y860kn2-63i8jZ3bpgVoCpX#dQ~Bu6zrnm*Oa8sNeW`3 zjwXklzX*kV{5!tm+dlpg!u;^fM{k}Di|Q`0>+dD3|JD{ z4{2{S;SiG*l4S)Z3d5Bt3WIXTVQEd+zKf|{N1C2PaK*;QWo3xPcvw;|FO@8qh*OHXcgABxn+=8 zm8$=Zd4cuHP3I2on}12%p;`*F^o5ux4fu z#^!Flw>b6qYAyTI3oQFv$+F*?r4iKatZz?fz{g# zpFQ;)&!SIoaXvY-@MhX`ydZP%V9YSvpN`UHjTxa}SBxV<_{sS&w&-ExGi05cSJ|}{ z#)HDc!GJ{Aubcnpym$J8c|7oHh_;p6d4mqK9AnL~#_2_ZPcI>+`shqye{R9)_|CQY z{bU<^J6jv;n-kCR`Apg$dEPQZ4-8I0fvCPsG~=vrdpsGLq{ONw2yE#d(0*Vf%p5ra zNNwYqO(6zBHn=`!vbE3HN_TaaV85I@vmQPgymhAfkb&{$2pgH2_vc2uoMvU7X~Zr8 z=HYU1=1IxD$7?CpAxn`6x)m~2EEIyv{9YU-xrp!QQm^JLZz+*@T&qkgR-{RAOD92? z-HUFm5aqCrxOEeDjuxku=1DA9I%bV0D%Ch0XLQKs!_ECmNY`Iqa5y4?@GJj(mO`eI z1KQlKTt&1IMzoVII7Qj_>oMM(~LsX2rQxi!cn zATr|CnmKpVYF6gh&F5lLt|Rpl+BI&2Q@Z~8)$=U~$cue-wsK)A2lfI`M_GOhb>X0P z#e53f3+X{_jZ~Q-X-y0bXB|!pDp#?A51x&K+AXT6W}rs4$LI;vmv&0jSzhLw3+Vc< zU7Md=w6}i%g}rw&({F~1LwwO$IpUt*@3YYBha*020yzqYa!9o9J!T9$tQqGlbF15o z7O-Z65T# zvZ|1?T)}THP<(%vu>S5jUuJJ}fBR%2*NM4uJFfdf){F*_BqT@%1IOilV8?@6TISoK zZwY(^RTG`Ul2Ln5PL?RUY1yXa633w|QgY!1JQ|GTvXf{ODGYKjjcZ(m0ZY`t8s4#8 zSHs$K>2xf)#)#Y(zVv9X{>{zr)>NbIH6ZZtXiJ!}utiB7U!m?= zmLA@Lt75%AKTIWd;$c`E$Gk22$;F@C!B*;o>B4Pq)8sainM2n}w?UHLpt8~>Cdy!EC z7^;I442(@67AnCp=bFDzQq!GmXLrfQ$%+reK|tq@w+(VSnyA7_LrX`aDKNogamPA6x@(KT6B9Ak~Z*hDP`;XhQEDXgxUUxjtS2ECV>-n9#`Mp*k7 zXPuep5cb7*L)PPwJsKX_BO4w2MZF~qtvC3r>Tsw#^m0Q|J?vH(uk+&}a>4jL&#-9GvtX)s1(q8~;%p1ZY z$N~VOw}6CPw1UcP0}D=>VA3W!(SqlK_*vK_&yhAGrcbc8-RPFollmJBiAS|04p?be zM`jGcrx#LvFQf7FtP1;$Yv%_Ty?1@SB$)0u_x5);m)5T=Ey=6c2lO(+bXZK?`e5awHp<;bfw@4W?7f^6i^&Gq_D zWgag|*8Wjr`FOzTh$QP(Zup2BBx0?jWvs-T>*V3_OPGLiu%?CRDv|Z-6F2oQIDR;AY{}{pN&VO z$8EvM6+}HMaYu-3dRJ-gHdRR;u3T9O0+GcwU1M}vps>jw?_#HiNeM?f3v+TH%REb1 zYy>0uos+g{<#c(XmQbjr)H4evwl?10y;w`f%R&33U+I$z&_+7)8?%-@oqC++4gO?^ zj|NBM!O_upI3(hBhK<2xoOj6YOP2#|U0=DPL{gMG6S`Y6RVfmFd6DH^DMKb1Yiq?) zj!;vPM-fXBAxzBB56MWJ=c+AqlrpxW^DLa1%(b~)?=5QWUDU7ia>)CHNxpXh-l*64 zp}A=GRBg^PiNo4p7&gN&Y?@JHhqeEhjy^i)WLGh)564vC91A$HVvHlzc+3;3ndY$+_=Fk}%>oBv*{Wot~WGL)7$_V1=vbm%}xJ3@A)nmZ^lJ>Xz*0^wyt?mj-J z=KaosgA&QIpP6enol1c|@*7ls^o|jhlNJC>jD0w;Us#m%kfu2;cqO})i zW4D^@EL7d%cs4)A8sWY|0}l4DpybC5I={4)3}*-BHy8Nre~SS9<8x(xJG+~^n+L~3 zo+nriPO)sp&9Ih(CaC+tzz@8^kTLOBBX-pU6`m#K2ABqUAT?C}x_8#5^aM(?z9;9E)|5Qu4BC^yk$^plP; zL;E&sJ zM{$uZ- z+ccbw=t6Kl@(E#|)po?BAM_tH^touM1ec^CGX7f_F5(lRSb1(8Qg z(N#p;%(P>(s#iI~(l%gd>6ZnP+@gha=Z@%@>LtURT_RjV5c8%!kAD%)ptk{&Nq0t;Eu;@W6^CHuVz1Qv(=>zZn z)mx;ZSA<+$%~#WQ%ZTMvvMg+`#Nu9jO-{C?sJIiaWTYN7)@JEdohL`4;jZv90Z*^yuBLS z58H82#5_?di#01aOM}0Q@^6z+-?>cP>L-JXzJ_7hbIbGo1d+*) z%#z9a-q!B+&arzlU~~-jnXK7xBzYjmeLiZ&B=^Q+bokZ*Aw1$E%Xs6HB@PDOa>}(9 zs!EmN8l8=<7+aH{n4<%sjAX$`bz_5ak@Je9p21Cav8BqTN;F61nUobK=X5oODhfr; z5IyoP&Pkb@SvJ{zd;k2fk>uFIU+(_AhyAzQF2WOMW_}(66!>4B-w!!)aDppKONUpn z{dC01o;g3WXMbYP686mO5N;&YHxE40DPw*C3)gWwRX*o35$#sIx^n%>&FeObZ?@MG zV_6pGZ7!EPZ5|he;bGp6*5XKpH;XXp+`7h>c`FR3EPQ|=FK=&b)dz2HEuPi-`YSy( z|KfsE^XJZ;n)I-FaIk;8VC88h9pVfnS;Cuu9dYZAn!fKHGB@OtylqVGM-UHliP07< zT}_{x+dtVphN@Sj(~u3WBvyV*R<*m*2-_nUvx_umff0*zjB;#iam@`cRBZX`vHpo0 z^DQ>pTRU4@+Xn|PiglJrBPHEOQ7#0g8A)y!7rEr*)~7bb1QCPkzA}@s)w#^OP}Iy| z11Hj$gs#M1IDwJ<*o+_(#)+b;tRjU7cDlS+f9)9SzkL0CZUF?oGdq~!V1I9WYjfSD z>9Ib1iYhGW6nn%8)d8xdMghq~ZtH&N^CQa#aCn$+`^#%9MT*62+1;3TR>Rf%x8jZv zt=rkHY>kI2@%0BQw^oC8p0!pVbfTi2EvG@;Ny8uyQe{P&bpz=Mj`hDXxgDBkbC;v=??sK0v48Bi2;F8-u3gn?7w~E+{Vc5gYEszH{IB|f+N<~Q;7eSU38$jm3kGOgKjUa){!EUPL0h>>Z*a9 zyNNEFNT}q6i2JRVQ0;J<$AQZ}AD)71Kf5b(&W(Qpq@#ee_+VrQd?W|`kv|BWb@T8r zV@O1@mcTO8QWnTo=A7JlwBpe*iT*t^XQOcxpooCi& z=#j*z7c5+X9#Lj?reeLh_vm7Ioc>3?V(&BG|2=1c?i=T6y3PSCczb*TEooj9v8+_C;nn*7Ty%2`zZ8 z*rY_v1Z5)zQNYTLYON{^7(nG8kJd?#`n4f`AtaU}0ZjlqBDAHWoX;EjRUf#cP zKG6LI!utE>LR6bOyE~hcunB4%nt&tLM*@)K;J8mFZpQ?x=aV38hDS&2C?F>&2)sc} zUQeEqS4d7JnX({$C1u?bZkJerXtz;_L>0%G9OVYT&^r}DFG!N3$*-~*ou7qZ^tlic zvlKBYlnlQ#7(cJn8qY6l`S##c07C3dJoqyy0R6lwABuHce%hmEeaR@;SY-}P_Zy4il<-@bnDwUkS-D%t?~;O+fKJ2l#E>a9l` z2anbtp3lO=k-zy$20s7L6zcP#DoFAFX0{jPM0Wouz5H9(9D`qoN5*{~4Co*Y*r_8g zbh?%nGM2XjCEIR-K%6Aqs!%579bVASTno#{;sq~=xG}oOh%~Px54hlkGx9*BUqW1xZSS!X1}k(*^d7!^6ZBBO;~@QwUHD zl$IQWAn4S+r1_kwA+1061gvMp$xO85!Vt6Zn6UwCyk#TvglJaV$*>nUh{P(AdlEzb zjN8pwLiF|UEh)locaj&zs0?HC5(g%PBhtgJS=boJ6!fOKX?AM1PvKzW(ZwoyK6)Kk z5BjG`hF@F&Hk_XSVwOv$9h`+!AxR1HVC<9b8;|^;AJ$$|*GJft5XfbWX3&av$=m56 zmV_?T9>Y{3y@Z@f?0Lo#>q7kP;4KkWVFuus$my{-mk`WKZ$t%O`Ml=I`GesHrbwwc$4$Ky}LaTC(nhnFUh>~j840@L@!5d(ga&- z;utRZa+}9)TWu$bv3U<6t8^t-Qnn2db%aQ^>EtLuDP>8&pG8_A>t>}+^1^2wljg}P zx%sRWOb^&zf3$s>;QrBLxPRrw`S{c~2<~s4t$Eno*xTIN*9Bk`*P$mmBIRKe-%OJZPg!Kq ziI5ijej?QEP~3iyBo8|1TX;gyeCnY54&-zW9&PMDT#Wmx8MA#N3;)*zxZl3Dv~)B( z$KhaqeP@#dN`7tf30QzJJHxmkU#LH1OcMEw`u)JNLH#%jS7a`;B5C`GGm!`hW65*w z28zm#F)S5|FOz1;$tfZQlSSq>fp1#v)@mfvEKT@oyy7Prw`of-{tVo|)2YNqyNjL7 zS7YrbRQ}rwoXp=PYyZP@!=*Mzrkt!8dS1Yf9%qPgTPAsyYa=aE4F=7S5?wZ^IpGSy zs)83SY(g!C@Ck2TNa1#vDXwA_C5dEKlB(w-O#};BgjHK;K$$d`%vAV1x@d*ZOSnBc zRVhGwetrfbSaVB;rlM6Z05(E^+A0iB!%#YFy2kA+bW6g~nWGa);*b|27otNSgigW} zQ(-iQNie54)2p_KNIs?pEq*qWp}MaVt=qXQa?YikEjqbWV4ta!<(ubCJHB;pBk;!N z&c?>>1Z{U1N;a_lCXjOE`~852^hAFY48rh8Hb?%bX3Z#&VS{7TZ}JSeoQ~j$&tCK5 z=(QjX<3cmWuE*`H6VY+n;`z#27O~9B+G=G5#LeS$HEiXC_)2GO1snRrnq|tBcW3(c zT|Z(>DWSZO8&QZE`Mpu^U#2SW)ApR3=OZZXTk}oX8=LE!>)Xd0fiH%z#a6_@c+5lQ z<*cm}*Jz*;451?}STa<&qUYU7Yd58&;Kps;>vma%j(Dszw28sEzoL|Gh_UKgl8UY} z8J!E{L19IO1sh%d1VgpJvVV`B+nU9Ce`|eX>x4(`gM2Nyeg~GSGN#kSL@R1d6F0|MLKt`A4rx6l z6A|Zeo);)5>+&u5=ATs+O&$bCqM`530z;p-( zm?V$=E1pHQ&tTyB&7q9l%p;A8OKhAVPsSFoQN#x^yr^)7OujrucVYZ9qJtQIv0 z64}W|zzw5vEq;ZYr6G^!q??&?<4e_){piusA38?+3pdY~n;z&Oa?F1W+){ z60?V$t!wlOV+klY-|ZU5sPn?5mkm~BMIC{Bkd%5_n(Xd8dP1|`Yg6m8UJlYH?mS%g zV2)7W;{UgE;qPg8{+YX#%?z#3=Qqh_x^eT9MP-HM)$v$0w9{)$JH|Q?^7oZ1*`L-WTN{rqQTN$d zLF_jc@HbriUz^)kd+g4;@qqnifP;|vW4GI;_6Tkk9F2Td*G*u@q34BOGwh!%xUr9= z;S6>4Yq5+4%S$ehQJ1KLLh=_A8OwxEI&Zofo0^pZ%vj^zC3_dfjbSVt+L(TVxf+VD zoQ!-J$F3+#C+N5{o<#1#}O^Wbi|`oCLhf zQg`VDwFUYrdl=n=p*$ujbWYH7416d`VbL{$HhRroB#rhm#zLR1IQ*X%2=2dr>s*}b zU}t^(;5Z$BX0Q$8%~8l1_EQXkz6@+o4?;O^0wR}y9(-^N_a0v}81{#e7+9GHy?q?H zc0)C~PH+%e7)X!;mW^2hmLPW1(~K?>(t4V{!veUXP#BF~I_5|9gUQi>a#>TBXU@&< zE+7&3@_%}6rp8p1uzRAR}VbK5a+kpLGG`#ieRs;qni)g^`NimFl! z@kd5@(szbgjD$OLR|dmP+<9@nqlHx*W4({qYgBu{0Uv{`D~O2^W+vn4~g<;c*pioO#m(F`1RjOd3}%u59yQem09n2i3iZY_x631TN!2+WDj5#}<2b>iFd zUw|&O_||z2M~HB4v*c_z@B-FMa5Mj?&jykX*2gT5xL93_m@I^q$(Rp&lYQ>f z+T_P?FF9{>stav>kG?q$nw%imFr1uN#CK#Fot#ZTuFk+eT@KeE>^&rj-YmBzlc^!2 zP7*G;F`Xo}LPo4WovU^uNM%>>N|Pxg7DC@x0^Y}_3(ZTeO5w&r)3F;%;RW=Z&}l(G z1)K|}M6TqshM6SCSijs3ooTGUcI&(j{8_^K-<&NI+}_?^-`+UhzW2OPhjh51#?qup zXV?v*CAuR^H(1TB0&(-Dr0aEu_iif7IdO&*0`t6diLC%AL?$%@1Ta&KWR`@efaZ_rJd2c!b+C=etk4 zI2T8GKwn2#c1W0&602mpL=UiFjosqd4?q4+9y=t5F;b zqYAeW+n_bRm<*ifEW@%xIZN4l+w~LniqE6{k(V1EK78}xX>t;N`h0Q{{`}nFz$xGT z;voB;ilILL@ z#t&}XyeHyzhnGxVUkM&8dk@-cw=*6I%$Mh@=(`DWu52cvED3d-c2apO_9GqhHIYse z$@bfu8};U9y|b9S&oxwj^aef^3H+xEAYUTLzc$sfg<|J=4F%z z+DVZhy)GrDb{8(A1IbsCN-tay8-gXI5>cRE&h0GQt1nUZ{Y;kJx_ut)J9p+K;Ku$g zos~OV$D6d~>0;iXn?9PPMjr1U)kku~A7_csycH|S6Vwuu-$#Z@2Pc-Rlto0Ipa55> z)T)+tnXyn2YZqChFeb@uFmprGUEteH!n1Tn7L1|OGGT%Q<0X|PZ=RCL^6m3esIC&$ z`P_Kjo$amtjlHGcxH?fR7cgg{c3;{c^oM9V8|N$ScHU0%M7M4x3X3bqXW=?8qPSpp zZb`NluH8wDsWKi0@%^^saYjdAqGe%tyh5+GTFi#4>H&Qwp4jI-<+*njaS&u$y9~`_AQCBV zg6AWYFjwRe9kwVyT%aCWXc1{1;uU8&4P~=f5PQc2j*y>}0;A=Kb+g^M1I% zygz$qz7u|HmsopmbKgY+5f!`;#A6-|ZBRE1-p}ERRz$&>EOngSBR8eEoug`m>q_eg z42;PF89_&)1jz+d9m_6D#C;jk$3VbC(t>DP+1!XCV@6lf`RuU}+A_sv%^MNHgT-01 zmkv4f&uI}XoOL+x(|LF}^?zY@jLeAxk6-&Ou!y}9Gr)_#P{HF5r>#NLH_dCn?Zrr$$ z-1n~C4dPp!JHE-I>+J`(Z(P5BqjUe(+PxcVS3B45c|2QbEfdt=4)fl5wDo9X=i%nY z!@Y+a=Vc+B`D?GFOXq}Ee)jfxj|UF^zdBoOGVRPyOn2Dl)*caYd!we|_Gmn^a~lfE!oBx{lwT3vW`p>a_2emc|>P|$~!#IVnfCqCDB#-=OUu|7aMZ?a^PdpppP!ZBJKOtP>s!Zdmd~Nn?)MS}A$U?_7HG z{@V-8`%edO7=wg8ss)Av zy4<{*iK!;bpL)*3-R}3&Rk1OU4Mr@HQ5(fFRF>Rd%U0LYP-beeDEvOx8FewpU&iR& zvk1!Vlkngfdn07{$L30Vro)5JW7(1%f1fW$tr+v5(K&2Ifn7peMLNLBT5>*f9g+i@ z=S9YOnhCBd6Jba5+!~XWzw*?V{D=nMzkpv^MJEUJV)k)OMZR9 zQ3+N4f6q6eohk6=MLHNfCiTtpyIF`W$-T*Wl+uYPjj)MW zPSdQD%N#3R=qe!cT}G@V#tDB}Cj7As_E1Uj^-1%UzOv)i$%~2(2FdquEm;>RGQS3 zZbx5kpQ%x9)h?SFW}0b&MCLS^M_2>vxxZZaR0Dr%uTpVZL5(U#78{CkB3Jfq^4l z_!s6%e5PW93rM2@X$0YLKps5i^7e-V%dkkh9u7EThgaBImXZ_m0P9$~n3l_P#P$pq z(QOQvcRS1wW-Z;0@`+WusU{^>P};)nxJ~r&X3EMfzXc;9_2!o5mY26N{sim$cg|Dy zoxAgr`(T5<**?Mg;w%z0eeMS~Pu)D8)G%zw#-7!j*{pCo6J6?z&;!*}t|Zf~$tK;0 z{lTQVVE+L1#>Vr)EzgmO=}0Eh;BHH-w(qDU5+nmTdGvu7^-7NXvFi>o@}8CveH4r&k3GlE zuF42(B~hdmHM$@YV^m2pvMr~(7rqBQBa4%kuLkmyg5%$R=Ok%)mS*5&-XELwa@N9cOi*&6M5kTo2Ru$iC)Y*l=1bcsc3lWC zTbXcWvCUnkbO5fBI#dY}3ClxGgo5%;nOWDafC36t=ys+o&!k}K>SZnJIjax+?1G~b zq1o9H8>eB|pQc~?)vF{;o?yd$JGA548*qPEb38Y&12$+#$Sf~91&{6AlsvqX;5)m z87`A`pXly)@0?Gf{ZX>+e{FWU9Vrv~ZsJcq-IPgyvwp)!q|i~y@XmlQGcs;;`0;4#l~7Hi8BhBg|Vkw!r;1D&641*>A*Ey5K=Ar*QSN_5)TN~*+7=XHbCj7=qU zHX0cUQYBWPJd+WVWaxsrv@NV>Sbt-IW&c&O>>ry=4tKROvnri6fs7VWDWf!!$=6N6C&wk zg=Lw_^HsT;1-Fvrm?i%LVEyM8*!4d+XV){{`zaR(wjT^o0NeM8wOOBG3K)@i-5(DJ zM{GFo18f;#_2arvgt32ff!w}&Z)xc#=Y|e!?2$itTp&1Wv_UxF zocApzfqBEmXEhJepiQRl)d&`jn!}XfWN<>z#YDUzj2rbz;@V;m)ucz#B6X0Utj*Xi z){+;Mevk{)wUL2iPp-t89V~mHk3dUfsv`z1(WMcJ&&ch)^@o>dG}5EDP9@1dSs+P} zWB5z6k&=^q!hpQ@W%}y#r`s~A5iU6f-qpdl=7G)tjNMV(L2p|Ok8>Ao>us}jAkY)i3RxHR4DZ}?)*Tb&z z^i;RfHN~x}uCjgY(R}B--~auObKicUR2=_vr&L;b<$mQx>32$Bm^@Ybv)iT8(GT8z z_tl3FJDt6qovnL28=dXlz3tu7qZ@erW~tQg_4{6TFdp=WY|yWGoR2u`=A3iMbDrm2 zZ`|cxg^lu2#bf=US2?S#z|w1)>dil zG?Sb&Wu+GEaqHlP$L)jC5Bd(Pei7?JOZ8NI@n$i{zw7%!8QN}sb zl!;0bK$!|W;)Yu#Bu^8QIwg%(cneFcNgUo_1TYsysseH@aH5P(AP3y-R(meir4In> zUg>9!v0gsK`tzq)e;>~c@cI-1f_3o{vCp zJnZ-Uyu8e0!AC{BG{zEKiL(~`O;dpH5}RdNny#lf9R75f$+9F%lPvReYSL^y&9D+_ zV(&S8fN@ExurSs{GSXaWi61tN_13}e)?Bn-xN@|+ul7!v9h{>5^;5Jzx>za=XVBgQ zRodIFPJ#BN2|ezXZGSv0myejl^{$xWtf95Bkv5WO4t+>02#zDMsZCO=jdm%BZn?>r zO)`@Lac5HSIZc&Ik`$ML5W-ny5@U2~Wym8eq?CKsn$MMdFfNz<0gI*73dle{Qk4NKU<`N8q@8nk|UhSpmY zBs*IL)K4TZgr&lUecta?yu3H6^z5KKiX#ZB;C0SJsWk^>326}6NShexpehX|3{J2R z>Qtr5g14YQ$n2y*Xyn9e0q(~TBBk(NE)hHH!Ac-w77By^!u5puqj`{yht$adp+4_@PZcBARqb=7Cz4VUXS(Z@MEZIGhTyrz+sJy z91E1C_?SY0Vduz;0PzG)C5%|1;DQBkFOD}NDVb5JR-v>pTnwy7RF0X9VG#xAH~c7^ zxW_5`_v65Pul;D_QR^Dozh6D2_?d8j0m40=5$?`zdk23_g5;Cw-0$|e2kPhDQDxli zkKoNm%S|vLcGVRbc(@@j4md6`ju6Rax9kODD!p7Fa(G%4L5DX2$|f8{`9zEkLt6fsIQbD>_M#L#76q z&APz?U>%U3Vh+j3FZu;IgC^*g}&$Ih9+z0Tg=vEhCSko)Cc?)7~bZYQ~nm5vzPF$;l^0=wbu5;A@y z7j|L@6G$_X8K(drfNVm0>Q>T9;VC#oM-CE5n+$qHxunHq0YT^NS%l;Yu%6=e_vaM; zs6h2s=Ti2mVpO-x`M_4-|Awqw9uvU_{k+%nkL{nWAbNVX+wbOH+4jcWO043wWk40{ zB7vkjQUcEn!$(yqsssZ3l;a1_iy~>HLMvGgiDxK97tm`meTb!$Um5}$SBByY%b;Ye zpDDSy0?D4j`rSFAU0EuXer1N&8{2z3?GBO~!unEF?shA=&C8q&p+{x};m`;dF3)ER-@>|bywBLGjFAfB0A^Ch4Ma=ikw{vg z6M$CNrGuZa4INt*AWSORAO=Huq=mya$astiY7MyRKr6Afr&M_7Dx=? zF%+a3u`mI+hHM1&y(n`h$f>`s>lut7c|TLU15p(3Ns25T0uFPi zk;Bts2>nbZ`wBAkGhV+k2Wu(@{^<{F`9r~*OXq{dSYa_Oxd3! zi8jz?Rv?`jYTi)xNX(ZZ-U^l@0vfoKA~#ot*JFhMnMOdGa&=*@X+3+YbwIW2^Q{A_ zasTEl)>HNDOQAckkaRkzQgsvs0rE$-%;P|@a2i*Y@yRco=MAWIn}mWu)-mXIvrb%nZnnmc}#XdO@i z>P)V`2)XW_%N<*-&c^0O>DxC-r9Xa=EcUSyS4R10G(pub1DJ8%8?&xI@_jzCy>j38 z{YtOfEsvMIwPwKBGNNR|$lBtQ%KSlb5UYx(z(P5nrwuKlcFMzy0{& zAf^1Vb8xY`S~_k)mH;>vp&nkj$Nt(JFG7W>Z_jXhrU-QoW_AkmxHkjy05CIeRL(2Q zI^tZ5IIekhPu8LuJc*1Y8E8nai6lt^wZ^Ebmr9XQWt&rm6HqCZ%2ze37&y;VtV4}h z$yGguC(%JImYhmlar`WreFab-oK{!AF$ZfZmi+ZB*3*TN%VUg_x^!+F`+*1}flvmY z?1x^ps*M(POYL1k8P7szbj)KWEDLO?L!%SG9s8=$4E%sJ!#L#V2^TcP&sx_d^D`cd&nOKp$HA`Ey`T59?3|=Qn1} z$Vs>6KcFPPKuQ81*JJ#|-1UbZA0cah!a6KJr6z>Hlq!2NG{Uco`rXKgu;!{k%?s8v z+_>UcnlNk%wYFTXmU$en*8Hhr_6|Vbnm^9)!Nkdv;gN67@g!86`o~$wr|VFs@ozlt z+mYwzY&fz!XI^(W97>s&{ZVSw2uVr>L9Otm z1&upVK`^6YbrB3hd?Axe9N9q_ax*D|7cW!ERTot$ynCj|y4N~v&+m(!C-@r=@b$)n z2d_VPo@jsR813%@ZSP!W^Ie3>pO^`i?N+CQ+-7T19=W83upyz(%G?_sF~~Fr+L9IZ zR-rZHlc^DcP9>mm0U}Exn7k~BklJKLngeY&3AM)@GW;~lAR?ODn93H8JEnz`8d9XD zQ}&(qVP}4)=7OHQ_Wbk6?kTzdVew*t#hZ>Suy1u@iWvP^;*Tv$vB6KQBLyPrUw>qN` zpoE+*vTp4h!bV+>$*BD)DS2m(lu+sQkIt$0RGD?YTollkD{SENp&j6m<9s|Aj7MG8 zJBq_VhM*(mDT!6fC>q}>Q`@97pp8-ZJKo2cAo^x&jI$%*5UT$EK2v|R{{Gk9>e~F zIkl+@VE^1~&9&9p+THF@tpUOtj}?w5!D$XajAmZL~>W9qBT07ki~ zS46Xk%;;9F`SR+^A6i;iT3NnZtv8rkt<^$dqorF*OLrSc$5Ego5t8fU^{~lB z&nu_ zM3WjkU!94bGtHb!b9y`+!>kW0<2Yz&ZI6&$u%rx{^*z*N8$u9Is_Gmd|Y;RkZ! zSutON#3w6CE@V__%$P>MjUkhGF6p_RSi3nI@)9&;|D1+ww>CDnCIR!Z2zx_b@ew|m z-H&7p-{;2>i?oR}$#D==xCond8To-h+(WuENgYXzQ^Q%T>P>AUhBc8vz-c}no?F%! zRj*cL2tTQH5UUKVmnL>A&w}+2yJ+%6thbjg<~uI}>-G%RyDh}Xt7i78n>hnq#2RN!aK~>6)s6lqXX{X4FWdtqIiUA(Ees zPSFk$IPi~u+#7SA z_b3D9u;_6t6}Lqu-=Mi-NfQbLQPB-^QPD@EoZPr#oB>$M$<73uQCCOOxK382o0NJc z4x(czNyVudK0p~7c6cAGYack)kLU1u_wIS~x6|I)-QC%q>?V6(8Z*!0-#!(t@Je|! zjG0x`%Qb*Bp={F97$5EMu$i6Y?^%(;(~+$gzmoN0m^h({hcsI!zGv$+mx=UVr}q-~ z5rA$HQ#I{LgA=^IdVONFsdKZUW@96Dc>eZW!TY$IQ+U2}Adh%&4#=E91|56W4)$Tm z3|nNDF(if6;0_0~!&~)Lzp@(o-s<8)`DXRyCXXs1V~eYN&0mJkL*#5W0};iwB_Wvy z$GG~k3SabI<}nOleZ^ZAx9$WhOz5bg7_Uxe@ttlPUz@FN=VIxEIyyIxK@YAJ^ph^b z+e;Vgf*lZCoJ;20d)qs^8$hy1d?iJG!nW2hc9CF%zNrNlbl;LNi zJij+bO}>ZczE+wBd%K0-Cv(N`hpg>aDg!p`mWSN|alJCwXVNK6W$t3GqyUl>7}moU z`^Hk66fyz1pvlX0y{K0y^4ugY>H4};2#Jo-3>!2gqZ|kyrf3Ay;g<-W$!Wj({0p%A zXX7Q`nv>N~RrW7t#{s7+u$RNP&j-kQAT6WOXn#4PB+w`Xyr{-01ElSaj)CeLQ4Yxq zH(DmL*lea%Y-w{}R%{1J1))oh8sg02;_T4SI3NvD>6l3)B$(|#ORMtvBfUQ*BHuj~ zku&9{hQsgAj;PHv7oG;@-q>TK@qS&>cnNK^25v|Ki&TUlFSg)lDuoAzD85cRCLIm) z&?cLdo)VlS!^Kvo#hz{2l>_(35g+4Xu$ZI>xL@Bec|z>(%^@}k%a`7r275+C2K_-^ zvHmFUG70T2`<_Q~!eri)Sb|aB8`JiVVb8buc*MK`KZ*dg(gjqOI%bY~W-6jA+>!S~ z_HA6O<6<)oB4lilyj$>_wu=-)nTbxEh^&qANG47T;ka%%&STkZ3a;7zgLM6!IapIY zaJC13TKg+D-CPRa5wCbT9``D?cSP5DN)xN#b;=EoW6Nb2H!3WUvUZ12zKzTWj+w<| z=)z=0)@c_uhp$WF9UTi|6E{TAh*x1yOf42Bq@E_LMfH_iTt=(Ug7sC*JDiEg{{q*F znsp-o4JYz=#))i0u6NselX1Wc5-}L_a(`qwV}pUma>jG`?vWjhy}s=Z$9$hL#o^GL zY_dWx=yn%SY#kGkDFNh3(WxZQpI~Ga?t2gN5ZE8SGGf2_={HWnrri8Iu_=fDrx{|O%h#U<=^mK9FNlLwtAiH- zxeJWRwUKhupr61>2rw7ODcVAbC|V58JIR~LWJ42I#g=&byV%F79fE)}%$JP@%s2es zbo0H_-MvN)vy=AZOLs38{irzgcjr`Osu1md?y96R#JveJ>w8UO+^tZ4+@PXvoD%z&q^lvpALE}SVov-@g+MU%tKd4Q? zy^93$I>CK1IaRrP(jGe_H?=CiKHEJwX-ob&-u8z#f%qJQ_hj^+c$*_dcQaB8i>XGU zlO%>)mKtUR3!|uBwWjF@)g{kZc{`3IvQ6qDSQo|GhCyN`bwybdXWISv;NUfyFS&S& zqYthqb)qM$bM%B7X1{w*Po|nj9ZBN-{ONu?nvml8CV z#lVBLjP52y)u_y6MX|e>JJD&J#0kP8S#>BscS)qFnShIDrYNa)RSJrrtD3>;6!a0zQ8w!>>Wo}JTbkuGg&P7-bi%55ziWVA;RM?A`$`r#N(M(UL zyK&JDelQMYe@ezXcQ59YRIK{rg6cn86~#p>Qsg)Knmt&U7~Ry4&+} zoeQ%(SAce}^p#_@KQg>!Q6j2;J+daDG=E!A^kigYU|?VZVoxCk1`wNp!I}k3F>K5R(O#1v^628PA&TH6s$PgN09g?Q>;M1& literal 0 HcmV?d00001 diff --git a/test/mpileup/mpileup.3.cram b/test/mpileup/mpileup.3.cram new file mode 100644 index 0000000000000000000000000000000000000000..9c827b816667218a74a3ce08541ba5270c5c9e84 GIT binary patch literal 19643 zcmeFXcUV*3(=Qr&5TpqR((9KlO^Wmmp@$+(dX-+Jw*UgtTOdf4PNYhg5;_P06qF)O zL;^^ONQsodh4;L_x7>5?eV%jgzi0h1d#zcYnOSQxGkfoqtpZlk#RCWe{^zzp_%9wV zE+8&3pjev@2LOnRNVa212L6vJyf&zze}NSBt4k0@e`i2UmpP8IeG`yfRMoyI+9vWu zFYvOdyes-Q59MHHT+#G?`a03r@arOpqG|a7tAXBiX`&F!}@ADj;d);XeF zOe+0^2AVJ|o6R(2*Z{no$wE0Z-=EbCOVG#C5u=i*)ij{K^lXyZQWT1^#P4IBv7WjgubV^RJGnlaP zZMeuU;*CYA`&&tDq=^A?F-^*XZ51)vXHtFPo>yu6swIalg*$UhY4KTal4!3WTjHyJ zZalgs#J#a|242mHx)(dDA=otZ*=6;-?W}C_e4!_WUUn$?j?EW=JrI2y*C5THE)?{f zS4Fq$TU6_JaxS{~Z_<_>Z6CWlyxx6dl!%xYky$fL6xHZd|NE&z!SJ2ojX*6IOy-56 zVE$XHM^*Ezu2pm}kh$;A^!z$dAg@yRg4N?bGv9F6ZQY*_mPZ;A^2i(wI=i00{&qAG ze);e`kNOLkBb?-3uZPQejB+ppMT&0&s-i8;MUu7yfHUNk-|w{rR)jL(^ksilFPkr_ zlgRSRZyAF=h)8?_jm(`mQ#-MEbr%x_E ze~e?O3JQGTwOCw$`|9&o(hcGZMO?`p{MFKjg#_5|vcGYE;K$()-`D(ybv60~*N-+M zQgIsZ2SLMwPEMcI@96KA!q3AMrQXfEPP4MSgIhnbXg_Uy0`%(p$GmbexpDxb(^Gf9 ztFEQ$EZp0XH5lG69E$J+y)><5Aqu8AL;uqrZQK;1GQ=Mu+uHFnpwshF=B12F-h5-k zHtTzfXgl#!ji=RraT}3IJ(tc}JhT*0a{o2J2WELxHX;PM$P$~L4wSGxxGCN@5NSf5q9HE$T;FHM|~m+V9P z*-?bN{D|jKc(>-@M;;4V75tYP$Dv%o?J``&Ltam=QmDSHHo5tc9>1pi^4z+y*dC#i zwYQtd-EwX(-eZPr)Np-jfgDm&ZXEo$Q&!aS(sEw8=lKI8ZRczb3+qH|KKy3n^5;9K zs{F2H_Bi@OnuBhbeDL=|r|-e^Y!y+5TgA&kGHMn9J^l;4({+=>>4YVNdg~zj8~^7q ztqt3emb4$9yH^ER(!TlCE~M3XYd~h|o{@=i$Njmg=M9~wR|8 zQT_|37uez_=Rc#EWypN39?goE^K%D-UaQFR=O5)|LF;KU`;Dy!qs03D*Uqsxta z4Jo2Cfw;K1c=!Z_gevNI_&9ht0I<&O)d>fnWPleS4ZtHH!okHS1QOpPy-)FghV~&H z2^l#R12c;lHT@%2c3xpoV{1xACN@qkZXP~TVWAeoMA-?g-u;!M`H}cZBec+`A)p z3bx7a$Q^j+j<<6++y&f`JBi&piCy3wxtra+li0lj|GLxs>rV5py9MptN$lN$_wLm1 z-9h&6di!^?`**{GJAH?DIP{&q)4Sdo3FHanDMSeZf@nhwASRIK5F3ac#1Y~QafP@; zJRm+0KS&@10*Si?@7zi3+_`Dz&d?6g9l2Arb7y1cZqqw=hIapLRd?2Y-Qj-SE#uc6 z_}ASQe%)>1*Bx%}ZVP*N`u6T5_U<5icl!43aC`r@t$*|LolExbjPKt`?BBU~|4z&P z-RvKdXlQg(^j8QF!V2Mo2tY(2Vi0kNBt!wC2vLTpK-3`W5KV{{L>Hn5(T5m9j3K5F zGl)6F0%8fVf_OrFA^wn;kYGp%Bn%P>iH5{L;vq?pWJn4m6_O6ggk(eVqM^58_OI9? zB>a!y`rqvQFGBJE7t2@&j|zx`2f!u7Cm;geCedv^5E82E-EwcE8V?^xKzPf&OFbeY zbrn1yo|%yw9u6+9x&dA^OdE#~AD4iboRW%~mY#u?jgwzU?8#FF4NYxRODk(fCp;qH zJrdIUWE2k`(mi5i;^5-`hliI>@UgIngrt;=tem2OjP z-|>^O(d|O-mVdiYEj@zUL{wI~O;;rxfU+_^Ar1~74i1;D;Vnj%iR%snzQd3h8sXrO zg0=ofUK^?0vdH{^-*3wrKJhIN=Qi7MaK7J`yZ<`8Evf%?cw0{Y>+rV5{@3Ac@%^vE z+bT?eON{sZwhaFlwuveJG5{CA!SU|}osa+rkA(Ctd~e8Q=*(-C^a9I%ed+8%hqU{S zCUqy`5CGz8?6z2Ww6- z)&Ou8p53DXxWx@QQV(uR*(%}{8PslMR1^$$nx7iz-9DOJB=FzoMaG!@V^{HuXqw4a zh$9KW06lCf#d*=;R6`Km%k4_UVDV@q5jg(5G&rX(SIzaI-{=U=G37s0ZHk2KD)_-L z+2}g0(bCimeFVuT>6YNg{(zBGSo5!p6a!SsFeSeyri zO-;f$0KigaIzprfkgDIr^AbE~Js3F}rhlu-sg@!yXB<14uKUDAocAY=*(X&BW#b$t zHdRXl7dGt{hL5CEe+}YUA-x%!0A7{WeJ8d`hQ63xM_#LT6DsXbLv?7ys~7YVDyWU@ zK_Z7Gl*^(ugy8T zq{_#Ky1yB6?sfKx`XAtgJZuHfgThBV%0vOurU+GJMGV#Z!beu^llE8@%7Wh$4S*DsCFAzdoA*f2yB6so?3*jK4h(IAu zR8d(V!&uG&-I3Em#_xYX!nF?zj4Su~aF)KyWIi&3=KeXMuk5nwbSainDi&7mmc`em zKd7p8^H38w3+rdZ5~WTF3-2e`34NeB@3)}47*d@MJU`NmW3L!V&53Q|t_d@6sVV|2 zRuwUEi_f_^aB?0{b`v8r%fN!uYTrm^G@rXu8*uJiz+WeFf2DsQ^i;#G5@xCSEjj>$x0ON!>4oH6?Ft2TNNdb|@tt zom@@)A|fCV9HqhKhs+rp|9JrS-)DLB{#`|LQkuqVM*DIP;!(@fjPTCjx*pwmJi`aj zm+|^IdjxauJ}tkK(PU_AWHKQ-)lL?=A++-JF*ViWvzo>IfR%eu`n<8vmE4N$rH+;^ zIHT6km_o*?%S~v-_`Loe6xiR&$o)h~Ct3!NJ9V+T_KA{9Q+k}tS9Wp(oyF51#m8^z zz^|Bc*EVP@3Gj|xAOBFvhxfS|aKfhtcSKb=oa_z&mU6*VsJE?$O~ZAUq}DPfm%|6u zJ<-MAyh*YheBAh*TbW_E*%j~9ZlO8zjHi@xS;yfC>NM>eEC%6C+W);tgW{pr16j^S zH@dbJ!A{{iW>Zm9UfcU!_G(RSD>DpNp2VRO)i_B=d$2D-%2^vBO#wL=oV)k&BZbX} z!Kd;s>QFCW1Kq>&0{z{*=m)u1vOOZ{;~O%aI`7LeRf5}Cvp(U((^S*rF7+^YP^=Nx z2}+iX1JKgK?(-uu!P8PtT>~WZbII>7NpHMgsaBEm+!P)N7#3dgA!eV9N>Da(f5_0M zKgZ>33etWk_)D*Zn+9mGQ5d1;CpEcaseYlLm12vBm!LlUSr5SA~#}TUF5*pN*nM z9LshM8>rXZlOSeLnSPB950OfAZKl7Mm|~>(vu`dl&iCF6)&0t=#2o0`zML`}LoXJW z?D&_3k(J~oY-P`bSh9Vae&z;Vc^8iE@{Ps%euQ+lL$7$p;>M*SuUxExe;QOASezWN zKReIRxf%ks4xUj&3bM>%I=@;~32oSy_!ko-=%(d1@2|3&XC$NP0W_;ueAe^gs_vWA zR&$m-p9UCtI)W6l2d;!#WwfCS-#W=#-WG&r5C8xIiT_CA;N!)1^joL?=WY)Qb-kCR zDB`y#qMmS`Qc5@X?$Hvzab6yV3Pg_Y+#pVymdgleS?#rFlzxXz0rai?RHrktOtwu( zHz$`Vz<*Ebqp)WZ*Zz#kk5LQjMnJY#IYz*cLU4+-KHC^wHRGoAmTV=pzs`1!(fD@G zT+WcR{#sN#T#h1gT@siPNwvJ5v_9`Bwg1HKqz_~Ic1A*9)TL;}LbJkIls#=W z3{EW?%Qrg36kAK5B1$)D%PPsI{uLV2@NkEaA{HV#B}V7me1u#H5R5UT*(?$yc>XTe zzr2rHEEXU+{mlaT$EZA!!DP~wdP1CV(-?W20RBR%yi${Nd$<0i%WF^j+U*w@NjkWa z!|t3(M{vQzAHV1YQ`(czM4S5-wAxG^?!JBW$S+o$naoecu8^)QGtl0Hz~`EwwUWiq z*^5qR()LS|d8mbPvx+7VZ|Z(bNa%&8tucdRcKdi_IdY{24x1?{&SQ~4-WnrQBFJ%) zaN~K)FOrP@wDtt~v0gNm@Jtea^!3s{hP(j0vgOz3wP&Hz%eq-zNVhJYtWb*FEtMCh zbA4s~tO%9SGELigapw6|k@)`9{Tw%n(WF{ho2Nw_sH*ODFF*<()QzHw#sOjh@GD0i z;cZt@izEvpJ-yaA-hph5O-zupQ*Zdbsw<(FYLaRTz{pd3!c=7I$kuZe+Z^9=NhBA1 zxRuuI%djh+v4Q={k7xTckJFJWierHW3S^Ns z=sZx8jd18C{_x1e2hdB@Q5}7XU%qJ)OidDbx%K*4Sj0i5_G6Q`YllLwknDtbE7Wkl zt@uuEKTubfolqw0*lHoeAnDIhwh}1V%L}GGY+HKkaQ`7IcKo@9cO$Qa$D51lDN~eV z2_yK{DW0?{^OnNx1q}S^+z`7T!bF(=0*HLeDNqe6!u)%{I@qD!GI;T;{mRNk0m*Pt zwP4g~{jZVMUotjrK?M!P*krfuuVE+nFFIB|gSrpSA}y18mF>Sx{YeJox!rDza}>9c z2M)ttAN@XQtz|jHRDRd~+GgLLK%Ou(He?f(7t@$YXDNtKZEWN%3}d@g@bv<&3ZwIA zj2H-C@yF(_r}a+qjxOMnc;#NjH|Uw@y+&DT?X5Qe!oc?0KHQ6&b=Vsw|pA?oVQ3U8NE z_OaLUE-uKw&;MTRCh^S&4NakPJb=!R``*J+#3OI4e`{Sxiudli-w^fNl#jp~#=UnG z{Q>(YPUp{5pS|zxV;8ND<^NFS&}H+SXn=!WeE&nKexQ(x+Hf`tZt~+zOenQmB`y4!qkBM9@ul2C5AsUFC!g-nC8Ne&)%BSGaX`3h%xGhPOaKdNr z`LoY&klOSlmo|4oPbb`{c~p?03m>5VgxbCC=er|4OxFE+`wu_E9{?YJoF?IRE!_&* z;AgIj?y{a{Q6vw4>@ZCQtgWojpAb}tW?m!@e}FnYCY1e4W~vbwzFU}^73LFl#I%y$ zirR0doy+!X>$nMv<8iEtLT}(~{{}h)%qzIPv{`4W6)>di0&fMuHv9^0G*+9+0#8;L zdA$rd<$&Q?2 z2(ilepiTMEqXcx6u(8Z%;@3G#pd_;7gfFpETSr_X>NdJ#&Q+C2BVnC`xSUOuJ@@fl z&Mnx_ob>2^@hZoQ!kUzUXU`rGIPr%@Kh#eWcidQ`jCY=$d#)a^BXT(WcH^}+~b`g@+nW5C<^?@ zl;7ziZw`DT%HtCBWMy(c&HMU{C$Zpk2Ib|XKGaeFpsQ(k;1#IJm4Eu&@TFOr^`MdW zK3<5w0ISi@fnVQ$4^9XlYq}{l?oIwkKJmHl&qA_$R=BG8B9d9E$&WurM+5bwKD9P{ z_T@CZZFI-%)K-qJ>>K+j)-K!n!ei>a5B)UpbW>Zpf|cDODy~OhDlfET=+;+OvGSnI`;3mEn$DdzsL8e``)_PBnS=GWmPy?YE-%gAEw- zVcd{zswt~50e$T5X|13kdRD3G_RcrX@^k-ZjZPGchGf(_rljN2c`R|LTbdicznq7! zB?sE2stnbJ(->Mgsa##0?q$ckF9v%{Q$__b=70TkyUDIQ6CXCmD2`77lw@!y_TE1A>o~et!2a13 zo!*2UT^?@Cf52X!ZL^dhut#Cm)=@K;J=h+rbp5=>n~>#g#LOgy1v7cM?=TGWmGfBM zj=cGUJ)3V}*gx2=UMRUdK9xuAAFMx?$IGxM)D4^dD8L&hW2fwIQf6xJCV1Y#JU6GD zg4tLMv_ zaTXySmVbV*Hukb)2%~`L!v-H%GI*9?vd_YcIw(6@HvI^vMFK_x$<8Yp5E3&pHb9MpEnLnc@3A;0@+K%Xv@w2P)qo2ot@D68?LAC`Krq-olmG? zHUc{dQ##_}W|5_I4qO7!C;s@=tT9PmRnF=i*C#eVIuRpVXIocKQ6-Ci(!ZC6i< z;WKUKS=ts>{kwD@LY_Ho{v z&d;PC3P*kci^^qN9VR9Glb=Etp_eYD%ARauZc>LNs3!t{v1*&2u;}W{eNhSbgL1yt zoKSoNqjtpUv>)W~2xK{wC})`~RH}TE66V9j%xh{d_nz6^WY=(loF8hUwl&M~Y7C6x z<5I0}<9W^7shK1=2uYM)o4%IyOq;4|^R+h!Lm!|}5cjZ_O9cAu%IJvXo=&AQohKOD zO>qW+GYFC`}>wsY$48GzwfQ;1ur>J`XEV;{+kLTq= zLKk19v9rn6X0xagElY}ksJTfxkrvl8*iz&)otUeH7{)%P`DaZ6quP_qK3eWqtTjKR zK&{f>0&iATeb$zJ(GQ%xkL4W#TrDt7Uh*r|r*q3^$Cn{c|IblY-s$WDH19-buybJK zf$Sl=q~wWun8IVk8p12jrX;c`ujAq6m(?}I+6xx>GmNZ9*v)48W=|{jWsh~S!p+{< z0%m)ACLsj>yB^0>x^Me58(Db;pBvL6WTR(vjnp2>F$y;R_6^b3iYX3!KrrSn)^7GD za&6g7?gJuq;av#1;)LEe(tk|s^^)qSl2Mb@qEO-*Cqt20^SvWYo)!>dxQ_Qk@0lr$ zTs}3h#WQ7+?ieG&Z3Hpr6a$_0F@O#1taCyc`MjG)l60DDdHan9bcCqsvk5NbmEo|> z2wWOwuQ4p++;+s`64MY-#M;lm6-?M($NX6f6YCHZUN)!kX{xHEYt(M#5EDjJVe6O< zn-Xp2Y+^tGRlIxC`y#rfwkt$jsyRe`so-_gb9A-C9?!vL!?Ox-)7*QJgQaSL;-9XZ z=f>sib;L@J57wr9deM373zvPDe>Xcj+=pMj$-h}S*$t%sXSzJ(vQ_tVldeQQqF0`! zBP@9!#QAzpqBLAJG7Y(7GA<#BTY@h@1IoMxCh zSDMPp3uhxMU;QRc8M^;O&KZ3O@sUc&H%GFYfSqeQMHj#gNNCreBeV26i}PSddA~~0 zu%sw{vA>FDfMy;r>A+HiePA-F>cBtrj_>7#TUwJqxv*dE^%|xP;a@DYE89ek)C7N) z2`VxE*=41sl>TTCJ=cSwqzoi1uqXUXSDap{Q<+gYp2KH^D^^LW^)X2?AxIH_sFD7; zc%@948f)lS&y=0>!P@q3--wRmpc^a}`z{q@DIT?asE=8g^i()p=s*2F>6C2L&xqJ& zY25xCANx$^%rd=x*(cD-hP)fWEaGWTrV|z+-QHAP&EdQr86Rei2bn?_fvUS>AB7*( zyL^dG{ksr3EWyfTL?hymaumwKQ6y+DwXt1@7ifFY8u97d(Lw9vZ+eIRP~`6=|JKhM zEJRt-9Fr9=GqGYDvf0;e5B6ObCXa8A8$=|A*5oeaE+T5C=!Tefs@szDr$U&I8Q-u9 zYm)F#3~=UG;!|sb+_c;U{h>JysuANAu#bwr(K<4RH9>%S(i`R{=YufwmPT1jbm>WYE7) z`C~OWo;hJ zQ8wD8XG&xZ)^cfwOOr9orm^%%$I1C*J_u8sr0XvkPh{}~= zt_Y8rRzhzNGtA7y7%LHdGpkS?irNcLV^g~IFj$@_Jxv66TGfn&6fpNLJv$s(F z0f?QwY)q=%J0aA)xy{A>6H18Jq(A?M>iYM~jlLoMF;Bu7*A4IOgB34C`qJ_ucZ$#B zc8y?dIIVe9b&kpTMrN0(X#;YsoX@}B7qmQMw$M>xw=93R==liFK1 zBHbRSj`GRL;r**v!Rg@oahBIDdP42tDpzq@f8V;TI?JpC4M(V?`;bh+)KZE3U!c4E zdc%VE!jgBCM|o7fOAuzc(f4K#yNB>en+rK^w8?^%mpt~4J-+Uei@Kp+&@WV|(bSt3 z?pa586g+F8bMx|N*1xGv@xA%87up*+D0>r*K%|wgrbR5@Tx=f9V6S=+hnR!wAEAVbQZvg!{iOd?X8Q5wse(#l7#QCQyb1Huncmlt(YiOF zBP_L>a)}Ktp+#->FmJ<{r&=rv>9=Ka1~mEd$BT-!-)ZOtolBPm5wc{wP6#WhGxvYL z^Lb64$(cuJa2K#M_hh*_YxD8fi&)zGNmfEs~RytwB0kC&FwJ>Bl7#>a;qTixmd~)8oW_ z&EzWYNpgJuS&0t?YCGb>w`duAwRe72j+Wm(s7&4a3Lo2PS{EZ8`V;@YzGI+Y5AE%> zg)UzlEU3OqEXUbFMpN<3;k0lqRlKhH{ zQdqnGH5O7VN3l7pgx^T%LKLsDbG?i@kZ|7H?oB6_Sq_QFkNCvFNa{nEEvTxG#A{Ax z-u7(YV5qWsq%B2*tk4f467XQB!F#jA0}Hij#;ci*P>8A)c7REe&wi zGT~a9&7yq=a>J=y(ZIiV$Vxx_TPsubO+pxX^1$Kzqwn}q-s&XLn?4VrTF$lOvloh$ z?~}5)>E(+8`~%ReO4OQgU?$CmNCAUqV8@!QVmc7OMwe||ESHh*2Ok!gY_MwZ=Ud29 zfVYD4FJz3~Q7r-0GE+oJNH!yb2wqf0tAVkBEUIjbDVra#eV&MTOn*;VR>yJvp@+Cs zK2vAk&6^0s!EeDwl#n4eU^k51VtKknhAs_PK+B1{#__#Ht})2XDffk7{Y1E9!^Fhc zW~O_+qmZ0m{V7n9Ojt=&Da8z;#ZWZwK$;>CxN4IgGqxWlRRT%X*4djHJJvrjoE32K z^An{n!`l!BCTQl#?5eR*46NBv;%6WYa$zPTr#3llrt=o*bz`Bj??Ito;Kp!MIA_K0 zx8K}Vy`+}F9UPLucrUhy*4)J=%54fZ5cJ!Gr&Dr(TuUP}4;}Uu7Ap{`gx85Waw%mxQPPgtF>geFA0V7< z;e&E<-7Z+rO%6N>sMd9MQZt!PsG|l?s6O>y6Cb3@F6@#cFF;Lw=nA98g=?7d!I?+k z_LDkaIS2&hY6{cGINtp^3U(E&A4>okx(gcC)|q5UM=Q1YXy^{6rAgCmq)?_9i`EJ_ zb7|-M@nmy3nF?y=n5jkAycZ_B~`J4>Xkv~Ia z{|rrxSin!;x_;q%O)d5grgH`W109|c3*+|Yr@OICdpXbP9lJ44%U$fmXf!2sziuFR zYlx}<8gUDjwuw^4h>hqd&&RI+NT20Ro*!JFn}3WfC{fUI)adRTTa*mz+wk0v9By*cC_oi!WwO$+ zYwEuySDxj=H?~To8nU977gKjKX;6+d;DyMfgZ2>&0tQT01!+dH2uoB3p;&&-{ z2lWqoGl;7;H!F$M*c5&*pSQ}G*ST_dXKBS1NX;I-)?E?nu|FfLmCI=&x~_b{gumhni(OCxpW{)psr;`W2d!^q4_v@Pnj zjdM9!{D)Oja8yc>-yy!6Wfb8Vq(T{#$Kw9gGLY{of?42F!^|!)G(TLR-sC)3)~`NX zpqBaenM-Kg!s$armZm9))vXjSi+$zNPL=Lzm;#yFlnB6699>hH3qLcMwgV}dQjJ8H zP~&%`vBnME|yJWH5TjM@;G z=!!$|nf*0I$cJ>1y5$r+O@o0rjtqHTneVpa3Mo-P#Yt`uqDbl01f3_Us$Xj?v`mZh zYp69VNPxkTvHDL51|vRcU658$v!D{*x^Z~C30q8*uGV1jtRZrP8+O&y{Zcb^63xtH zZiU%R4>8#ZzX%QBgwSDJh;VLvPL@)`_C+)b9Hu|^K4}rNDCo9SphVNM=DV`b%Gy%K zN4B)+ixq4yx37NNI#|BUlWb);xVVn&hDonsmhJR!ZbZ7fH1J1$65VJ#rAQ=)5qaog zGDXTCe||D;k`9Ica(AnTx3wA@)0mU;5m4c1=p+XgIUw1p0fg~L| z5HH!a(1Pb>7yVhNK?n@`LfBCT(`Oe*_yz~uZ>K<4CtKd{dQ9%m)??g*6$tOY4MbofN*-9|y7QzuqA~%0W+OW?RupELClB%u zFO4m(jACK+cdHbARt48|vJcP~ub0SxXZQ)SLbZL!1>j5cwx4;yZ2c>`V-hY3@s@Fu zvM9<2PlcD75~geks4@ZB^gVKp4NxgFHP zMi`H-4kpd|m!~XIyMK@NE)nt$doy#^Hp_dy5o1>&W(toNwml=4uRWQjgd@5= zXIvaq14XUN4?aXKO?#eA-aW(+F1JU7g>+$`G&DY5f4p#@w!FAHBltmG!TQ?aTK3nO zzu2(n-ocm%d)2}Q-Ntk-JB@fNA1}Hp?K?c{TMZ?BX(4%)=_h!bsq>#9hc|*i3i|Iq z%&bWJ2d9t4VMW!eXwPXndC$`HC6B*$MCmPftTKOEQ$N=Uc79PBFo9B}romR@Wy+S; z5*)sm3xE1F-QmKt-8p@{C*jqYw}39`ST01{OwVjDcglK4T?JoXUHEx!U+$$ZKVLZB zK6<~JHmMyZU3e_Dkc@r90sMBo6;pkaFHt?i0oWU0?E+lp1Ge4Ef>yRy zDW&r-7kxP3GS#GnrYceN%+(sy(cjTSMQXNe>|=Ybik)FNO6(5|a^Hhl;JNYwsaYpJ zUni{g4Egt(O$CK2N)x+@{s8nDOaHQVX)gMf^p&`zlVc-_g)2UCl%>*TGH)b|{1x5? zib=*h%sNpv?9PiIhm_sIOe(Wv#rRt&^`vY!c2>hzdb^8s2Y{KHuW>VRxS+2D;C@uI z_cBdnqf#4|=EU#IP>3&_sGiUrdY4aKN+0}r`YI6{F&rXSeB&>p(1JNWcWLomkBkbr zXjz|mwjSAwcYD=kv1PX9{o~~2woK;bzQ(Lgx(>F`6xcpB>XUF#G)#k^;W3{3btH=fUp&*y;~KjT zuMOa8hws&!umWbK!F++xsp~&;8XCiz&4u|BU)Wpu+FlTke4hoqqR6K%Jb9D&AV3{I zjgdC-_hxikL?=A0HeGMfdggKaN zULXC8=G0dZ??cZatWbF@m)DyTDn};@LDt3fOSRYwnL+#E9uJ9ci2z&4QkJq-H;JDd z&Ycw=V>}sEBsT0eh9nW_?w8-BJ&_J2*jaRM8-V7ToWX}YGyzYOiiA{DAR5>;=2h36F2Xnj-a=N{ZzC3AWYRto+9OT#6ipSg{`kG~auc7E|`mXyh zhw|73C)*dy*hezBWa}S|sg_#ue#OFbvcQiF;7z8FHA(q8hY}KIDabC$Xt&uPQo7C+ zX%c#zp`3@-)*fTJr%(r;SKod_7H%)Cohe+uI3`sHW0X0Zxuz{@FX|>ocy`#WdX`u& zTNttW7R){HO<_TVa{Q28wYco<{f45nxfOfrb zf?vOdgR9J-wV>CulmOiMlH%h1rc18&AfeeI6xQ#urDN^#02|oFSTBZ(M)@MvMhk*k z*5^ew{n9dV3dcld7-Y{%ocm5iELS`cJ=fRg3q3kA>&Q7AFsGig0iXx|^KG2%&n&;M z9NGEWcF;;vRTD52l$4MElj@q1xpTd$>$AXgIfHDLT3nb8ISIN+Q+DFC1}R|5E!ML0 zsFu7k$5b$rN&~8zB+jE;8ao`3Rb*-h-VOtgedpt*@q-g=)}bwlz>5abi{HvK&c z;*Yx@9SPO^-sX=LCg>&%;lQ-@bh7a#cU-Ooci&oBm?tpv?`5{V(9(9Vd~rghT?rCZ zE6!pm8^n`kh?uB@Hrfu%t2=~tEV*f4-%oR<_twgLj3+A5%rN2_N zA+}k@(D_wX#=G~u!^zRq`{Th)e$r1QnKC3RcTappg|NXu6=!!N2{tBf9z^n&6yv&^ zUpALer7EI{GrTyYG)+t@p@xQG+asDI&jMMFPY>2~v)galY`9041hb_rk^@Mn{DHJY zyR~kIR+@S`L0X&%^qioa`&GlD%w#2Y^NsTdfWv0=5TVa9xn6fr7v+ZLz&s;OfGLRP zC*uVZFgbI`KZdetw_wWVv54R3+uh|!x|T~1uLI#^A4X;uRyx!tBnWID&-c)Y%B1TT zhkm8%#b?r-VELAaYsj1&8n12fi69j?@vpg zvKp9~P)|WCJa=T2DZ1^_De(U$F_5wBG+w%j>yx}rE~KIv#03%t1Nb!IUnV|*j$mLA zzqX^Ye2m_LpcXp~8*U06_C)FOlY=^EDbS%EkoB6{uX04?snncGuNTis5NRC_D{EcY&gW;<@pJ0k9(f02B_(}R z2cZm02kF~+EDBNB&b|ogv53P0x%6i;3B9cwvfJ2|$IVO~L-O7TbaQG)NGmOhw%1&N z=Kd$L$s9t_4WLt|$y<2Vd{*at7Om(MwfTezKbNVx60cvT)gh^RMMBYK%28ieYQ%7b zUF*h1{#53NAy4HBmJ^IYRqzqj%eA7!N-Hj7 zbGe2ZX8atm{^jPv1AFl2Y=P{Hw9w;a%)8VB*@%6+!NuZrA#XIgDDT;gUB3Pe|JaFe zTrAMsInH>(m?l3tjVluldJW=v7HY(+P0v*30w8#ixe>vRe|NcZQvovBmq7c}tv+a_o!}Tca<=*7k`PqVZ>m|zqi_P`b z=4D9-x@5f%dw$lq%(5PtdVG%E7Jq1e=-u8y?`!?opt|jKA}eQld&j0U)A#oy*U>j`D1%a_P)k$nWvr^7q4`{3^EN-WXH~hzdn`~3 z7G`i#KK#_?q-Fy7%D#p2aS1u5YkgWieri`=Uw@Ty!&)(8V!}9ARoMTlLat@QX-y@c zR@cr@GW0gW4H0)8w6{uz?;9{i_~5H+?VDfpPz6#{9uI8i5NqHCXUH(}Is( z7`QvtTR|&@LQ;G>D1S!|t|AacjoxD;dQlgMZiIJ>7?7a4vws5?DDQaw5U* zjP2SL`lbZ_U0m*D*%%V;nkgCcU3=3;M_JE1l!+RSvLNySjuLDIg>yzCJ|FHXkNOQL#iPWRHcqYzQu8w*=fjW*ZVv4s)@k(W)B{AtIrlu#ZE zj^DX>8m$zg!y2N{i!g(lzXfcb4t8#^(Ehli-w!11`GBA4{pj&LPax zzjG|Md9(7tmG9v%Rcc>2y+0WcqqJT@$%b~0M4lZQi^fuH4)(w1}t!IDsuEz()YxrpPEf-g-2PB#ZW=ZB8I@32vLl?<{4|lS zM65L=u{g+}>R+WLW*qeqv*hS3Cy4P6l2J5{x%O$ytO*V5B}=5YB(5W3?c2c$DrC3aW_x~M@?idY z({BlL*@dxlUiR@nlPDftx}aqYEAdG`mL=<_bS4F?CCET{^BZGkrv^mVUjwPw`-igP z9I12)aToOqs=Iv8B(@`9mV2uX9h9WNRo~NtPy}+*r;2V+kwD2k;+wR+9tL$lH>cOV zvYoPcdGtX6b9^#yeQ+9n-gC2ZA%8iEMg^Y4Qw+$*>k>vJlaFugR(p>nf=@WbesqFa z-sjwYF5p;J@?BA5@cxE!Fw5;r(1%lp;6Qv*X5mqMGjo$C+!&JBa9~9E zQ>?M-mEa(oUCRj)IG-adyfdfH1@ZzC_5PDd1$muFe7qwu3Y&{BTBT45qQEg=2RlOH zG1?#7Ouv@PyVh5}YV$K`IHh`Jk#4bT{t-a~$k{5^DhwR`-L&z!TY9QHJu)3I6Rn%5 z#ibRYN!vmPgsL!_6?GXvwQF+VR`~>Dg+>9K6lyY~^Z_m1=E1nhhJB1;x6y1=cJceS zRg#sl^NO6?ET0pc(}o%&Z;WK*g-Rocsekyb>CH48WZ6NY@a9PYet zU)ob>L@La+l(SWnQrIJWU+bj5z*>udIqJP6uuO3 z85#C*E;e0YxWMZi_j;&%y~S<~6bywqjw0>3@if!l#9^wdtFd3})9wDT&w}~JW#avw z3v;pkaH(GppZ(4^m`t%{r;$592`?F z*Q^|OwP__2Q-kUL9r+FQfISWf@oymLh_w`EC$cSGUC!{4*o8Ajx_|u2Qb1q}kG_m6 zFBe5kBiJI!?_X(b63YwzLZtIRLAC5VB?{XF0S3P(`J)*48YIYR^zMaW*PqPVABbr) zVp=k>;Ou#exyyG_OY`N_B4Q7q00F%*8YC8sI*3tw1;0DjJCb`J4ks$$IbEEl4Q&~Hu@WLISS+&%_T<#qh5}#4^zBcZL(j)vh2X?mQ|d zJ%tSsF~!HxthD6`6lKxE>C&qYe1u{qcw$sVhl%-W!;Qa|`~Bp|W6pQyeUM&RCP|F{ zy2g>G1(wflmPwX#p0Z|5cL>Y^$q&X1SPrI@;8$2tnZma@@@QkUjVm)+IaZ*ek`*Fu zN@JZ*h|2X!V<4|LS8l8S4WlRKdhcLLZNYO-VI2|ftssQ<4-1iQKL}mF>A^0pg^qOv z#ip-~ZTZ#o79X9}ucqxSxAC4psA5w}Igl%9c^FSL)&<=dw0OF_fSD{=Z?LiMYqRXR z=-#UCSWdm1+*&KX#*9d-Bj+0)cRcJaeiqc>?0l{yH8t?tYSx0MfS-o(s>#R}5Lt;? z``kN1`A_)Y`d2fHjZ^UjYVHT`XEqDTI>)wxL&8Xgdom%m!5_w2nLS(Omx7pmS+imf zeqcNi`=nG)2N?a?fAndj&>8g>kOwhfj(2Yg9oRVs$dHqsYmtSpF%$30Q>Q5MwV^Rr ztW^6hT48-HGIid%F>h@Q=6v_R!adDs&1T%rch)87ee?yv>i-{i}rtdtpU(eyutV z?fg)$3_C?}Q<+)*NAj%DCw#Y`Z`9?qz6YI~b@_eWJTiNS`u3>=>Wi<;{}ucO1Nq>?s7a0KXv2q1J734S-_YkE=jHA4 z_T}x{Ti;(d)YJdrJYxX2*KN1qTRhKg`_;$i>-OpO(;wfzet-V?wlPoT@pS9b%e2wiy3YVcxE)h76gh)0-I#D^&aZciImX=Y z5l3(vHGwq5$r$eJZfvj;N)~Wc{-#t)XI7)kF+e&&K<>^EjdWKGjtJX3?mlhK^VrQT zR*)H#s8DFib@*C|M>6yAc+^~3kIKwiBQqbFs#NC6%3NAn`9W1AB}hpiAclKCt<5uW zdTwDJKpZkcC1#$KL}^J&xpJ+gmAUfq$Sh^8%*v`<`KZdwM`f;*>K`f=|63_pA_H!k z&3w?@t=}Vp2KXQY1PPr*kQ4xkVphqNsS?)`WsBrmxpJ+nNtVzy9_1X&dM7qxWyG3DL^KP%7 z{P@q8Pos_S+w;rM`T4K?xz9N7-pAWXGxzS+PY(~nm;(p^?2`i=q5Qxql&UHNs#Ob9 zN>ygAmH9|M^tb-b%*qA8q8)=_@DJVOAs`t6Wk8ix2^LFI7IP_AJ*rr1)k9LsrP6w2 z*5e^BrFvyDi3O3#a4b^cnEO0`o-+VAW#@I|42lkQ?;eC?J`k2hA{5@3Q(7gFHIvCC zAnUymk{tjeMgY;eVOkh2?PlQ)dN7$GA|TG7K!Fi~*in)mRHl|5Su0f~X^zZFHAaaF zN|h=Og&IjD00z*{aQ6@uB#;n5_~`^y1lwHb?Y%Vp^2sV6p~AYaDj8`|rM+UH|H0c$mYjw^HcHXS*ef!(~NJ^}V6p=YDUm z->2c)CXSdM{d(S>KMy-!&)$99z00;95eUd2dbCD@0Us%nQmTR@8jb02Y;Z!|qXaJH z--6?B>5;jdh~T0e;cjm;rU#8g63j+|3jh%?H%#xE4UKZAxF};~QZ}~K2h8ClGbI5M z7_xAoU+jJ#ZCJGL^KR|9zkS_0aR|wpb_z2gb_>)Tnx2?S<`9%*rf6$rN$N+YRh5#N zm0|{wu-#91SVWBDsoNF-7KsEDf+j5I?Td9k#_q1;9#ekqcFaLHM&CC?pR5de-<{j# z^LF3we;l{*dO63uo11%tFcQcNu-wk8_2DGS04|u(yM?4Adt+#=T1$%* zm6BFe%a-mY&Hyo#XGl;4tRHYQIQn?AXdniBq7GeCr38Psy%H)_k&q|Ih!jQ~<{gYV zeD`yV=@u65=hM^EF=u=Edb|8Q`xRaHgTp!Z`}O_ub@SJk_t*EY|9T!5d-=NUm+|E? zF1R%xZ()55iIoBxVO5moHg>v^qEKdG{r>_xw-}jNdIPmgFik7;KftQ&hickKwjYGZ03b zh!tP@TYc^RNy`0T@O_!d7uh-?L;~OAloZ96Km$sTW%cTr{JCRvmEvY}MimKTXcZ_S zdKA;Q!Tjz4WL$~M8b;??FeXy92eT1h*Ymo<#;)?}y%C7Zh`u6y(+X!U=ZFTe@elSq zjFCG7g(qup^Vfs`m{W1>2MWk+&_tcB@DuA0dKN=}{tIog;#H#lYY{R6S1v5b%Errl z_JAcv#(SI_%i`x5Ek@+nglpvAoV(k!wMTNKRfkKBev*MPxuP;vP(?pOsdw0gL+wyu zNC3W=JUrTT>EZQ24*&oF|NsC058y>lMgRZ+00966z1dFy0RRRD0RRC20RZk}0ZRZW Bz!U%g literal 0 HcmV?d00001 diff --git a/test/mpileup/mpileup.3.cram.crai b/test/mpileup/mpileup.3.cram.crai new file mode 100644 index 0000000000000000000000000000000000000000..6257e4bb473cac0bcd82851c39704b293449dde3 GIT binary patch literal 43 ucmb2|=3oE=X5$AYPfQFA44#;nY&UsqVq(ZFly=OmEr!9i-E*BJPz?a@jSH3l literal 0 HcmV?d00001 diff --git a/test/mpileup/mpileup.3.out b/test/mpileup/mpileup.3.out new file mode 100644 index 000000000..e0ee45aba --- /dev/null +++ b/test/mpileup/mpileup.3.out @@ -0,0 +1,30 @@ +##fileformat=VCFv4.2 +##FILTER= +##contig= +##ALT= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##FORMAT= +#CHROM POS ID REF ALT QUAL FILTER INFO FORMAT HG00100 +17 1050 . A <*> 0 . DP=6;I16=6,0,0,0,232,9002,0,0,360,21600,0,0,113,2597,0,0;QS=1,0;MQ0F=0 PL 0,18,152 +17 1051 . A <*> 0 . DP=5;I16=5,0,0,0,191,7317,0,0,300,18000,0,0,115,2675,0,0;QS=1,0;MQ0F=0 PL 0,15,135 +17 1052 . A <*> 0 . DP=5;I16=5,0,0,0,189,7223,0,0,300,18000,0,0,117,2757,0,0;QS=1,0;MQ0F=0 PL 0,15,135 +17 1053 . A <*> 0 . DP=5;I16=5,0,0,0,187,7027,0,0,300,18000,0,0,119,2843,0,0;QS=1,0;MQ0F=0 PL 0,15,133 +17 1054 . C <*> 0 . DP=5;I16=5,0,0,0,184,6852,0,0,300,18000,0,0,121,2933,0,0;QS=1,0;MQ0F=0 PL 0,15,132 +17 1055 . C <*> 0 . DP=7;I16=7,0,0,0,255,9635,0,0,420,25200,0,0,123,3027,0,0;QS=1,0;MQ0F=0 PL 0,21,161 +17 1056 . C <*> 0 . DP=7;I16=7,0,0,0,252,9454,0,0,420,25200,0,0,127,3127,0,0;QS=1,0;MQ0F=0 PL 0,21,159 +17 1057 . T <*> 0 . DP=7;I16=7,0,0,0,269,10389,0,0,420,25200,0,0,129,3133,0,0;QS=1,0;MQ0F=0 PL 0,21,164 +17 1058 . G <*> 0 . DP=7;I16=7,0,0,0,281,11297,0,0,420,25200,0,0,131,3143,0,0;QS=1,0;MQ0F=0 PL 0,21,170 +17 1059 . T <*> 0 . DP=7;I16=7,0,0,0,257,9509,0,0,420,25200,0,0,133,3157,0,0;QS=1,0;MQ0F=0 PL 0,21,157 +17 1060 . C <*> 0 . DP=7;I16=7,0,0,0,268,10392,0,0,420,25200,0,0,135,3175,0,0;QS=1,0;MQ0F=0 PL 0,21,164 diff --git a/test/mpileup/mpileup.3.sam b/test/mpileup/mpileup.3.sam new file mode 100644 index 000000000..e40039de3 --- /dev/null +++ b/test/mpileup/mpileup.3.sam @@ -0,0 +1,250 @@ +@HD VN:1.0 SO:coordinate +@SQ SN:17 LN:4200 M5:a9a06ca09c111789d92723fbf39820f6 AS:NCBI37 SP:Human +@RG ID:ERR229775 LB:HG00102_I_bc_pelib_1019 SM:HG00102 PI:497 CN:MPIMG PL:ILLUMINA DS:SRP001294 +@PG ID:bwa_index PN:bwa VN:0.5.9-r16 CL:bwa index -a bwtsw $reference_fasta +@PG ID:bwa_aln_fastq PN:bwa PP:bwa_index VN:0.5.9-r16 CL:bwa aln -q 15 -f $sai_file $reference_fasta $fastq_file +@PG ID:bwa_sam PN:bwa PP:bwa_aln_fastq VN:0.5.9-r16 CL:bwa sampe -a 1491 -r $rg_line -f $sam_file $reference_fasta $sai_file(s) $fastq_file(s) +@PG ID:sam_to_fixed_bam PN:samtools PP:bwa_sam VN:0.1.17 (r973:277) CL:samtools view -bSu $sam_file | samtools sort -n -o - samtools_nsort_tmp | samtools fixmate /dev/stdin /dev/stdout | samtools sort -o - samtools_csort_tmp | samtools fillmd -u - $reference_fasta > $fixed_bam_file +@PG ID:gatk_target_interval_creator PN:GenomeAnalysisTK PP:sam_to_fixed_bam VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T RealignerTargetCreator -R $reference_fasta -o $intervals_file -known $known_indels_file(s) +@PG ID:bam_realignment_around_known_indels PN:GenomeAnalysisTK PP:gatk_target_interval_creator VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T IndelRealigner -R $reference_fasta -I $bam_file -o $realigned_bam_file -targetIntervals $intervals_file -known $known_indels_file(s) -LOD 0.4 -model KNOWNS_ONLY -compress 0 --disable_bam_indexing +@PG ID:bam_count_covariates PN:GenomeAnalysisTK PP:bam_realignment_around_known_indels VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T CountCovariates -R $reference_fasta -I $bam_file -recalFile $bam_file.recal_data.csv -knownSites $known_sites_file(s) -l INFO -L '1;2;3;4;5;6;7;8;9;10;11;12;13;14;15;16;17;18;19;20;21;22;X;Y;MT' -cov ReadGroupCovariate -cov QualityScoreCovariate -cov CycleCovariate -cov DinucCovariate +@PG ID:bam_recalibrate_quality_scores PN:GenomeAnalysisTK PP:bam_count_covariates VN:1.2-29-g0acaf2d CL:java $jvm_args -jar GenomeAnalysisTK.jar -T TableRecalibration -R $reference_fasta -recalFile $bam_file.recal_data.csv -I $bam_file -o $recalibrated_bam_file -l INFO -compress 0 --disable_bam_indexing +@PG ID:bam_calculate_bq PN:samtools PP:bam_recalibrate_quality_scores VN:0.1.17 (r973:277) CL:samtools calmd -Erb $bam_file $reference_fasta > $bq_bam_file +@PG ID:bam_merge PN:picard PP:bam_calculate_bq VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +@PG ID:bam_mark_duplicates PN:picard PP:bam_merge VN:1.53 CL:java $jvm_args -jar MarkDuplicates.jar INPUT=$bam_file OUTPUT=$markdup_bam_file ASSUME_SORTED=TRUE METRICS_FILE=/dev/null VALIDATION_STRINGENCY=SILENT +@PG ID:bam_merge.1 PN:picard PP:bam_mark_duplicates VN:1.53 CL:java $jvm_args -jar MergeSamFiles.jar INPUT=$bam_file(s) OUTPUT=$merged_bam VALIDATION_STRINGENCY=SILENT +ERR229775.22049853 163 17 1 29 80S21M = 115 213 AGGCTCAGACTCCTTTCTCTATGACAGGGAGGTCATGTGCAGGCTGGAGAAGGGGACAAGAGGGCCCCAACTTCTTTGCAAAGCTTCTCACCCTGTTCCTG BDBDHECFF@D=DA>CIJIF8E>HBEEBH@AA8>GH@BIJI;?CC95@@?*2-67=6?$6ABDGD6GGHKGEGHIJIH=BFIKI:DEADBH>CFIE MD:Z:21 RG:Z:ERR229775 AM:i:29 NM:i:0 SM:i:29 MQ:i:29 XT:A:M BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ihg\aehjhYcd`cag]behd +ERR229775.4635304 99 17 1 29 9S92M = 250 348 TTCTTTGCAAAGCTTCTCACCCTGTTCCTGCATAGATAATTGCATGACAATTGCCTTGTCCCTGCTGAATGTGCTCTGGGGTCTCTGGGGTCTCACCCACG BFFKGHHHIKIIIKIKLKIILHMKJJLLMILJJJMLJJNKLLMKKJLJKNKLKILNKLKMLINLMNLMNKJJKLNKMKFAEHGMKPLHFGJIMIKFFFE@; MD:Z:92 RG:Z:ERR229775 AM:i:29 NM:i:0 SM:i:29 MQ:i:29 XT:A:M BQ:Z:@@@@@@@@@jhhhjhjkjhhkgljiikklhkiiilkiimjkkljjikijmjkjhkmjkjlkhmklmklmjiijkmjlje`dgfljokgefihlhjeeed_Z +ERR229775.76124411 163 17 1 29 12S89M = 253 351 AACTTCTTTGCAAAGCTTCTCACCCTGTTCCTGCATAGATAATTGCATGACAATTGCCTTGTCCCTGCTGAATGTGCTCTGGGGTCTCTGGGGTCTCACCC @BDIFEFFEBBGJIHGJHEIJHGJJKIIIIJKHHIIIJKICKHE@>1;<=E?CG?F X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@H +ERR229775.71066602 99 17 35 60 101M = 291 355 ATGACAATTGCCTTGTCCCTGCTGAATGTGCTCTGGGGTCTCTGGGGTCTCACCCACGACCAACTCCCTGGGCCTGGCACCAGGGAGCTTAACAAACATCT BEFHDHJHHHFGLIJIJKKLJKLKKMJIIHJLKMJJLMGGLJMJMMMEJMMKKMMKJ?LKLJMHNJIIMHCFHGMFCIJDHJICAIDJJFIHGGIBBHEEI X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@E +ERR229775.57643739 113 17 39 37 101M * 0 0 CAATTGCCTTGTCCCTGCTGAATGTGCTCTGGGGTCTCTGGGGTCTCACCCACGACCAACTCCCTGGGCCTGGCACCAGGGAGCTTAACAAACATCTGTCC DEEFHE@C?HCHHAIJIIJIHCJEIE;JHFEEFHKFJFJIEGIJGH>9KJD@;EFCJIFA=JFICKIDCFJGFC?IIJHHHKHB@IICIICGCGJGDDH?? X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.24343576 163 17 62 60 101M = 322 360 GTGCTCTGGGGTCTCTGGGGTCTCACCCACGACCAACTCCCTGGGCCTGGCACCAGGGAGCTTAACAAACATCTGTCCAGCGAATACCTGCATCCCTAGAA @DCDHCFB>,,FGDGFHGC@FHFIHGIKH@2JGH@JGJ?EJHCA5?BLIHEJHIGFEB@BG;BBEDGIEDGGGL;FGFI;A37F9F2=@JCDKHJGAIGFEEEE X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.48988007 99 17 115 60 101M = 371 356 CAGGGAGCTTAACAAACATCTGTCCAGCGAATACCTGCATCCCTAGAAGTGAAGCCACCGCCCAAAGACACGCCCATGTCCAGCTTAACCTGCATCCCTAG ?GDCCIGFKGFKGHKKHGIKJIIKGJHIACKFGHCKHJJJFIILGFGMK@CKFIHHJHI>JIFJMEGADJG>FEHJIIIFHJHIMDHKGIH?CJGGFFIE8 X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.22049853 83 17 115 29 1S100M = 1 -213 CCAGGGAGCTTAACAAACATCTGTCCAGCGAATACCTGCATCCCTAGAAGTGAAGCCACCGCCCAAAGACACGCCCATGTCCAGCTTAACCTGCATCCCTA ##IDEBEBHKIDCIFDIFGKD?EHA>BA;GJHIABEGEFGIBDGIKGJMGJIJKHGHKJALJJIJ@DCECE>EIIIHHIKDEFHIEHGHHGHGFEECCD@7 X0:i:1 X1:i:0 XC:i:100 MD:Z:100 RG:Z:ERR229775 AM:i:29 NM:i:0 SM:i:29 MQ:i:29 XT:A:U BQ:Z:@@B@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.6535575 163 17 136 60 101M = 400 364 GTCCAGCGAATACCTGCATCCCTAGAAGTGAAGCCACCGCCCAAAGACACGCCCCTGTCCAGCTTAACCTGCATCCCTAGAAGTGAAGGCACCGCCCAAAG @:9D&@9/0<98DBCCGCDG:?E=>D><+/;7A:=HE71)61>4:KDDIKLJJGJH=6GAIGEIHCHGB@?>HBFHGHBGDFKFGKHGFCFFGBBEJFIJMIFIHJJJLIDFF@HDKHEHGFEHLHHDEFDB X0:i:1 X1:i:0 XC:i:99 MD:Z:99 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A +ERR229775.74734077 163 17 164 60 101M = 421 357 TGAAGCCACCGCCCAAAGACACGCCCATGTCCAGCTTAACCTGCATCCCTAGAAGTGAAGGCGCCGCCCAAAGCCACGCCCATGTCCAGCTTATTCTGCCC 7+>C1A5?-3&B<:EA:(86>A4F8=B<7>7D52@7=>CAE5DK.DCF>(-706B=ACA>D<@IE4:D;CG;@BH9@GH@CCJ@G=B@;ED9E@BHDBFHGI;5ABFHFIG=FCE/=GHHEJGJF X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@H +ERR229775.86942903 99 17 232 60 71M1I29M = 471 339 CAAAGACACGCCCATGTCCAGCTTATTCTGCCCAGTTCCTCTCCAGAAAGGCTGCATGGTTGACACACAGTAGCCTGCGACAAAGCTGAATGCTATCATTT AGHIGIEGD>BGHFHHIKKILKMIIIHIKHJKLCEFJJFMDLJIFHKLLKDJGBEGGJ?@GFIIKIH?GGHDDACIB?>DDJFGII1?,9ED*@>D@FCE= X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR229775 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@C@ +ERR229775.4635304 147 17 250 29 53M1I47M = 1 -348 CAGCTTATTCTGCCCAGTTCCTCTCCAGAAAGGCTGCATGGTTGACACACAGTAGCCTGCGACAAAGCTGAATGCTATCATTTAAAAACTCCTTGCTGGTT EIGGGHHHHCJICGIMGCJGHKCFDJOJJKKIJKKKJIKJJMIIJJJHEHIGILLLLGLBGDJJJLKGIKHGIIKHHJHHKIFHHCG;HFBCGFBEFCDGB X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR229775 AM:i:29 NM:i:1 SM:i:29 MQ:i:29 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@IG +ERR229775.76124411 83 17 253 29 50M1I50M = 1 -351 CTTATTCTGCCCAGTTCCTCTCCAGAAAGGCTGCATGGTTGACACACAGTAGCCTGCGACAAAGCTGAATGCTATCATTTAAAAACTCCTTGCTGGTTTGA DDFFFGHJIGHINGDIGDJIJAINKELOIJLKKKKKMJLKKGJKJKLNKKNMMMKLBLJLLLNMMJKKJKKJJJKKJLLIJJHE@KJJJKFHIHFEIIHFB X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR229775 AM:i:29 NM:i:1 SM:i:29 MQ:i:29 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.72556128 147 17 262 60 41M1I59M = 22 -339 CCCAGTTCCTCTCCAGAAAGGCTGCATGGTTGACACACAGTAGCCTGCGACAAAGCTGAATGCTATCATTTAAAAACTCCTTGCTGGTTTGAGAGGCAGAA DDFJEGJGC@IKEINIFFMHKHIJKKKIIMJKJJJLKKMJJLKKMJLCKKFKKMLLJKJIIKKIIKJHKLGHIGC>HHIJKFHHHGGIJGBEEJAEEIFEB X0:i:1 X1:i:0 MD:Z:100 RG:Z:ERR229775 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:CBA@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@GG +ERR229775.73749010 147 17 283 60 5S20M1I75M = 28 -349 AAAGGCTGCATGGTTGACACACAGTAGCCTGCGACAAAGCTGAATGCTATCATTTAAAAACTCCTTGCTGGTTTGAGAGGCAGAAAATGATATCTCATAGT ######G?<7G9;+@-DEI=CHOHKOFBHE9BHKFE>JHDH9?GHFDCBKCIHA;E=C;9>@A7HA?;AGADHBGHGG@@:>8HG?D9DF6/;@=>:BBA;FEFGH:A7E<&>HAJEIEKKKJGMIJGILKMGNLLKLKIEIJHDIEFE X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@G +ERR229775.65476258 99 17 324 60 101M = 548 324 TATCATTTAAAAACTCCTTGCTGGTTTGAGAGGCAGAAAATGATATCTCATAGTTGCTTTACTTTGCATATTTTAAAATTGTGACTTTCATGGCATAAATA BFFFGHHHHKIJKELKKKJJJLKLIIJIKLLJJLJMLMMNKLLKFJMNMKKJMKKLMNLLKKNLKLMKKKKLLKJNNNLILKLMJNLLKLKIEIKHGHGFE X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@G +ERR229775.44063798 163 17 331 60 101M = 608 377 TAAAAACTCCTTGCTGGTTTGAGAGGCAGAAAATGATATCTCATAGTTGCTTTACTTTGCATATTTTAAAATTGTGACTTTCATGGCATAAATAATACTGG @92:9C:E>:EFG>H@ X0:i:1 X1:i:0 MD:Z:0A100 RG:Z:ERR229775 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:ZS@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.59467859 147 17 359 60 101M = 159 -300 GAAAATGATATCTCATAGTTGCTTTACTTTGCATATTTTAAAATTGTGACTTTCATGGCATAAATAATACTGGTTTATTACAGAAGCACTAGAAAATGCAT DGCDGIEEDKK>LIKHIGMJFHLNJFHLIJAJIIFMMHDIJHGIHIJLIC?LJIEDCA=<3AJIHID)MJGD=@?<8*4JCCA8@928-=92)2@975E)BFE8-;L>CFC>8K?E=8''?@9A>6C694*%;,/44* X0:i:1 X1:i:0 MD:Z:4A25A63C5T0 RG:Z:ERR229775 AM:i:37 NM:i:4 SM:i:37 MQ:i:60 XT:A:U BQ:Z:B@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.70199275 99 17 391 29 101M = 711 374 ATATTTTAAAATTGTGACTTTCATGGCATAAATAATACTGGTTTATTACAGAAGCACTAGAAAATGCATGTGGACAAAAGTTGGGATTAGGAGAGAGAAAT ?EFGGHHFFIEIIEF?C@ABICJICEIJJJLLJJM?H>HHCFI:G>AEHJILLFHGCMJGLKEM>-5A8BKE;JIJHFH4AEIAGMJDF@EHKJHJLHD9JKJN?JLFAG=GMGKKJIAJAJGHI@JGIKKIMHLIIGDILHIF>CGJJLGDC8DHHLGFGFE? X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:FE@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.5711913 163 17 409 60 101M = 646 337 TTTCATGGCATAAATAATACTGGTTTATTACAGAAGCACTAGAAAATGCATGTGGACAAAAGTTGGGATTAGGAGAGAGAAATGAAGACATATGTCCACAC <@CDFD@A?HIIGFJKJLLIFIFCGIFEEDF@KMC?EI=<<GGCDEEFDD7 X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.22701711 163 17 421 29 101M = 699 375 AATAATACTGGTTTATGACAGAAGCACTAGAAAATGCATGTGGACAAAAGTTGGGATTAGGAGAGAGGAATGAAGACATATGTCCACACAAAAACCTGTTC 93:<>>FC'?IHGIKH7KCHCGJFFJHEFCHJJMCLAHJDHKHMGHMLMEF@IBFIHI@DA:HCIGFA83>=0HHEG7 X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:C@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.52216469 163 17 454 60 101M = 693 339 ATGCATGTGGACAAAAGTTGGGATTAGGAGAGAGAAATGAAGACATATGTCCACACAAAAACCTGTTCATTGCAGCTTTCTACCATCACCAAAAATTGCAA @CEEFFBFE:<>:MEMIMED1N?LLQKQD9)@GNLKB@GHGFA;>A>D>;A;H=?B5DIEAFEC>-(7@C8BAD5>7 X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@C@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.82457097 99 17 474 60 101M = 695 321 GGATTAGGAGAGAGAAATGAAGACATATGTCCACACAAAAACCTGTTCATTGCAGCTTTCTACCATCACCAAAAATTGCAAACAACCACACGCCCTTCAAC A?HGGHHFIGHIJFJLLDEJLJKIJIIIGJLMJHIHKMNNNJMNLJJMKKJJMKMMMLLLNJJMKKLKJMKNNNNIKKIIKMJMHGFKGHC?FEHLDFGDB X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:CA@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.93698964 99 17 499 60 101M = 735 336 TATGTCCACACAAAAACCTGTTCATTGCAGCTTTCTACCATCACCAAAAATTGCAAACAACCACACGCCCTTCAACTGGGGAACTCATCAACAACAAACTT BFFGHGFHFHEIKKKLIKLIIJLJJKKLJLIMKKMMJKMKKMKKMKNNMNKLLMKNNKKNKMKJKKBKJIOJKKGINHGEGHHGMIJIIJIGJHFIBFDHD X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@CC +ERR229775.17900575 99 17 527 60 101M = 760 333 AGCTTTCTACCATCACCAAAAATTGCAAACAACCACACGCCCTTCAACTGGGGAACTCATCAACAACAAACTTGTGGTTTACCCACACAATGGAAGACCAC BEGKGHGLHFDIIGIIKILLLLIKKLJMLIJKILJIKJBMMMNKLKMKNLMMMJLJMMKKKJLIJMHKMIEMJHJICJFDFHIHJGGGKDIIGJGHIDEFB X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.65476258 147 17 548 60 101M = 324 -324 ATTGCAAACAACCACACGCCCTTCAACTGGGGAACTCATCAACAACAAACTTGTGGTTTACCCACACAATGGAAGACCACTTAGCAACAAAAAGGACCAAA BCGGGE@GIAJGDGIHAIGFKNMJKKJKJHKLJGKKJJLKKJJHIKKJJKGJJJKILGGHBHFBHHJIHIGF:KGBJIEJKFFHGAGGHGBBHD;DCEEEA X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@CA +ERR229775.83749675 163 17 553 60 100M1S = 783 330 AAACAACCACACGCCCTTCAACTGGGGAACTCATCAACAACAAACTTGTGGTTTACCCACACAATGGAAGACCACTTAGCAACAAAAAGGACCAAACTCCT ?<:GH:?I59=G@JHHDC3D'6@?ACFHI:E?>;BG=BECFIBH:6?E<6?GDEDHDCHDE65?=GE## X0:i:1 X1:i:0 XC:i:100 MD:Z:100 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@B@@ +ERR229775.19017039 99 17 560 60 101M = 839 368 CACACGCCCTTCAACTGGGGAACTCATCAACAACAAACTTGTGGGTTACCCACACAATGGAAGACCACTTAGCAACAAAAAGGACCAAACTCCTGGTACAT ?GDB=1GFFK:GHGH=F?G=CHJJ?DJLGGDGCCC6CIEA?.@E9 X0:i:1 X1:i:0 MD:Z:44T56 RG:Z:ERR229775 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.78639790 147 17 590 60 101M = 335 -355 CAACAAACTTGTGGTTTACCCACACAATGGAAGACCACTTAGCAACAAAAAGGACCAAACTCCTGGTACATGCAACTGACAGATGAATCTCAAACGCATTC CFDGCCHEBGDGFDBKCACBCBC?HKIKDGKLEJJGDHMDG45?IIFIHDEDHIBHA:94'ECEFHC=EH>BFGB@@?:?CEFFFBKJG=JD>EIGFGHHLGBECIKJJ?JLBG=JHGHIIIJMHKKIJGIIC5FGIJGGEIGGFEFIEEHE7 X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@G@ +ERR229775.47649789 147 17 647 60 101M = 392 -355 AACTCCTGGTACATGCAACTGACAGATGAATCTCAAACGCATTCCTCCGTGTGAAAGAAGCCGGACTCACAGGGCAACACACTATCTGACTGTTTCATGGG 68BIAGJE?C?=8JI=5@EIEJHLJJIHGGGBGC?=.?JBAAG=A4EAHJ=FFJJJKJLHH@KJIDHB=HF>?FF>HF@FH;DGI@GAGF7@;@=;3?DBA X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A +ERR229775.52216469 83 17 693 60 101M = 454 -339 CCGTGTGAAAGAAGCCGGACTCACAGGGCAACACACTATCTGACTGTTTCATGGGAAAGTCTGGAAACGGCAACACCATTGAGACAGAAAACAGGTGAGTG C=DHEIHFFLIANGFAKIJLMIILOKJJKLLKKKKNKKMMKLKMKKNNLLKKMMMLLNHKMKMKJJJCKLKJIJILKIMJLLKGJLKFIIGHKFFHFKEHB X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:A@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@D +ERR229775.82457097 147 17 695 60 101M = 474 -321 GTGTGAAAGAAGCCGGACTCACAGGGCAACACACTATCTGACTGTTTCATGGGAAAGTCTGGAAACGGCAACACCATTGAGACAGAAAACAGGTGAGTGGT ?HEFAC>LEAG@C=A@GKKCFHLJJKKJHFCHGKJJJEIGJMJEKFIJJJCHIJKMIFJIFFJJI@FHGH>>;HEEIFCJJ=DJGCGBBEEACFBICEDDB X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@D +ERR229775.22701711 83 17 699 29 3S98M = 421 -375 TGTGAAAGAAGCCGGACTCCCAGGGCAACACCCTATCCGACTGTTTCCTGGGAAAGTCTGGCAACGGCCACACCATTGAGACAGACAACAGGTGAGTGGTT ####FCGEAFD7::.:DB;'=CB+D@BFFF;2C<,8-%H@C@FI;F-+KIHDCB@57CID<*A4/)G:)ID0IJGKIDIDGEH8<+==FLAEGCKEFEDD? XC:i:98 MD:Z:16A11A5T9A13A6A16A15 RG:Z:ERR229775 AM:i:29 NM:i:7 SM:i:29 MQ:i:29 XT:A:M BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.70199275 147 17 711 29 46S55M = 391 -374 CAGACAAATGAAACTCAAACAAGTTCCCCCGTGTTAAAGAAAACGAACTCACAGGGCAGCACACTATCTGACTGTTTCATGGGAAAGTCTGGAAGCGGAAA ##############################################CC<+2:::)HD@(8<6C?A;?>=>,'7(>@3>6><=<1;+7:8>A4@9%.*<07* XC:i:56 MD:Z:12A35A3C2 RG:Z:ERR229775 AM:i:29 NM:i:3 SM:i:29 MQ:i:29 XT:A:M BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.93698964 147 17 735 60 101M = 499 -336 ACTGTTTCATGGGAAAGTCTGGAAACGGCAACACCATTGAGACAGAAAACAGGTGAGTGGTTGCCTGGGGCCAGGGAACTTTCTGGGGTCATACTCTCTAT AEHFGJG:@GHHIHFI@;>JHHEEH@IJJCKJFJJKMJJIIJJHIJGI=HFHGJKLIEFFKICDIDKBIKE@IIIJHGIKKHIGIDIFIG<IFKMJMBGKDFFJF@CGBBIGINHJEJI?FFBDILDLDDILIFGA7)?EEHLIMIHFIFHHHIFDFJD X0:i:1 X1:i:0 MD:Z:83T5G11 RG:Z:ERR229775 AM:i:37 NM:i:2 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@F +ERR229775.92236775 81 17 758 37 101M * 0 0 AACGGCAACACCATTGAGACAGAAAACAGGTGAGTGGTTGCCTGGGGCCAGGGAACTTTCTGGGGTCATACTCTCTATGTTGATTCTGGTGGTGGAAACAA A?>FGG@BDCFFJIJIMIKIMFFIKJILIIKJNIKJILJMJKKMLMLMLMJIIJFINMLFJGLKJKJJHIKKJLJHIJJLIIHDJKIJGIEFGFGHGHDFB X0:i:1 X1:i:0 MD:Z:70T5G24 RG:Z:ERR229775 AM:i:37 NM:i:2 SM:i:37 XT:A:U BQ:Z:CA@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@AA +ERR229775.17900575 147 17 760 60 101M = 527 -333 CGGCAACACCATTGAGACAGAAAACAGGTGAGTGGTTGCCTGGGGCCAGGGAACTTTCTGGGGTCATACTCTCTATGTTGATTCTGGTGGTGGAAACAAGA +EGGCFD>EEFAJIIIJHMHEEJJHKIHJIMDCHHKKJJJJMMEEEKMKIBHBLKLKCIJKLIJGHCAGIFDDF>HFHFIHECEGDF?GEB?EFCFEEIEB X0:i:1 X1:i:0 MD:Z:68T5G26 RG:Z:ERR229775 AM:i:37 NM:i:2 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.83749675 83 17 783 60 101M = 553 -330 ACAGGTGAGTGGTTGCCTGGGGCCAGGGAACTTTCTGGGGTCATACTCTCTATGTTGATTCTGGTGGTGGAAACAAGACTGTCCCAGCCTGGGTGATACAG EEICDIHLCGFDCHH>DFHFKGDCNEKJJLHLLG;KIIIDLJEEJD@IC=D=0GMFLIJLCJHHCHFEHIIHHJHIHDFIHKHGHKH>HHAFDE=GEF=H: X0:i:1 X1:i:0 MD:Z:45T5G49 RG:Z:ERR229775 AM:i:37 NM:i:2 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.63559677 147 17 833 60 101M = 594 -339 TATGTTGATTCTGGTGGTGGAAACAAGACTGTCCCAGCCTGGGTGATACAGCGAGACCCCATCTCTACCAAAAAATTAAAAATTAGCTGGGCATGGTGGTG FDHFHIHEF@FDD;5AC::ELBGCBHE3DKIHEHMFAHLE=BACIGH>IFB7FEHBC=G>KHFCHIFFGJDHEFFBB@BACFCCD@ X0:i:1 X1:i:0 MD:Z:1G99 RG:Z:ERR229775 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:[YZA@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.19017039 147 17 839 60 11S90M = 560 -368 CTCTCTATGTTGATTCTGGTGGTGGAAACAAGACTGTCCCAGCCTGGGTGATACAGCGAGACCCCATCTCTACCAAAAAATTAAAAATTAGCTGGGCATGG ############GJE:GEE?9)D<=B?09>.>/1?ACBCBIJIA@@?5FEEC9HL<<8?7,B?@@@BGHGC9BHIHGI:GG@BHHCFGGJ<3ED;;CDAB@ X0:i:1 X1:i:0 XC:i:90 MD:Z:90 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.98760722 163 17 840 60 101M = 1103 363 ATTCTGGTGGTGGAAACAAGACTGTCCCAGCCTGGGTGATACAGCGAGACCCCATCTCTACCAAAAAATTAAAAATTAGCTGGGCATGGTGGTGCATGCCT CBG@;DACF=HDJFJJCMJH@JGIKKIFDFFFHHEGEDHKHGCGJJICAB=?AIIIGGEG X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@C +ERR229775.516742 163 17 845 60 101M = 1152 407 GGTGGTGGAAACAAGACTGTCCCAGCCTGGGTGATACAGCGAGACCCCATCTCTACCAAAAAATTAAAAATTAGCTGGGCATGGTGGTGCATGCCTGTAGT A;>HF=GAIHGGH?FIEHGE9EFCIEA=@@ X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@A@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@CBFH +ERR229775.55719080 99 17 994 60 101M = 1282 388 TCAAGGCTGCAATGAGCTATGATTGCGCCACTGCACTTTGGCCTGGACAACAGAGCAAAACCCTGTCTCTAAAAAAAGAAAAGAAAAGAAAAACTCACTGG BFHIGFHLHHEKIIJKKKHIJKIKILAKLJJLJKJJMKKLJLMMJMLKKNKKMLKLKNNNKMMMKIKMJNKMMMNGHHJFHHIKHIIIKHIHCGMGHDIEC X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A +ERR229775.77830097 163 17 1036 60 101M = 1255 319 CTGGACAACAGAGCAAAACCCTGTCTCTAAAAAAAGAAAAGAAAAGAAAAACTCACTGGATATGAATGATACAGGTTGAGGATCCATTATCTGAAATGCTT BIEBGCCHCBCHHH,=FICDJKHCGDGJHJJKHFIIJKLLIKLGLGKLMMDHLJJDLFIKIDIDIKIGJIFHHGFHEHJH?JIIFJFFIIFLIJHGHGGIB X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@D@ +ERR229775.3695912 99 17 1042 60 101M = 1118 176 AACAGAGCAAAACCCTGTCTCTAAAAAAAGAAAAGAAAAGAAAAACTCACTGGATATGAATGATACAGGTTGAGGATCCATTATCTGAAATGCTTGGACCA BHEGGIHHHKIKGJKLJIKLLLIMMMMMMJKLMMKLMMNKLNMNNKLLJJNLMLKJKJLMKJLJJHKJHHHHLHFJIHHHIKIKINJKIHJIIMJGEHDED X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@C@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.54641833 99 17 1042 60 101M = 1321 379 AACAGAGCAAAACCCTGTCTCTAAAAAAAGAAAAGAAAAGAAAAACTCACTGGATATGAATGATACAGGTTGAGGATCCATTATCTGAAATGCTTGGACCA BHEGGIGGGKIKGGKKHAHLJLIMMMMMLJKLMMKKMMMFLLMNMJNMKJMJMLKJKJLMKJLJJHKJHGHHJHFJIJHHIKIKINJKIHJIIMJGEHDEF X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@C@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@B +ERR229775.90795085 163 17 1066 60 101M = 1297 331 AAAAAGAAAAGAAAAGAAAAACTCACTGGATATGAATGATACAGGTTGAGGATCCATTATCTGAAATGCTTGGACCAGATGTTTTGAATTTTGGATTTTTT BGHGHEDHGDCHJGJHIJI?JGJIHHKIKIGHHIKLIFKIIJIHL=HIKJCIGLLHIHKJMLKIEBEHJMLJDMIJKJMIKLDHKCJJGFDHHGGGEFFCB X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:JOOLJ@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@BCEGEE +ERR229775.51118640 99 17 1069 60 101M = 1370 401 AAGAAAAGAAAAGAAAAACTCACTGGATATGAATGATACAGGTTGAGGATCCATTATCTGAAATGCTTGGACCAGATGTTTTGAATTTTGGATTTTTTCAT BHFHIJJHJKIKJJKKLKHLLJJMKLKJJJKLMJKLJJJKMMFJGKKMLJMMKKLJKMNLMNNKLMNKLKLKMKLMLLIGLLIKNKKLKJCKHFEEFCFGE X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:EJ@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@B +ERR229775.57580585 163 17 1077 60 101M = 1316 339 AAAAGAAAAACTCACTGGATATGAATGATACAGGTTGAGGATCCATTATCTGAAATGCTTGGACCAGATGTTTTGAATTTTGGATTTTTTCATATTTTGTA BGHGEEE@G>9JHEGHGIFFHHHJKHHIFBAIIFGHHIJKHIJKIIKJIKGJKMLJKKNKKBLDLJKLJLKKJKHLIKLKLKIKLFLKLFIJJEIJGHFDE X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:CFFB@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@G +ERR229775.82642257 163 17 1081 60 101M = 1336 355 GAAAAACTCACTGGATATGAATGATACAGGTTGAGGATCCATTATCTGAAATGCTTGGACCAGATGTTTTGAATTTTGGATTTTTTCATATTTTGTAATCT BGHGHH@JEB@JGHHEGGGHJHBJHHIFIICIA>HDJIKJIIJIILLKJLGJJLMJJGLJLGKIHJ=JJKLLMJKKLKFMKLLLLFIJKIKKKKHGGFGGJ X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@L +ERR229775.30538656 163 17 1087 60 101M = 1321 334 CTCACTGTATATGAATGATACAGGTTGAGGATCCATTATCTGAAATGCTTGGACCAGATGTTTTGAATTTTGGATTTTTTCATATTTTGTAATCTTTGCAG A?BHJEKFGG??IKKKAEIKJJLLKLLEHKLKIHIJIILEGGEG? X0:i:1 X1:i:0 MD:Z:7G93 RG:Z:ERR229775 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.87113255 99 17 1096 60 101M = 1361 365 TATGAATGATACAGGTTGAGGATCCATTATCTGAAATGCTTGGACCAGATGTTTTGAATTTTGGATTTTTTCATATTTTGTAATCTTTGCAGTATATTTAC ?EFGGFHHJHFGIAHIIFKLLKJKLJJKIJKMKLMMJJMNKJMEHHFIEDIKLKLGLLKLLLLKLKJHKJJKKHKFIKD;JCGEIGDIIDK=4CEDEFAEB X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@D +ERR229775.98760722 83 17 1103 60 101M = 840 -363 GATACAGGTTGAGGATCCATTATCTGGAATGCTTGGACCAGATGTTTTGAATTTTGGATTTTTTCATATTTTGTAATCTTTGCAGTATATTTACCAGTTCA EFFFGLHGHJLNKLKJGLLNLILLLIAKKKJLNKJHJMJNIJKDNNNKLLKNNNJMMJMNNNNLKJIJMMMJIJKJKLMLJJEFHHHCIJAGFFHLDIHE? X0:i:1 X1:i:0 MD:Z:26A74 RG:Z:ERR229775 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.37017046 99 17 1113 60 101M = 1339 326 GAGGATCCATTATCTGAAATGCTTGGACCAGATGTTTTGAATTTTGGATTTTTTCATATTTTGTAATCTTTGCAGTATATTTACCAGTTCAGCATCCCTAA BHDCIGGFIGCGIGKJKIKIJKLIKLKILJKKJFHJKKILJJKKLLMHJJKKLLMIJJKLLLJKJMKMNLLIJKLKKLDFLLKAFHDIIIJHKLGGFFJED X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@B +ERR229775.3695912 147 17 1118 60 101M = 1042 -176 TCCATTATCTGAAATGCTTGGACCAGATGTTTTGAATTTTGGATTTTTTCATATTTTGTAATCTTTGCAGTATATTTACCAGTTCAGCATCCCTAACTCAA GDFGGHIJILLFHHMIIMLJKLIJNKKKIMNNKKKKMKMILMJLMMMMLIEIJMLJJIIJIKKLLIKIKIBGHHKJHGEIKFIIHHIGGHBAEFCDEEEE@ X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:B@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@GE +ERR229775.17531023 163 17 1121 60 101M = 1381 360 ATTATCTGAAATGCTTGGACCAGATGTTTTGAATTTTGGATTTTTTCATATTTTGTAATCTTTGCAGTATATTTACCAGTTCAGCATCCCTAACTCAAAAA BEEEDE@EFDEFGFI>GBCBJHFGGIBGFFEJIFJJJJKEFJJJJJKJIHEJKKIEGHJMMKKHGJHFIKJIKKJHJKKKIHJKKLJKHILGMGMHHIEEE X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@CGDFG +ERR229775.516742 83 17 1152 60 101M = 845 -407 AATTTTGGATTTTTTCATATTTTGTAATCTTTGCAGTATATTTACCAGTTCAGCATCCCTAACTCAAAAATTAAAAAATCTGAAATCCCAAACGCGCCAAT 7?ABDGED>DDDDJE?FB9DDCEA.=<>AD=/AEG6ABA8FD>2CGF@GFBJ?>5*G>59@.<*4JKIB;D*)JJIIBHA:8GC>=E4;H7C>F?GCEDE? X0:i:1 X1:i:0 MD:Z:72C28 RG:Z:ERR229775 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.36576640 83 17 1160 60 101M = 937 -323 ATTTTTTCATATTTTGTAATCTTTGCAGTATATTTACCAGTTCAGCATCCCTAACTCAAAAATTCAAAAATCTGAAATCCCAAACGCGCCAATAAGCATTC ADEFFKKIJIIHIIJGJIHIIFKJJINIHJJJMLHGHJLIMHGLJIGEFJKGFDKGCLKLLKMLHKKKKJLJGIKJIKLKJJIGBKAJHIGHHHLHGGHGB X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@D +ERR229775.6073289 83 17 1160 60 101M = 857 -403 ATTTTTTCATATTTTGTAATCTTTGCAGTATATTTACCAGTTCAGCATCCCTAACTCAAAAATTCAAAAATCTGAAATCCCAAACGCGCCAATAAGCATTC <@AFFKKIJIJHIIJGIIJJHFHKJHNIJKJHBEF@HGKHMLJLJJJLMJKIJGKGHLKLKJLLHKKKJIKJJLKJIKLKJJIGBKAFEIEHGHLHGGHHB X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@D +ERR229775.78971137 163 17 1189 60 101M = 1464 375 ATATTTACCAGTTCAGCATCCCTAACTCAAAAATTCAAAAATCTGAAATCCCAAACGCGCCAATAAGCATTCCCTTTGAGCGTCATGTCGGTGCTTGGAAT BBFEFFBCCB@GHHGHHGDHJJJHIGKIHGJLJHJJILLLLILJGKLMIKDFHLKHAE;@HGMGILHFIJIIFGLJJHBCHAGEGIIKIAG>CEMEGEHHD X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A +ERR229775.87728427 99 17 1242 60 101M = 1483 341 AACGCGCCAATAAGCATTCCCTTTGAGCGTCATGTCGGTGCTTGGAATGTTTGGGGTTTTGGATTTACAGCTTTGGGACGCTCAACCTGTACCTCAATAAA BHE>G?HFHKGIKKKIIIKKLLJKKKHKCEJJJJEJ?JEBDMJJMABJJIJKLJJJFCDCGDHGCCHEHGHLEEHFGHC;IMIJHGINIIIGIMHIIGGD@ X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:DJ@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@BB@ +ERR229775.77830097 83 17 1255 60 101M = 1036 -319 GCATTCCCTTTGAGCGTCATGTCGGTGCTTGGAATGTTTGGGGTTTTGGATTTACAGCTTTGGGACGCTCAACCTGTACCTCAATAAACCTGATTTTAAAA EEFFIFFIHHGINJAGKIJJGHAIJGKKMKJLKKKINMJMMLKNNNKMMKNMJJLNMMMNKMHJEALKKFJJJLJJIIILKJJHIIIEHIFHHJJJGGFFB X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@IKMJ +ERR229775.55719080 147 17 1282 60 101M = 994 -388 CTTGGAATGTTTGGGGTTTTGGATTTACAGCTTTGGGACGCTCAACCTGTACCTCAATAAACCTGATTTTAAAAAAGTTTGGGGGCATTCCCCTAAGCCCG ?EIHGEHF@HCJHEFEIHEGGGHIGHHHKG>BGJDEFDBGJKDCEJKJHJELJJIJIGHF@KKIKILKKHHHIIIKGJJHJHEFDGLJJMJLLKIIJLMLJMJJMNKLLJLKLKLJNNNNKKHKKLJJJHDHGDGJGGLHGHJIHAGHJGIHAGKIHGJII@FFCCCE X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@G +ERR229775.57580585 83 17 1316 60 101M = 1077 -339 GGGACGCTCAACCTGTACCTCAATAAACCTGATTTTAAAAAAGTTTGGGGGGATTCCCCTAAGCCCGCCACCCGGAGACAGCGGATTTCCTTAGTTACTTA BEDG?HHKHIJGIKHFHGHKFDIJE?HFHIGJFFFFCCCCCKDEEGFFFFFFFEHDDDFFCJEJLCJIHGLLCLLMKIILK@KKHLKJHIIHKFJHHGHFB X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:AC@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.30538656 83 17 1321 60 101M = 1087 -334 GCTCAACCTGTACCTCAATAAACCTGATTTTAAAAAAGTTTGGGGGGATTCCCCTAAGCCCGCCACCCGGAGACAGCGGATTTCCTTAGTTACTTACTATG EEHFDIFIJHIHFFCIFIIIFDGIKJJGGGGDDDDCJDECGEDEFFGECGDDDFGBCACJBGIIEJLCLKMIJKLLBLIILLKKIKHKGKFGIEGDGEFI? X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.54641833 147 17 1321 60 101M = 1042 -379 GCTCAACCTGTACCTCAATAAACCTGATTTTAAAAAAGTTTGGGGGGATTCCCCTAAGCCCGCCACCCGGAGACAGCGGATTTCCTTAGTTACTTACTATG FFHGEHEIJDFGBHKIHHGC<4FHIHHFFFF?BDBEI>G>GDCADCDDDI>AAEE@GAAD>FEB@HG8EGHIIIKHAJIHKEFGHEGGEHB;E@BDEEED@ X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:A@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.29727862 163 17 1327 60 35M66S = 1641 363 CCTGTACCTCAATAAACCTGATTTTAAAAAAGTTTGGGGGGATTCCCCTAAGCCCGCCACCGGGAGACAGCGGATTTCCTTAGTTACTTACTATGCTCCTT 7==;A97.8+7HA;IE:88;9EEFH8>;?E####################################################################### X0:i:1 X1:i:0 XC:i:35 MD:Z:35 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.82642257 83 17 1336 60 101M = 1081 -355 CAATAAACCTGATTTTAAAAAAGTTTGGGGGGATTCCCCTAAGCCCGCCACCCGGAGACAGCGGATTTCCTTAGTTACTTACTATGCTCCTTGGCCATTTC DBEFFGGGIJIKIIIIFFFFFKFHHGHGGGGHD?HEDDFFCKGDGBMJIFJC@MLNMKJLLBMMJMMLLMMJMJLIJLLIILIGIJKJHIIHGHFHGDEGA X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.37017046 147 17 1339 60 101M = 1113 -326 TAAACCTGATTTTAAAAAAGTTTGGGGGGATCCCCCTAAGCCCGCCACCCGGAGACAGCGGATTTCCTTAGTTACTTACTATGCTCCTTGGCCATTTCTCT :DCCDCJFIJHHF9FFHHMFGCFGGEDEC94#455D@=I?7BADBJJIJBCHMJJDMH?HGDLKJAHEHKA@>B=HDBIGHAEHH8ADDF<8DFEHGEGB@ X0:i:1 X1:i:0 MD:Z:31T69 RG:Z:ERR229775 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.87113255 147 17 1361 60 101M = 1096 -365 TGGGGGGATTCCCCTAAGCCCGCCCCCCGGAGACAGCGGATTTCCTTAGTTACTTACTATGCTCCTTGGCCATTTCTCTAGGTATTGGTATATTGTGTATG FEFFGGHDCHCC;HIF?15;7A:4#FD>JKG@DGMKBFLFKLKAJ@AMEE9BEBB:GFB?CIEHGJA<>DDH=BJEJIBFGJAF:DGDMIIMJJCKLLILLILKHIHKKKIJKHHFDFHKHIGHHFFJGEGFIHBBEF@FEEGDB X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.48996859 99 17 1381 60 98M3S = 1659 345 CGCCACCCGGAGACAGCGGATTTCCTTAGTTACTTACTATGCTCCTTGGCCATTTCTCTAGGTATTGGTATATTGTGTCTGCTGTGAACTGTCCTTGGCCT A5FEFEGF?EHHIEIIH8HIIJJIHLJIHGIJHMJJJNA:FAIHGML;0GEDGILGHKHGKHHIKINJKLIJGGFFFF8FFLJJIFEGHLKJGGKMLILLLJKKILKIIILEKHFJJIGEE? X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@C@ +ERR229775.87728427 147 17 1483 60 101M = 1242 -341 TTTGGTGACGGGTGAGGAGCAGGGACAGAAGGGTCCTGCGTGCCCTGCCTTCACAAGCCCCTGGAAGGAAAGTTGTTTTGGGATCTCTGCACCCTCAGCCT :=;FCD?1/EECJIGHCF>AAFGCIHKEA=BDAF<:EB>JFJIDBHHCHAD>+#AFDEIE?B@ X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.15144424 163 17 1542 60 101M = 1799 357 CCTGGAAGGAAAGTTGTTTTGGGATCTCTGCACCCTCAGCCTGGACAACTTGTGCCCATCTGGTGACCCCTCACTCAGCCACCAGACTTCCACGACAGGCT BDIECGEFDCEIHBGCGHGGGJEGHBIFHDJIGHJKJIJJKLH?K@JKFJEJIHILMFJMMHB;>IHIIIMIJCKKIFJHGFHJDHGMFIIJG>JFHBDDF X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:EF@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A +ERR229775.83025798 147 17 1590 60 101M = 1304 -386 CTTGTGCCCATCTGGTGACCCCTCACCCAGCCACCAGACTTCCACGACAGGCTCCAGCCTCGGCACCTTCAGCCATGGACAGTTCCGCCAGCGTTGCCCTC CA;4I?C?9HGCJEBD<08@2J<+=@=DB9CD@ X0:i:1 X1:i:0 MD:Z:26T74 RG:Z:ERR229775 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.29727862 83 17 1641 60 51S50M = 1327 -363 CTTGTGCCCATCTGGTGACCCCTCGCTCAGCCCCCAGACTTCCACGACAGGCTCCAGCCTCGGCACCTTCAGCCATGGACAGTTCCGCCAGCGTTGCCCTC ####################################################E==>=55;,C:65/9:=5J=C>FF@=GBJCB?5"D1?L;1=EHG;=BA0 X0:i:1 X1:i:0 XC:i:50 MD:Z:50 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.107364540 99 17 1651 29 101M = 1920 369 GGCACCTTCAGCCACGGACAGTTCCGCCAGCGTTGCCCTCTGTTCTGCTGTTTTCTCTACCAGAAGTGCCCTTCCCTCCTCACCTGACCACTCTGGGGAAA ?CGGDFL?FHCGFFIAKJIIJGIEHALLJJKGCHGEIEELFIFHMGFGIJDFMFKGIJCMEKHFEAHDF X0:i:1 X1:i:0 MD:Z:14T86 RG:Z:ERR229775 AM:i:29 NM:i:1 SM:i:29 MQ:i:29 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@CBF +ERR229775.48996859 147 17 1659 60 33S68M = 1381 -345 GACTTCCCCGACAGCCCCCAGCCTCGGCACCTTCAGCCACGGACAGTTCCGCCGGCGTTGCCCACTGTTCTGCTGTTTTCTCTACCAGAAGTGCCCTTCCC ##################################G=:?F3CCE>D:8=64'#)'I<=):7>HIB@=A:CE1;:C=JJHC9A:<7=BCFHCL@LHEHIEHA@ X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.69874320 163 17 1704 60 81M20S = 1920 309 TCTCTACCAGAAGTGCCCTTCCCTCCTCACCTTACCACTCTGGGGAAATCCCTCAGCACCCTCCCTGAGCATACCCTACTCCGGCACAAGCCCAACCTGCA 74J?@C:D@-=C;696/*=;DD8+@*@7C94='04*65:A@860;+9H##################### X0:i:1 X1:i:0 XC:i:81 MD:Z:32G48 RG:Z:ERR229775 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.51562629 147 17 1727 60 101M = 1445 -382 TCCTCACCTGACCACTCTGGGGAAATCCCTCAGCACCCTCCCTGAGCATACCCTACTCTGGCACAAGCCCACCCTGCAAAGCCCCTGAGGCCCGCCCTGTG ADDFD?GHHEBGIGIHIJHHHHGGHGFEGHFJB;2CB?FADDEAJDDFC@8ABCE?A@BCACCB@H@<AEGG@HEG;ACBGCHFFAFF/?GFJLHILKLHIGGIJM:CECFEIHLBFIDJEHEHILAHB5CFG@FGGLHHHGI3?FFILIHHMHGGKC6C X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:GAA@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.2494821 99 17 1749 60 101M = 2024 375 AAATCCCTCAGCACCCTCCCTGAGCATACCCTACTCTGGCACAAGCCCACCCTGCAAAGCCCCTGAGGCCCGCCCTGTGGCGTCTCTCCCTCCCTTGCTGT AHHGFFFLHHGIIHKKHHJKLJKLKJJJJLLMJJJJMJCLJJJNFJLMKKMMNLMKLNMMLMIMHKJHJGG@ X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@FC@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.15144424 83 17 1799 60 101M = 1542 -357 CCTGCAAAGCCCCTGAGGCCCGCCCTGTGGCGTCTCTCCCTCCCTTGCTGTCAGGACAGTGGTCCTGGCCTCCGGGGCTCACGGAGCCGCCCTGTGCCATG @BGGGGB8D@HEHKEJFGGGACGCGKFGGF?EGCCCCDDCGEEFEIGFHDIFJEGGFJDFEBHCEFGEGJKE>LLLKJKII@KKLKKAIHFIHFHHEGFHB X0:i:1 X1:i:0 MD:Z:70A27G2 RG:Z:ERR229775 AM:i:37 NM:i:2 SM:i:37 MQ:i:60 XT:A:U BQ:Z:BD@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@Z\V +ERR229775.97978507 163 17 1893 60 101M = 2135 342 TGCCGTGTACCTCTGAGCCCTCTGCACAGTGCCTTCTGCTTGCCTGTGGCTTTGAGAAGAAACCCCTTCTGGTTATACATAAGACAGCCAGAGAAGGGAGT BEFCHHGIEFJDFKHGBGCFF7CAD X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@D +ERR229775.107364540 147 17 1920 29 101M = 1651 -369 AGTGCCTTCTGCTTGCCTGCGGCTTTGACAAGAACCCGCTTCTGGTTATACATAAGACAGCCAGAGTAGGTAGTTGCCCAGGGTGGCACACTACGTTGCTG <@DE96DJHGG>8CG@:?4$=@*IBB@41AEC<=3+#(B<@6F=287JIG?C8(A@BCIH>MLJFH?C;CJIFGCGDIBIJHDCJCEFFHHIHD?ALEC5CHMD38CECLGCE?45HLCE;BEGFHGJ<=C? X0:i:1 X1:i:0 XC:i:94 MD:Z:94 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.43533499 83 17 1932 60 101M = 1693 -339 TTGCCTGTGGCTTTGAGAAGAAACCCCTTCTGGTTATACATAAGACAGCCAGAGAAGGGAGTTGCCCAGGGTGGCACAGCACGTTGCTGCCAGTTACTGCC 2D>ADFGGIIHFIKILIFLDB51FCBHGGCKJILFIKKJKKJMIHJMLKJMLMJHLIGIMJMKJGJHGKKIJHFIIFLDHG@HIFIGGGH?KCEGHGGF?? X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.22929983 83 17 1950 60 101M = 1693 -357 AGAAACCCCTTCTGGTTATACATAAGACAGCCAGAGAAGGGAGTTGCCCAGGGTGGCACAGCACGTTGCTGCCAGTTACTGCCATTTTCACAGGCATGAAA HEA>CFFGIHKIKIGMKLKJIFKKMEIKLJHKNKMKKNMMLNKNKMJCLMMMJJMMLJKMLHIAKMJLLJKLKMJLJILJJKHHLLKJIIFKGHHHGFFFB X0:i:1 X1:i:0 MD:Z:91G9 RG:Z:ERR229775 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:C@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ADB +ERR229775.66105707 83 17 1971 60 101M = 1746 -325 ATAAGACAGCCAGAGAAGGGAGTTGCCCAGGGTGGCACAGCACGTTGCTGCCAGTTACTGCCATTTTCACAGGCATGAAATGGAGATAACAACAGGAGCGA EFCIGFCMICINIMIGJIKKNBJKIHIKMJJKKLJIFINLJKCKMKLMKJJGMJMIGKJHFHIMMLKJIIMLKJIIKKJIIKKKKHHDIIGIHLFGKF:FB X0:i:1 X1:i:0 MD:Z:70G30 RG:Z:ERR229775 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.105154648 163 17 1981 60 101M = 2189 308 CAGAGAAGGGAGTTGCCCAGGGTGGCACAGCACGTTGCTGCCAGTTACTGCCATTTTCACAGGCATGAAATGGAGATAACAACAGGAGCGACCGCACAGGC @DCE:EEFD<=H?>>?FF==CCB@1:C=FFGHG;<=?HKICHBC?4AFEE:HEC5AJ3B;H?A>6BCEB85 X0:i:1 X1:i:0 MD:Z:60G40 RG:Z:ERR229775 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.52172354 163 17 1982 60 79M22S = 2196 314 AGAGAAGGGAGTTGCCCAGGGTGGCACAGCACGTTGCTGCCAGTTACTGCCATTTTCACAGGCATGAAATGGAGATAAGAACAGGAGCGACCGCACAGGCT A@?:E>31<61E<;88BG,%/C8/4BAG4;BA1AG92D;D?C9<=)?>;C?BDF+9D+0>>0;DGJG####################### X0:i:1 X1:i:0 XC:i:79 MD:Z:59G18C0 RG:Z:ERR229775 AM:i:37 NM:i:2 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.39805220 163 17 2022 60 82M19S = 2315 385 CAGTTACTGCCATTTTCACAGGCATGAAATGGAGATAACAACAGGAGCGACCGCACAGGCTGCTGAGCGCGTCACACGCAGCCATCGCGCAGCTCAGGGAT @94EAE@J>:3GGEGCGD9=ECACGGHHHE;HHB?DFC1E:AA@AJJE=@C6=43>@CI?8DBC#################### X0:i:1 X1:i:0 XC:i:82 MD:Z:19G62 RG:Z:ERR229775 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.57143597 163 17 2024 60 101M = 2298 374 GTTACTGCCATTTTCACAGGCATGAAATGGAGATAACAACAGGAGCGACCGCACAGGCTGCTGAGCGCGTCACACGCAGCCATCGCGCAGCTCAGGGATAT @DAECIBEC@AGHEICGGIHJHGIEHAGHEDGICFLHILJCJ8FDE>KDD3;C?CJEDHFGEGFCF=F<>>EBIE@DECD?>DB9BECBHCJDADD;AE@;>C>HLEFCDH>IILJ@G6IJGG:AEJACCEEB@ X0:i:1 X1:i:0 MD:Z:17G83 RG:Z:ERR229775 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@B +ERR229775.11251161 163 17 2065 60 101M = 2333 368 GGAGCGACCGCGCAGGCTGCTGAGCGCGTCACACGCAGCCATCGCGCAGCTCAGGGATATTACGTGTAACTCGACATGTCAGCGATTGTCACAGGCACTGC @3B"2=<"5?9=JGBBB'=:@;DFC=?698AFCD4;74C@EBD7IBFHH8AD@G+-3HGHFHF>IIKJKIHKBKBLJLLLLJLLJKJJJKJJCHJKJLHMMBLHJJIGIJGI>HFCFGJKEHGFHIFMIJMIDMIIMIHGHADFFIHKIGHEDB X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@D +ERR229775.18301321 163 17 2092 60 101M = 2301 307 GTCACACGCAGCCATCGCGCAGCTCAGGGATATTACGTGTAACTCGACATGTCAGCGATTGTCACAGGCACTGCTACTCCTGGGGTTTTCCATCAAACCCT AFEECE789<',AD@GF@BG?>H<4F7GBIE=@>FCF;=;CEBFE>D=A=AAJGHKH;DDFKHG?C02BAIHG@@FEAA3=6 X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.97978507 83 17 2135 60 101M = 1893 -342 TCGACATGTCAGCGATTGTCACAGGCACTGCTACTCCTGGGGTTTTCCATCAAACCCTCAAGAGCTGGGCCTGGGGTCAACTTCCAGCCTGGGGAAACTGG E=FGGHIGKINJBIJIJGMIJFMIJHIHJHHIGJLHJJIILFNNNLMLKLJKJGMMMLKKMLMKKJLLLLLJLLLJKKJILLKKJLKJJIEGGGHHHGHEB X0:i:1 X1:i:0 MD:Z:85G15 RG:Z:ERR229775 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@GG +ERR229775.15256528 147 17 2147 60 2S99M = 1898 -347 AGCGATTGTCACAGGCACTGCTGCTCCTGGGGTTTTCCATCAAACCCTCAAGAGCTGGGCCTGGGGTCAACTTCCAGCCTGGGGAAACTGGGGCAAGTATC ###E?E<9G=8IMIIFGED<9;(BABBB;8;99?ABIGDCHJD?<:;C7FBEE3EBHDG9@CCKGHH@??D@;HFG>1EEF=BCDAG9631,D9DE@7 X0:i:1 X1:i:0 XC:i:99 MD:Z:20A52G25 RG:Z:ERR229775 AM:i:37 NM:i:2 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.75821297 145 17 2155 37 101M * 0 0 ACAGGCACTGCTACTCCTGGGGTTTTCCATCAAACCCTCAAGAGCTGGGCCTGGGGTCAACTTCCAGCCTGGGGAAACTGGGGCAAGTATCACCAGAGATG EFKFHHIIJIIH@IKGIJHHHFLLLJFGJKHJHEIIMJJKMLNKKIKKMJGELKLJKGHGLLKIJLKJKIJIKKIHHJFJJHHHHHGFGH<;DEFEIEEG@ X0:i:1 X1:i:0 MD:Z:65G35 RG:Z:ERR229775 AM:i:37 NM:i:1 SM:i:37 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.105154648 83 17 2189 60 101M = 1981 -308 CCCTCAAGAGCTGGGCCTGGGGTCAACTTCCAGCCTGGGGAAACTGGGGCAAGTATCACCAGAGATGAGCTTTATAAAAATAATGGTGCTAGCTGGGCATG ?BEHFGKILIHGFFGDFGEGFBHEGKHNLFJNLKKKLILKKIKKKLIFJCKJJJJLJKJJMLMJIIJJICLLJJIIJIIEHJGGJHIFHIIHDHFFFEFH? X0:i:1 X1:i:0 MD:Z:31G69 RG:Z:ERR229775 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A +ERR229775.52172354 83 17 2196 60 101M = 1982 -314 GAGCTGGGCCTGGGGTCAACTTCCAGCCTGGGGAAACTGGGGCAAGTATCACCAGAGATGAGCTTTATAAAAATAATGGTGCTAGCTGGGCATGGTGGCTT EHCBDDB?7=E=DBAKCDGLHHEIMICHKJHAKKKK>CDJIJIKMGFJKIFFJMLMHIIEMJKMDHIJKJKJJJIIJKIJJJHJHFHGFIJGADHICGHJIJKDIIFIJCGEDGBD X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:EJ@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@F +ERR229775.59500924 99 17 2276 60 101M = 2490 314 GCTAGCTGGGCATGGTGGCTTGCACCTGTAATCCCAGCACTTTGGGAGGCCGAGCTAGGAGGATCGTTTGAGTCCAGCAGTTTGAGACCAGCCTGGCCAAT &HIEGHLHGHFIHEKIHKJLJILJJLLKIIMJLLLJMJIHMKKJJMGFJJLCLIJNJKJLJGHGJ>G@@GJGHIHKHJJFIFKIKIKGIJIIIMHAEFGDD X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.57143597 83 17 2298 60 101M = 2024 -374 CACCTGTAATCCCAGCACTTTGGGAGGCCGAGCTAGGAGGATCGTTTGAGTCCAGCAGTTTGAGACCAGCCTGGCCAATACGGCAAAACCCAGTCTCTACA ?EDFHFHFHHHEFJJFIHDEJFHHMEIF@KOJJJNJKMJMKL?JNMKLNKLMLMJJMJMMKJLCBLJILJLJLKIIKJII@JJF?JIFHEFKFJHIGGGFB X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@D +ERR229775.18301321 83 17 2301 60 2S99M = 2092 -307 ACCTGTAATCCCAGCCCTTTGGGAGGCCGAGCTAGGAGGATCGTTTGAGTCCAGCAGTTTGAGCCCAGCCTGGCCAATACGGCAAAACCCAGTCTCTACAA ###GAB7.BC><:*5'=GG@A:?H@A8,@B77FE-EIEEEHBDBKJDH=IACICBGGLLJHH'%/HLJCHICICFADHA?E?>:B?I:FG=EI:@@=ADC? X0:i:1 X1:i:0 XC:i:99 MD:Z:13A47A37 RG:Z:ERR229775 AM:i:37 NM:i:2 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ED +ERR229775.39805220 83 17 2315 60 8S93M = 2022 -385 TCCCAGCACTTTGGGAGGCCGAGCTAGGAGGATCGTTTGAGTCCAGCAGTTTGAGACCAGCCTGGCCAATACGGCAAAACCCAGTCTCTACAAAAAATACA #########DFBIFEJB?%?I@FFIMFFGFFFD;DLMJEJ>8FGMHGHBMKHFM=/GCJFJKEKJCFJD8JAHHIJJIIIDII@AEJFGHBGHHHHFEHC? X0:i:1 X1:i:0 XC:i:93 MD:Z:93 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A +ERR229775.12020490 147 17 2330 60 101M = 2089 -341 CTAGGAGGATCGTTTGAGTCCAGCAGTTTGAGACCAGCCTGGCCAATACGGCAAAACCCAGTCTCTACAAAAAATACAAAAAACAACTAGCCAGGCGTGGT EFKFGLHIEHGFHIIDDHHCIAJGBBHDB;=+EB@ X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.11251161 83 17 2333 60 101M = 2065 -368 GGAGGATCGTTTGAGTCCAGCAGTTTGAGACCAGCCTGGCCAATACGGCAAAACCCAGTCTCTACAAAAAATACAAAAAACAACTAGCCAGGCGTGGTGGT BA,>9DHC@BEKKIKCAAGKFEGIIHDCJHEG?IIFKJDEFFIMHKIDHDFFJJJIIICEEHJJIJJIJECIKJJILEI?FHFDGEEB X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.80729707 99 17 2417 29 101M = 2698 358 TAGCCAGGCGTGGTGGTGCACACCTGTAGTCCCAGCTACTCAGGAGGCTGAGGGGGAAGGACTGCTTGAGCCCAGGAGTTTGAGGCTGCTGTGAGCTGTGA :EBE?HH>CECHH;>?IDEFLDGNIJIGHG@B?AGF@ X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.101859832 99 17 2474 60 101M = 2762 388 AGGACTGCTTGAGCCCAGGAGTTTGAGGCTGCTGTGAGCTGTGATCGCATCACTGCATTCCAGCCCGGTGACAGAGTGAGTCACTGTCTCGAAAAAGAAAG ?ECGDLGFKGCKHGKKIGKGHGIIIKJEILJKLJFJ@EHGH:CHJL?HJHIJHMLLIJIEFJKIIE=HB>HGJHJIBEH>GGJHJHHFMG;H?FCHB6>CA X0:i:1 X1:i:0 MD:Z:90A10 RG:Z:ERR229775 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@C +ERR229775.59500924 147 17 2490 60 101M = 2276 -314 AGGAGTTTGAGGCTGCTGTGAGCTGTGATCGCATCACTGCATTCCAGCCCGGTGACAGAGTGAGTCACTGTCTCGAAAAAGAAAGGAAGAAATAAAGAAAA IEFKEGJJIMIIDJJIJGJHMHHIHIGHI?HHJLHJJJLKJMKGJMKJI?DJJKJJMKLJIIKHJFCGIFIFJ;KIIIHKJGGJIHHIGGCB@FCIEEEEB X0:i:1 X1:i:0 MD:Z:74A26 RG:Z:ERR229775 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:D@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@CEC +ERR229775.5983641 147 17 2506 60 101M = 2267 -339 TGTGAGCTGTGATCGCATCACTGCATTCCAGCCCGGTGACAGAGTGAGTCACTGTCTCGAAAAAGAAAGGAAGAAATAAAGAAAACAAATAAAAATAATAG GDGGKHHJGGEIKAGHHKIKHKJHKMKEGNJJ?;LIKJJCJJNGJKLHKHCJHFFEK>GJJJJKFIJKIJHJIIIHHIHKJGGHGFHGGGBBEFCEFEEI@ X0:i:1 X1:i:0 MD:Z:58A42 RG:Z:ERR229775 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:B@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.52727770 163 17 2538 60 101M = 2848 395 CCGGAGACAGAGTGAGTCACTGTCTCGAAAAAGAAAGGAAGAAATAAAGCAAACAAATAAAAATAATAGTGCAGACAAAAGGCCTTGACCCATCTAGCTTT @0=>12?7?C;8I=0;9>#AH@ECA9=9=0().D=:;CKBE'450120:7+@C=E4C6E@CE5ACFI@D<@>9G=?;?E*=3HEKKJJCHKKHFHGJKLIILLGJLLLJJMMJJIMMMJJMHKKEEJGKLJKMLMKJJILKGLHJKJIIMIIIMFFIGIGGKFGE X0:i:1 X1:i:0 MD:Z:17A83 RG:Z:ERR229775 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.18618553 163 17 2570 60 101M = 2828 358 GAAAGGAAGAAATAAAGAAAACAAATAAAAATAATAGTGCAGACAAAAGGCCTTGACCCATCTAGCTTTGGCCCTCAGCATCAACCGCTAGATACGTCCCT @>DGC8=FEC>CGDIEHCACFGFKKAFHKJBDDCJ X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@E +ERR229775.83543817 99 17 2577 60 77M24S = 2821 288 AGAAATAAAGAAAACAAATAAAAATAATAGTGCAGACAAAAGGCCTTGACCCATCTAGCTTTGGCCCTCAGCATCAACCGCTAGATACGTCCCTCCCTTTC 4::A:>A>G8)>F<>ADDHDCGAJ<=JB,*EB797,>HHL@C95=/:EC=@@FC>GEJHC=479788BI96F0EKK######################### X0:i:1 X1:i:0 XC:i:77 MD:Z:77 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.66162627 99 17 2602 60 101M = 2766 264 AATAGTGCAGACAAAAGGCCTTGACCCATCTAGCTTTGGCCCTCAGCATCAACCGCTAGATACGTCCCTCCCTTTCTTCTGGGGCACAGGTCACACTCTCT ?DFGEHGFHIHGJEKKGGJJLJKKJLLIIKMIFHMJJIIJLLKJJIJKHJKMKFAJLJKLJKGBHJIFKGHHLHIJMIIGF>BCGJGKDCJIJGGFKFIEH X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@J +ERR229775.36854728 99 17 2628 60 99M2S = 2910 357 CATCTAGCTTTGGCCCTCAGCATCAACCGCTAGATACGTCCCTCCCTTTCTTCTGGGGCACAGGTCACACTCTCTTCCAGGTCTAGGATGCAGCTGAGGGG 4GFEJG@EKG=@.BEGJ+AHFCFCGLGGD/E9CGADGFH?GDKGLFIAHDJ@BHGLEFDGEE=DDGIBFB### X0:i:1 X1:i:0 XC:i:99 MD:Z:99 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@B@@@ +ERR229775.80729707 147 17 2698 29 23S78M = 2417 -358 TGCTTCTGGGGCACAGGTCACACTCTCTTCCAGGTCTATGATTCAGCTGAGGGGTGCCACTCTTACCATCTAATCTGTGCGCTTATTTACTCTGCTTTAGT ########################HI<4*16J>9**D?/?:9**HC)F3A'6B3F/;1.(((>/2&-5=*;,3HA<':0+('/(;/*7.(7%;'.2C@481 XC:i:78 MD:Z:15G3G15C21C7C12 RG:Z:ERR229775 AM:i:29 NM:i:5 SM:i:29 MQ:i:29 XT:A:M BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.94440410 147 17 2716 60 101M = 2419 -397 TGCAGCTGAGGGGTGCCCCTCTTACCATCTAATCTGTGCCCTTATTTCCTCTGCTTTAGTGAGGAAGAGGCCCCTGGTCCATGAAGGGGCCTTTCAGAGAC DEFJHGD>7E>ADGG@:9HJBIEADHGGGIHJJFGA>A?99DEKGFCC=4<%DGG;@BCCEDDF### X0:i:1 X1:i:0 XC:i:99 MD:Z:99 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.45483038 99 17 2750 60 101M = 3055 353 TGTGCCCTTATTTCCTCTGCTTTAGTGAGGAAGAGGCCCCTGGTCCATGAAGGGGCCTTTCAGAGACGGGGACCCCTGAGGAGCCCCGAGCAGCAGCCGTC BFHGGFFLHHGIIJKLKKJKLJJIHIKKMLLLLLMFEKMMNLMJLLJJJKMIFCFLILKLLKMLNLICHBEJ3AFAEEKCBCDGFIF;?=CCHFFEEC83; X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.78014576 99 17 2757 60 91M10S = 2948 291 TTATTTCCTCTGCTTTAGTGAGGAAGAGGCCCCTGGTCCATGAAGGGGCCTTTCAGAGACGGGGACCCCTGAGGAGCCCCGAGCAGCAGCCGTCGTGTCTC BFGGGHGFKHIIIHIJFKHIKJLILLKLJKKMLMJLFJLJJJLNMMMMLMMKLMKMLKLJBJJFGCGFFECGHFB@HFFF/7@67?9E@F########### X0:i:1 X1:i:0 XC:i:91 MD:Z:91 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@A@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.101859832 147 17 2762 60 101M = 2474 -388 TCCTCTGCTTTAGTGAGGAAGAGGCCCCTGGTCCATGAAGGGGCCTTTCAGAGACGGGGACCCCTGAGGAGCCCCGAGCAGCAGCCGTCGTGTCTCACCCA <8=DBIGIHJGIDJIMHICFA?BGEFAG9FEGAAJ@CC?@DCFHAJ>>811?C;85FEHCBHA>@K8EE=3@<@EHB=;HI>FF?EB@FF=C5CBA@ X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.66162627 147 17 2766 60 101M = 2602 -264 CTGCTTTAGTGAGGAAGAGGCCCCTGGTCCATGAAGGGGCCTTTCAGAGACGGGGACCCCTGAGGAGCCCCGAGCAGCAGCCGTCGTGTCTCACCCAGGGT EHGCA-@LEEDGHEFLEMHB?B?@FGEIDG?CA?FC>ACD1??@;AEAGCGGAAJKGFHK=IEB?LGCEFFHDCG#:3?EBFBGDF X0:i:1 X1:i:0 MD:Z:90T10 RG:Z:ERR229775 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@B +ERR229775.44852854 83 17 2817 60 101M = 2547 -370 GGGGACCCCTGAGGAGCCCCGAGCAGCAGCCGTCGTGTCTCACCCAGGGTGTCTGAAACAGATGTGGAGGTCTCGGGTGAGGCGTGGCTCAGATACAGGGA BCC?6ABEHFILIIJJGGG;IGIHMIHIHF?EH?HKHLKLKKMMLNMMJKKMMKMKLKKNLJKKKLMMLIKJLBKLJJLLLKBIIKJFKIIHHHIHKEEFB X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:CBA@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.83543817 147 17 2821 60 56S45M = 2577 -288 TCTGCTTTGGTGAGGAAGAGGCCCCGGGTCCATGAAGGGGCCTTTCAGAGACGGGGGCCCCTGAGGAGCCCCGAGCAGCAGCCGTCGTGTCTCACCCAGGG #########################################################7,,/?4:@2;'B6#'01'8,2'4&8.;H29?@:+&'-13CH;-1 X0:i:1 X1:i:0 XC:i:45 MD:Z:0A44 RG:Z:ERR229775 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.18618553 83 17 2828 60 101M = 2570 -358 AGGAGCCCCGAGCAGCAGCCGTCGTGTCTCACCCAGGGTGTCTGAAACAGATGTGGAGGTCTCGGGTGAGGCGTGGCTCAGATACAGGGAGTGGCCCACAG #B7@??990GHIIMFDEICAGH?FHCD<+@FEEHHIIIJILKKLKJKLNLJKKKMLMMJKIGBKIJJMMKK>GJLKJIKLLIHEJKJJIKEHGHE@EFDK? X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.91229453 99 17 2831 60 101M = 3084 353 AGCCCCGAGCAGCAGCCGTCGTGTCTCACCCAGGGTGTCTGAAACAGATGTGGAGGTCTCGGGTGAGGCGTGGCTCAGATACAGGGAGTGGCCCACAGCTC ?CGEEF?HBGFIGFKJJABI@JIIIKKJJLKJKLLABEHLJLLMKKILJJJJFKKHGFLI=DD?BGFEG>@BBFIJKIKGIHJIG@HHHFKGEF:E7 X0:i:1 X1:i:0 XC:i:86 MD:Z:86 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.7004516 163 17 2878 60 101M = 3107 329 ATGTGGAGGTCTCGGGTGAGGCGTGGCTCAGATACAGGGAGTGGCCCACAGCTCGGCCTGTCTTTGAAAGGCCACGTGACCTGGCCCACGGCTGGCAGGTG @EEFECDFD;:JG0C=?D;AGJ?GGGJEI<=JHHHHJKIKE>CFIKLGGE?HIH6?CAF>GBKBA9GIGB?EDFE@IHGFGHIGEFFJG:@FIC@EDB?6B X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@D +ERR229775.36854728 147 17 2910 60 25S76M = 2628 -357 GGTCTCGGGTGAGGCGTGGCTCAGATACAGGGAGTGGCCCACAGCTCGGCCTGTCTTTGAAAGGCCACGTGACCTGGCCCACGGCTGGCAGGTGGGACCCA ##########################HHKC9,>ABC?;DBGAH=8;;IEE<>2?HB@C>HCF7<;2G79===)C@5&=*B@86FEEHA@B9:<797DB3;@ X0:i:1 X1:i:0 XC:i:76 MD:Z:76 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.28172972 163 17 2918 60 101M = 3194 376 GTGGCCCACAGCTCGGCCTGTCTTTGAAAGGCCACGTGACCTGGCCCACGGCTGGCAGGTGGGACCCAGCTGCAGGGGGCCAGCAGCACCCACAGCAGCCA BFECEDAFC@CGJH?GIIGGHIJIIGJHHD;A;@=D@9BE>:D=BHI9;;A"99>><@>BCEEE=CFEFIBAC# X0:i:1 X1:i:0 MD:Z:78T22 RG:Z:ERR229775 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.78014576 147 17 2948 60 101M = 2757 -291 GCCACGTGACCTGGCCCACGGCTGGCAGGTGGGACCCAGCTGCAGGGGTCCAGCAGCACCCACAGCAGCCACCTGTGGCAGGGAGGAGCTTGTGGTACAGT C@AB=GIC>BDHFFG@@??HHFHGEEIGHHHFBCFFIHHDJJEFMLHJKFEFHILEF>IHGGIIHJIHHI?EKIIHJJEJJHEJIDJHHIB@ED@EFEIDB X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.19870548 163 17 2964 60 101M = 3254 390 CACGGCTGGCAGGTGGGACCCAGCTGCAGGGGTCCAGCAGCACCCACAGCAGCCACCTGTGGCAGGGAGGAGCTTGTGGTACAGTGGACAGGCCCTGCCCA ADDECGIGHJHBFH:F=:<9D??FIKJIGJHCHLGIHIEABDE@CGDDFFAFA?CDE@E9B?6>4B@@FAA6E6@5*>1=B>DB X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.91036639 147 17 2967 60 101M = 2776 -291 GGCTGGCAGGTGGGACCCAGCTGCAGGGGTCCAGCAGCACCCACAGCAGCCACCTGTGGCAGGGAGGAGCTTGTGGTACAGTGGACAGGCCCTGCCCAGAT 53AFE?BAHGJIHIBCCEDIGIF=GGGGHKCFKF@F=?CGLJGBKIIKGG?:IJJJJKLJKLKJLKKKIKHB@HICHBHKHFEHGFJHGFBCFE@CEIFEB X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.11173812 99 17 3034 60 101M = 3333 399 AGCTTGTGGTACAGTGGACAGGCCCTGCCCAGATGGCCCCCCGCCTGCCTGTGGAAGTTGACCAGACCATTTGTCACAGCAGGTAAGACTCTGCTTTCTGG ?CFKBHGHEHFGHEIGDHHILKLLLMIIKLJJKIJIKILMMM>JIMIHIMJFCDJLG0ADIHIGCGDEHHHEHIIKHKHGJIG8GKHKGNIMIIKGDFCEA X0:i:1 X1:i:0 MD:Z:70C30 RG:Z:ERR229775 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@GF +ERR229775.45483038 147 17 3055 60 52S49M = 2750 -353 GCCCCCACAGCAGCCACCTGTGGCAGGGAGGAGCTTGTGGTACAGTGGACAGGCCCTGCCCAGATGGCCCCCCGCCTGCCTGTGGAAGTTGACCAGACCAT #####################################################A54-7=90;?5::24>EAB?DH@DE X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@FJ +ERR229775.59323675 163 17 3154 60 101M = 3389 335 TGGAATTCCTGTCCATCTGGCAGGTGGGCATTGAAACTGGTTTAAAAATGTCACACCATAGGCCGGGCACAGTGGCTCACGCCTGTAATCCCAGCCCTTTG @B?ECD9@8@GCII88GHF<9:FIIILLLLHFJEHHJJHIJGKJGI?@BJJJJKDB>DKDJC<@EEBHFLGF?EIAGEHCCD@2ABEACFHDCC#9@?###### X0:i:1 X1:i:0 XC:i:96 MD:Z:91T3T0 RG:Z:ERR229775 AM:i:37 NM:i:2 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.28172972 83 17 3194 60 101M = 2918 -376 TTTAAAAATGTCACACCATAGGCCGGGCACAGTGGCTCACGCCTGTAATCCCAGCCCTTTGGGAGGCCAGGGTGGGTGGATCACTTGAGGTCAGGAGTTCA BDFCHIEIJGKDHIJHIJIMHGG?IHIHJHKHJJGCGFKBMKMKJJLKLJJIIJFJMMMKMMMLMKFHLMKJJLLJIKIIKGDKLIKKIGHHKFGLDIHFB X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:ABA@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@D +ERR229775.453972 81 17 3215 37 2S99M * 0 0 AGGCCGGGCACAGTGGCTCACGCCTGTAATCCCAGCCCTTTGGGAGGCCAGGGTGGGTGGATCACTTGAGGTCAGGAGTTCAAGACCAGCCTGGCCAACAT ###>6FEBCCE@HGDIIHDG?GEIICHHF@FBBIGHDFFF1JMLLLJCIMLIHFLIHJIJFGE?KLJMMHCDKMLLKJLIIJEB@KJKIEGIGHFHBFEE? X0:i:1 X1:i:0 XC:i:99 MD:Z:99 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.41226651 99 17 3242 60 101M = 3478 336 TCCCAGCCCTTTGGGAGGCCAGGGTGGGTGGATCACTTGAGGTCAGGAGTTCAAGACCAGCCTGGCCAACATGGTGAAACCCCGTCTACTAAAAATACAAA BFEEGHHFGKGIIEKJKGJHIJIIIIIIEIJKJKJIMKLLMJJJKMMGKDCIJLKLGIJFIGHCBFDHFEIHBEBCKHHDHHI?GIJJGNIHHJGDGEGDD X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@IIK +ERR229775.19870548 83 17 3254 60 101M = 2964 -390 GGGAGGCCAGGGTGGGTGGATCACTTGAGGTCAGGAGTTCAAGACCAGCCTGGCCAACATGGTGAAACCCCGTCTACTAAAAATACAAAAATTAGCCTGGC DEFIFHBEIIIDHFIGKHGIKCHIGKKOJILHMJKNHKGJIEKIMJMJDDJIJGAKKLKKLKKMKJJLLLCIKJIIJIJJJJHDEJIIIIGKHLHFGGEFB X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:CCA@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.43420834 99 17 3270 60 101M = 3494 324 TGGATCACTTGAGGTCAGGAGTTCAAGACCAGCCTGGCCAACATGGGGAAACCCCGTCTACTAAAAATACAAAAATTAGCCTGGCGTGGGGGCGCATGCCT ?ECHGGHFKIBJHJFGHKBJJIJKJMHKIKJMLLMIJKMKNKKJLI%@GMKHILH?EEHFAJJMMMDFBDIJJJGHGJDDHLDCG;HDA#77=FIJFJIJ=JJIG;EJEFBIKKJFE:GFD8/9:*E@EE3%DJ;D2BDD@ X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:IH@G@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.94803111 163 17 3384 60 101M = 3606 322 CTTGGGAAGCTGAGGGATGAGAACTGCTTGAACCTGGGAGGCAGACGTTGCAGTGAGCTGAGATCACGCCACTGCACTCCAGCCTGGGCAACAGAGTAAGA BIEECCDHEBEGIBIGIGGHJIJHKIJKIHGLIJLJKKKLKKJKKJBIJIEJKJKKKIMJKHLEFIF@HFGDKGHIFLHHIHIHMIGBGJHGJIJHHGEFG X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@B +ERR229775.91011602 83 17 3387 60 101M = 3102 -385 GGGAAGCTGAGGGATGAGAACTGCTTGAACCTGGGAGGCAGACGTTGCAGTGAGCTGAGATCACGCCACTGCACTCCAGCCTGGGCAACAGAGTAAGACTC DDFFKHHFIMIHIJKGLIHIIHKIGJIDHIJKIJKNLLLNLKCKNKMJNKKMMJKKHNMJLIFAJJHIHIIHGLKIGJKKLIKKKJIHILGKFHHLEFDGB X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:CBA@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.59323675 83 17 3389 60 101M = 3154 -335 GAAGCTGAGGGATGAGAACTGCTTGAACCTGGGAGGCAGACGTTGCAGTGAGCTGAGATCACGCCACTGCACTCCAGCCTGGGCAACAGAGTAAGACTCTG A5IGFFHGIIIJKINGEGIGI;KHE?1IHHJJKMJJHMKJBKNKMJMHGIMJIJLKJHKIE?GFFJKJEFEHKEIKIEGIFHC;AFHIGL@HHLGIGHDH? X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.5896825 83 17 3415 60 101M = 3144 -371 ACCTGGGAGGCAGACGTTGCAGTGAGCTGAGATCACGCCACTGCACTCCAGCCTGGGCAACAGAGTAAGACTCTGTCTCAAAAAAAAAAAAATCACACCAT @>>ADEB1CA>FB277FJIFJ;=B18+/A098D=55?==:<>(;0=7BBH@>BEHFCBBC99?JA6@G7.A;?:7:AJGJJJJIJJIGIIGGIFHGEEFE? X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@A +ERR229775.43002343 163 17 3466 29 43M58S = 3687 321 CCTGGGCAACAGAGTAAGACTCTGTCTCAAAAAAAAAAAAATAACACCATTTTGGCTTCAGAATTCATATCCTCCTGCAAGGATATATACGCGAGAAATTA 58=>BB1BB659IJHIGHHF:IFBBBHBFAG?G@HFCF;AGFDG>:AECFEEGAA X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:C@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@C +ERR229775.43420834 147 17 3494 60 101M = 3270 -324 AAAAAAAAAAAAATCACACCATTTTGGCTTCAGATTGCATATCCTCCTGCAAGGATATATACGCGTGAAATTCAAGTCAATGACAAATCAGAAAAAAAAAC A9>D?@DFHHFFG9?577GHGD;IIGHGIGFKFFGDEBGACABDIB>I?G?HGKICIA9F<=>9>IGIIHJ@HIKCDDHGG<>GGCGCDJBBEFCFFEC<@ X0:i:1 X1:i:0 MD:Z:93G7 RG:Z:ERR229775 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:G@CICDGHJIEDB@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@BC@CCB@@@ +ERR229775.98041640 147 17 3494 60 46S55M = 3175 -373 CCCGCCCCGCCACCCCAGCCTGGGCAACAGGGTAAGCCTCCGTCTAAAAAAAAAAAAAATCACACCATTTTGGCTTCAGATTGCATATCCTCCTGCAAGGA ###############################################?DHGJJJHE?HD9;D;0@HD?:J7>:5>8GIIJHFGHJIHIIIINIGMIIGHFDED X0:i:1 X1:i:0 MD:Z:57G43 RG:Z:ERR229775 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.98929975 83 17 3553 60 101M = 3302 -351 TACGCGTGAAATTCAAGTCAATGACAAATCAGAAAAAAAAACATATATATACGCAAACCAGTATCCTACTGTGTGTGTCGTTTGTTGTGTTTTCGACAGCT A?>E?FIIFFJKKIFNGKIKJHIHIIEHJHLHDDDCCKJCGJJJKJJJJFFBLJKIFMKMJJJLJJJFLKIJIJJJJK@ILLIILIIFGKIKI?GHGKGEB X0:i:1 X1:i:0 MD:Z:34G66 RG:Z:ERR229775 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.105205152 99 17 3562 60 93M8S = 3856 394 AATTCAAGTCAATGACAAATCAGAAAAAAAAACATATATATACGCAAACCAGTATCCTACTGTGTGTGTCGTTTGTTGTGTTTTCGACAGCTGTCCGTGTT ?D>?9HF>@ECDFDCDF;HBDCIID9797+7.7B>6=HL######### X0:i:1 X1:i:0 XC:i:93 MD:Z:25G67 RG:Z:ERR229775 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:AF@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.30258628 163 17 3583 60 101M = 3859 349 AGAAAAAAAAACATATATATACGCAAAACAGTATCCTACTGTGTGTGTCGTTTGTTGTGGTTTCTACAGCTGTCCGTGTGATAATAATTCCTCTAGTTCAA @@GCHH;6=>ECF=G4D==2BC*:=)6)'/-/4107;+4+@=E7,CBC:;C;BLB?HDGGB X0:i:1 X1:i:0 MD:Z:4G22C31T4G14T21 RG:Z:ERR229775 AM:i:25 NM:i:5 SM:i:25 MQ:i:60 XT:A:U BQ:Z:OOVRWWJELKO@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@IG +ERR229775.15284212 99 17 3585 60 88M13S = 3809 324 AAAAAAAAACATATATATACGCAAACCAGTATCCTACTGTGTGTGTCGTTTGTTGTGTTTTCGACAGCTGTCCGTGTTATAATAATTCCTCTAGTTCAAAT ?DEDDFFEIECHI;HHHAHI>HGLLGKIJGHFHCJIHEAGF:FJJDC8GIDFJBCFBHDGGH5GCFCBC=:AF/1826-7FJEIJHI############## X0:i:1 X1:i:0 XC:i:88 MD:Z:2G85 RG:Z:ERR229775 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:MRSRRTRPQ@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.15906182 163 17 3598 60 101M = 3862 364 TATATACGCAAACCAGTATCCTACTGTGTGTGTCGTTTGTTGTGTTTTCGACAGCTGTCCGTGTTATAATAATTCCTCTAGTTCAAATTTATTCATTTTTA BFEEEE@EKCDGA@>G@D?HJIIC;?=CD@JK?#;BJJ5DECBIABFDGHHCGFE?DJDGJGKDGI5BEIKHFFIKD-BHEFEGMGIIKGIJJIJGJGJDJFJ?FMMKHNKIKKNNNLDMKLNLKKKLMCKKKNKKJLKJKKMKLKKMJMJMKKKKJLLIIIJJHJJKIHHGHJIGFFB X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.15603458 163 17 3626 60 101M = 3846 320 TGTGTCGTTTGTTGTGTTTTCGACAGCTGTCCGTGTTATAATAATTCCTCTAGTTCAAATTTATTCATTTTTAACTTCATAGTACCACATTCTACACACTG @EADDC9A@B@GH@GBCFB>>3CD?=;E@9>H;C;IJBIIIIIJIJHILHCBAF;=GI@BJDJE>>CFHKHIINE:BHIGH4E?EHJGG>AFMIFIEHAJ4 X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@B@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.80842527 99 17 3639 60 101M = 3844 305 GTGTTTTCGACAGCTGTCCGTGTTATAATAATTCCTCTAGTTCAAATTTATTCATTTTTAACTTCATAGTACCACATTCTACACACTGCCCATGTCCCCTC AGEFGHHG?JEIHJLJIKK@IJJJIJJMJJMJKMKMMMJMKKMKNNKKLJKLMKKLKLLKMKNLLKKKNLKKMKJJLLLLLJLILIPLJKILJIIGHFEJD X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.84503264 163 17 3670 60 101M = 3903 331 TTCCTCTAGTTCAAATTTATTCATTTTTAACTTCATAGTACCACATTCTACACACTGCCCATGTCCCCTCAAGCTTCCCCTGGCTCCTGCAACCACAAATC AEFCIEFFEB,CEHH?*;6936?956.-2%7)=C@3?BB.6C891FDGFJ?==>D@A:/DEB5@4BDG@D@ X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:EG@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@B +ERR229775.78993145 147 17 3760 60 101M = 3530 -330 AACCACAAATCTACTCTCTGCCTCTGTGGGTTGACCTATTCTGGACACGTCATAGAAATAGAGTCCTGCAACACGTGGCCGTCTGTGTCTGGCTTCTCTCG 1@DGHHHFIJE@:CKDGIJIFHJBFBFGIHJJEFCHGEKEIIHGJGFAIKDJJMLJJIILDKIKIKIHHJEBBAIHJJE?HHIGGCGHHGABEHDEGEH9A X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.102280357 83 17 3772 60 101M = 3516 -356 ACTCTCTGCCTCTGTGGGTTGACCTATTCTGGACACGTCATAGAAATAGAGTCCTGCAACACGTGGCCGTCTGTGTCTGGCTTCTCTCGCTTAGCATCTTG ;EGFFHIFGIKIKGJIHGHJIDGIJHIJHIGGGHG>HLJJJNIJKKJMJNKLMKJLLJJJDCKKLKJAIGLJIJGIJJLKJLICJGJAIIIHKHHHIGHHB X0:i:1 X1:i:0 MD:Z:101 RG:Z:ERR229775 AM:i:37 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.60297548 147 17 3785 60 101M = 3736 -149 GTGGGTTGACCTATTCTGGACACGTCATAGAAATAGAGTCCTGCAACACGTGGCCGTCTGTGTCTGGCTTCTCTCGCTTAGCATCTTGTTTCCAAGGTCCT @GFFFGJIJGIIHHKHJHHIHF@FIHIJLIHIFFJHJAGAIIHDGFDGAIEGHIAIKHIJIJKKIJKGKJD@IIAJKKEKJGDDJCGEE:,BJIGFGEFHFEBALJGJ?K4E;KILICFJELIFKJB>AHAF@HFGEGGGC? X0:i:1 X1:i:0 MD:Z:90A10 RG:Z:ERR229775 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.105205152 147 17 3856 60 101M = 3562 -394 TCTCGCTTAGCATCTTGTTTCCAAGGTCCTCCCACAGTGTAGCATGCACCTGCTACACTCCTTCTTAGGGCTGATATTCCGCGCACCTGCTACACTCCTTC #BE=GGHILIIHKHHJGJHJDHEKD;+EBF?C>FFJ?E?DCIFEIGB>=HGBDILKGIFB>FI=9*=<><'?;C69?8,6?DD253-72,D9>: X0:i:1 X1:i:0 MD:Z:80A20 RG:Z:ERR229775 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.30258628 83 17 3859 60 27S74M = 3583 -349 TCGTGGCCGTCTGTGTCTGGCTTCTCTCGCTTAGCATCTTGTTTCCAAGGTCCTCCCACAGTGTAGCATGCACCTGCTACACTCCTTCTTAGGGCTGATAT ############################FLLJHF-.LGLKHKKHCIBLHBHDB?@@;7IH=9>7/5HIE+A@EHICFFIGIJ@AGI?>KHAGEFGHE:DE7 X0:i:1 X1:i:0 XC:i:74 MD:Z:74 RG:Z:ERR229775 AM:i:25 NM:i:0 SM:i:37 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.15906182 83 17 3862 60 101M = 3598 -364 TTAGCATCTTGTTTCCAAGGTCCTCCCACAGTGTAGCATGCACCTGCTACACTCCTTCTTAGGGCTGATATTCCGCGCACCTGCTACACTCCTTCTTATGG FEFFGGJHCKHHKKGHILFE@:EBCFIIHLEHHIMHEEIFBEGJJJKIIBAIGJMMLMMJMIIJIJKJJJMGLAKAKFFEJIDGHIHCJK@GJJHJGGHEB X0:i:1 X1:i:0 MD:Z:74A26 RG:Z:ERR229775 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:D@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ +ERR229775.104583040 99 17 3884 37 84M17S = 4097 298 CTCCCACAGTGTAGCATGCACCTGCTACACTCCTTCTTAGGGCTGATATTCCGCGCACCTGCTACACTCCTTCTTATGGCTGATATTCCACGCACCTGCTA ?HFEEHFHBC7EGAHIHCHFDHL?HJ=FI48C>KFJL=EKCCJJJALKHJLJLLIIHJFKHIIGGKJHCG?EFBHIGDCF>F@CCDFEGEGFF@ X0:i:1 X1:i:0 MD:Z:39A61 RG:Z:ERR229775 AM:i:37 NM:i:1 SM:i:37 MQ:i:60 XT:A:U BQ:Z:A@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@B +ERR229775.84503264 83 17 3903 60 2S99M = 3670 -331 GCCCCTGCTACCCTCCTTCTTAGGGCTGATATTCCGCGCCCCTGCTACCCTCCTTCTTATGGCTGATATTCCACGCACCTGCTACACTCCTTCTTAGGGCT ###?DDA5-;91@B:HBJ<:89-=F65868-%4C9E5-=>9C+9C9H;AFC7GEBCCJJILKJHHAIHELLIJJD=C>IFEIIJIJHLEEGEB X0:i:1 X1:i:0 XC:i:99 MD:Z:0A8A23A3A8A52 RG:Z:ERR229775 AM:i:25 NM:i:5 SM:i:25 MQ:i:60 XT:A:U BQ:Z:@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@ diff --git a/test/mpileup/mpileup.4.out b/test/mpileup/mpileup.4.out new file mode 100644 index 000000000..217cc0e77 --- /dev/null +++ b/test/mpileup/mpileup.4.out @@ -0,0 +1,527 @@ +##fileformat=VCFv4.2 +##FILTER= +##contig= +##ALT= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##INFO= +##FORMAT= +##FORMAT= +#CHROM POS ID REF ALT QUAL FILTER INFO FORMAT HG00100 HG00101 HG00102 +17 100 . C <*> 0 . DP=18;DPR=17,0;I16=17,0,0,0,688,29762,0,0,958,55682,0,0,332,7446,0,0;QS=3,0;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,27,189:9:0:0:9,0,0,0:9,0 0,9,108:3:0:0:3,0,0,0:3,0 0,15,134:5:0:0:5,0,0,0:5,0 +17 101 . C <*> 0 . DP=18;DPR=17,0;I16=17,0,0,0,650,27530,0,0,958,55682,0,0,331,7303,0,0;QS=3,0;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,27,182:9:0:0:9,0,0,0:9,0 0,9,99:3:0:0:3,0,0,0:3,0 0,15,132:5:0:0:5,0,0,0:5,0 +17 102 . C <*> 0 . DP=18;DPR=17,0;I16=17,0,0,0,695,30453,0,0,958,55682,0,0,330,7178,0,0;QS=3,0;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,27,188:9:0:0:9,0,0,0:9,0 0,9,111:3:0:0:3,0,0,0:3,0 0,15,139:5:0:0:5,0,0,0:5,0 +17 103 . T <*> 0 . DP=18;DPR=16,0;I16=16,0,0,0,692,31998,0,0,929,54841,0,0,323,7035,0,0;QS=3,0;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,24,189:8:0:0:8,0,0,0:8,0 0,9,108:3:0:0:3,0,0,0:3,0 0,15,147:5:0:0:5,0,0,0:5,0 +17 104 . G <*> 0 . DP=18;DPR=15,0;I16=15,0,0,0,611,26723,0,0,900,54000,0,0,295,6259,0,0;QS=3,0;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,24,178:8:0:0:8,0,0,0:8,0 0,6,89:2:0:0:2,0,0,0:2,0 0,15,133:5:0:0:5,0,0,0:5,0 +17 105 . G <*> 0 . DP=19;DPR=17,0;I16=17,0,0,0,604,23936,0,0,989,58441,0,0,317,6751,0,0;QS=3,0;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,27,170:9:0:0:9,0,0,0:9,0 0,9,97:3:0:0:3,0,0,0:3,0 0,15,125:5:0:0:5,0,0,0:5,0 +17 106 . G <*> 0 . DP=19;DPR=17,0;I16=17,0,0,0,644,26574,0,0,989,58441,0,0,299,6093,0,0;QS=3,0;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,30,190:10:0:0:10,0,0,0:10,0 0,6,85:2:0:0:2,0,0,0:2,0 0,15,124:5:0:0:5,0,0,0:5,0 +17 107 . C <*> 0 . DP=19;DPR=17,0;I16=17,0,0,0,694,30064,0,0,989,58441,0,0,313,6543,0,0;QS=3,0;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,27,192:9:0:0:9,0,0,0:9,0 0,9,108:3:0:0:3,0,0,0:3,0 0,15,136:5:0:0:5,0,0,0:5,0 +17 108 . C <*> 0 . DP=19;DPR=17,0;I16=17,0,0,0,692,30148,0,0,989,58441,0,0,310,6420,0,0;QS=3,0;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,27,190:9:0:0:9,0,0,0:9,0 0,9,108:3:0:0:3,0,0,0:3,0 0,15,135:5:0:0:5,0,0,0:5,0 +17 109 . T <*> 0 . DP=19;DPR=17,0;I16=17,0,0,0,741,34273,0,0,989,58441,0,0,307,6319,0,0;QS=3,0;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,27,195:9:0:0:9,0,0,0:9,0 0,9,110:3:0:0:3,0,0,0:3,0 0,15,150:5:0:0:5,0,0,0:5,0 +17 110 . G <*> 0 . DP=19;DPR=17,0;I16=17,0,0,0,704,31276,0,0,989,58441,0,0,304,6240,0,0;QS=3,0;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,27,194:9:0:0:9,0,0,0:9,0 0,9,104:3:0:0:3,0,0,0:3,0 0,15,136:5:0:0:5,0,0,0:5,0 +17 111 . G <*> 0 . DP=19;DPR=16,0;I16=16,0,0,0,584,24362,0,0,929,54841,0,0,272,5416,0,0;QS=3,0;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,30,167:10:0:0:10,0,0,0:10,0 0,6,88:2:0:0:2,0,0,0:2,0 0,12,118:4:0:0:4,0,0,0:4,0 +17 112 . C <*> 0 . DP=19;DPR=17,0;I16=17,0,0,0,680,29854,0,0,989,58441,0,0,296,6052,0,0;QS=3,0;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,27,191:9:0:0:9,0,0,0:9,0 0,9,95:3:0:0:3,0,0,0:3,0 0,15,135:5:0:0:5,0,0,0:5,0 +17 113 . A <*> 0 . DP=19;DPR=16,0;I16=16,0,0,0,645,28035,0,0,960,57600,0,0,266,5318,0,0;QS=3,0;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,27,176:9:0:0:9,0,0,0:9,0 0,6,87:2:0:0:2,0,0,0:2,0 0,15,139:5:0:0:5,0,0,0:5,0 +17 114 . C <*> 0 . DP=19;DPR=17,0;I16=17,0,0,0,674,28788,0,0,989,58441,0,0,286,5856,0,0;QS=3,0;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,27,182:9:0:0:9,0,0,0:9,0 0,9,103:3:0:0:3,0,0,0:3,0 0,15,133:5:0:0:5,0,0,0:5,0 +17 115 . C <*> 0 . DP=21;DPR=18,0;I16=18,0,0,0,708,30546,0,0,1049,62041,0,0,274,5490,0,0;QS=3,0;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,30,189:10:0:0:10,0,0,0:10,0 0,6,89:2:0:0:2,0,0,0:2,0 0,18,147:6:0:0:6,0,0,0:6,0 +17 116 . A <*> 0 . DP=21;DPR=18,0;I16=17,1,0,0,727,31755,0,0,1049,62041,0,0,253,5079,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,27,183:9:0:0:9,0,0,0:9,0 0,6,90:2:0:0:2,0,0,0:2,0 0,21,175:7:0:0:6,1,0,0:7,0 +17 117 . G <*> 0 . DP=21;DPR=18,0;I16=17,1,0,0,712,30478,0,0,1049,62041,0,0,249,5019,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,27,183:9:0:0:9,0,0,0:9,0 0,6,85:2:0:0:2,0,0,0:2,0 0,21,177:7:0:0:6,1,0,0:7,0 +17 118 . G <*> 0 . DP=20;DPR=17,0;I16=16,1,0,0,636,26574,0,0,958,55682,0,0,266,5426,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,27,175:9:0:0:9,0,0,0:9,0 0,3,60:1:0:0:1,0,0,0:1,0 0,21,162:7:0:0:6,1,0,0:7,0 +17 119 . G <*> 0 . DP=19;DPR=17,0;I16=16,1,0,0,629,26439,0,0,958,55682,0,0,267,5553,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,24,175:8:0:0:8,0,0,0:8,0 0,6,73:2:0:0:2,0,0,0:2,0 0,21,160:7:0:0:6,1,0,0:7,0 +17 120 . A <*> 0 . DP=19;DPR=17,0;I16=16,1,0,0,672,29188,0,0,958,55682,0,0,264,5518,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,24,175:8:0:0:8,0,0,0:8,0 0,6,83:2:0:0:2,0,0,0:2,0 0,21,171:7:0:0:6,1,0,0:7,0 +17 121 . G <*> 0 . DP=19;DPR=17,0;I16=16,1,0,0,662,28460,0,0,958,55682,0,0,260,5454,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,24,181:8:0:0:8,0,0,0:8,0 0,6,80:2:0:0:2,0,0,0:2,0 0,21,168:7:0:0:6,1,0,0:7,0 +17 122 . C <*> 0 . DP=20;DPR=18,0;I16=17,1,0,0,716,31224,0,0,1018,59282,0,0,256,5410,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,24,181:8:0:0:8,0,0,0:8,0 0,9,99:3:0:0:3,0,0,0:3,0 0,21,178:7:0:0:6,1,0,0:7,0 +17 123 . T <*> 0 . DP=18;DPR=16,0;I16=15,1,0,0,661,29997,0,0,898,52082,0,0,255,5385,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,167:7:0:0:7,0,0,0:7,0 0,9,112:3:0:0:3,0,0,0:3,0 0,18,166:6:0:0:5,1,0,0:6,0 +17 124 . T <*> 0 . DP=19;DPR=18,0;I16=17,1,0,0,626,24802,0,0,987,56523,0,0,279,6003,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,27,154:9:0:0:9,0,0,0:9,0 0,9,104:3:0:0:3,0,0,0:3,0 0,18,154:6:0:0:5,1,0,0:6,0 +17 125 . A <*> 0 . DP=18;DPR=16,0;I16=15,1,0,0,611,25689,0,0,898,52082,0,0,254,5340,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,154:7:0:0:7,0,0,0:7,0 0,9,104:3:0:0:3,0,0,0:3,0 0,18,162:6:0:0:5,1,0,0:6,0 +17 126 . A <*> 0 . DP=18;DPR=17,0;I16=16,1,0,0,648,27366,0,0,927,52923,0,0,279,5947,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,24,162:8:0:0:8,0,0,0:8,0 0,9,107:3:0:0:3,0,0,0:3,0 0,18,174:6:0:0:5,1,0,0:6,0 +17 127 . C <*> 0 . DP=18;DPR=17,0;I16=16,1,0,0,646,26972,0,0,927,52923,0,0,279,5949,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,24,163:8:0:0:8,0,0,0:8,0 0,9,109:3:0:0:3,0,0,0:3,0 0,18,160:6:0:0:5,1,0,0:6,0 +17 128 . A <*> 0 . DP=18;DPR=17,0;I16=16,1,0,0,673,28797,0,0,927,52923,0,0,279,5971,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,24,169:8:0:0:8,0,0,0:8,0 0,9,111:3:0:0:3,0,0,0:3,0 0,18,162:6:0:0:5,1,0,0:6,0 +17 129 . A <*> 0 . DP=17;DPR=16,0;I16=15,1,0,0,645,27891,0,0,867,49323,0,0,280,6012,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,24,168:8:0:0:8,0,0,0:8,0 0,9,113:3:0:0:3,0,0,0:3,0 0,15,159:5:0:0:4,1,0,0:5,0 +17 130 . A <*> 0 . DP=17;DPR=16,0;I16=15,1,0,0,641,27295,0,0,867,49323,0,0,281,6071,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,24,169:8:0:0:8,0,0,0:8,0 0,9,113:3:0:0:3,0,0,0:3,0 0,15,152:5:0:0:4,1,0,0:5,0 +17 131 . C <*> 0 . DP=16;DPR=15,0;I16=14,1,0,0,606,25732,0,0,838,48482,0,0,256,5472,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,167:7:0:0:7,0,0,0:7,0 0,9,110:3:0:0:3,0,0,0:3,0 0,15,147:5:0:0:4,1,0,0:5,0 +17 132 . A <*> 0 . DP=16;DPR=15,0;I16=14,1,0,0,627,27579,0,0,838,48482,0,0,256,5514,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,169:7:0:0:7,0,0,0:7,0 0,9,110:3:0:0:3,0,0,0:3,0 0,15,151:5:0:0:4,1,0,0:5,0 +17 133 . T <*> 0 . DP=15;DPR=15,0;I16=13,2,0,0,584,22816,0,0,838,48482,0,0,282,6196,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,163:7:0:0:7,0,0,0:7,0 0,9,105:3:0:0:2,1,0,0:3,0 0,15,150:5:0:0:4,1,0,0:5,0 +17 134 . C <*> 0 . DP=15;DPR=15,0;I16=13,2,0,0,607,24653,0,0,838,48482,0,0,283,6267,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,177:7:0:0:7,0,0,0:7,0 0,9,105:3:0:0:2,1,0,0:3,0 0,15,152:5:0:0:4,1,0,0:5,0 +17 135 . T <*> 0 . DP=15;DPR=15,0;I16=13,2,0,0,600,24178,0,0,838,48482,0,0,284,6352,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,173:7:0:0:7,0,0,0:7,0 0,9,106:3:0:0:2,1,0,0:3,0 0,15,156:5:0:0:4,1,0,0:5,0 +17 136 . G <*> 0 . DP=15;DPR=15,0;I16=13,2,0,0,574,22258,0,0,838,48482,0,0,286,6450,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,172:7:0:0:7,0,0,0:7,0 0,9,105:3:0:0:2,1,0,0:3,0 0,15,134:5:0:0:4,1,0,0:5,0 +17 137 . T <*> 0 . DP=15;DPR=15,0;I16=13,2,0,0,563,21377,0,0,838,48482,0,0,289,6561,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,160:7:0:0:7,0,0,0:7,0 0,9,104:3:0:0:2,1,0,0:3,0 0,15,139:5:0:0:4,1,0,0:5,0 +17 138 . C <*> 0 . DP=15;DPR=15,0;I16=13,2,0,0,584,23088,0,0,838,48482,0,0,291,6637,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,172:7:0:0:7,0,0,0:7,0 0,9,108:3:0:0:2,1,0,0:3,0 0,15,142:5:0:0:4,1,0,0:5,0 +17 139 . C <*> 0 . DP=15;DPR=15,0;I16=13,2,0,0,554,20790,0,0,838,48482,0,0,292,6680,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,161:7:0:0:7,0,0,0:7,0 0,9,106:3:0:0:2,1,0,0:3,0 0,15,143:5:0:0:4,1,0,0:5,0 +17 140 . A <*> 0 . DP=15;DPR=15,0;I16=13,2,0,0,583,22789,0,0,838,48482,0,0,292,6690,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,163:7:0:0:7,0,0,0:7,0 0,9,107:3:0:0:2,1,0,0:3,0 0,15,153:5:0:0:4,1,0,0:5,0 +17 141 . G <*> 0 . DP=14;DPR=14,0;I16=12,2,0,0,534,20750,0,0,778,44882,0,0,292,6664,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,18,158:6:0:0:6,0,0,0:6,0 0,9,108:3:0:0:2,1,0,0:3,0 0,15,142:5:0:0:4,1,0,0:5,0 +17 142 . C <*> 0 . DP=14;DPR=14,0;I16=12,2,0,0,503,18593,0,0,778,44882,0,0,292,6650,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,18,157:6:0:0:6,0,0,0:6,0 0,9,97:3:0:0:2,1,0,0:3,0 0,15,129:5:0:0:4,1,0,0:5,0 +17 143 . G <*> 0 . DP=14;DPR=13,0;I16=11,2,0,0,415,13657,0,0,718,41282,0,0,285,6599,0,0;QS=3,0;MQSB=0.590909;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,18,128:6:0:0:6,0,0,0:6,0 0,9,95:3:0:0:2,1,0,0:3,0 0,12,97:4:0:0:3,1,0,0:4,0 +17 144 . A <*> 0 . DP=14;DPR=14,0;I16=12,2,0,0,519,19725,0,0,778,44882,0,0,291,6609,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,18,152:6:0:0:6,0,0,0:6,0 0,9,105:3:0:0:2,1,0,0:3,0 0,15,129:5:0:0:4,1,0,0:5,0 +17 145 . A <*> 0 . DP=14;DPR=14,0;I16=12,2,0,0,527,20289,0,0,778,44882,0,0,290,6584,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,18,153:6:0:0:6,0,0,0:6,0 0,9,106:3:0:0:2,1,0,0:3,0 0,15,138:5:0:0:4,1,0,0:5,0 +17 146 . T <*> 0 . DP=14;DPR=14,0;I16=12,2,0,0,514,19484,0,0,778,44882,0,0,289,6573,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,18,152:6:0:0:6,0,0,0:6,0 0,9,103:3:0:0:2,1,0,0:3,0 0,15,128:5:0:0:4,1,0,0:5,0 +17 147 . A <*> 0 . DP=14;DPR=14,0;I16=12,2,0,0,515,19213,0,0,778,44882,0,0,288,6576,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,18,150:6:0:0:6,0,0,0:6,0 0,9,99:3:0:0:2,1,0,0:3,0 0,15,140:5:0:0:4,1,0,0:5,0 +17 148 . C <*> 0 . DP=14;DPR=14,0;I16=12,2,0,0,541,21019,0,0,778,44882,0,0,286,6542,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,18,157:6:0:0:6,0,0,0:6,0 0,9,106:3:0:0:2,1,0,0:3,0 0,15,146:5:0:0:4,1,0,0:5,0 +17 149 . C <*> 0 . DP=14;DPR=14,0;I16=12,2,0,0,512,19326,0,0,778,44882,0,0,283,6471,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,18,148:6:0:0:6,0,0,0:6,0 0,9,109:3:0:0:2,1,0,0:3,0 0,15,140:5:0:0:4,1,0,0:5,0 +17 150 . T <*> 0 . DP=13;DPR=13,0;I16=11,2,0,0,511,20251,0,0,749,44041,0,0,280,6362,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,18,153:6:0:0:6,0,0,0:6,0 0,6,84:2:0:0:1,1,0,0:2,0 0,15,152:5:0:0:4,1,0,0:5,0 +17 151 . G <*> 0 . DP=13;DPR=13,0;I16=11,2,0,0,506,19826,0,0,749,44041,0,0,277,6263,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,18,157:6:0:0:6,0,0,0:6,0 0,6,84:2:0:0:1,1,0,0:2,0 0,15,144:5:0:0:4,1,0,0:5,0 +17 152 . C <*> 0 . DP=14;DPR=14,0;I16=12,2,0,0,543,21283,0,0,809,47641,0,0,274,6174,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,168:7:0:0:7,0,0,0:7,0 0,6,84:2:0:0:1,1,0,0:2,0 0,15,146:5:0:0:4,1,0,0:5,0 +17 153 . A <*> 0 . DP=14;DPR=14,0;I16=12,2,0,0,536,20594,0,0,809,47641,0,0,272,6096,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,156:7:0:0:7,0,0,0:7,0 0,6,81:2:0:0:1,1,0,0:2,0 0,15,153:5:0:0:4,1,0,0:5,0 +17 154 . T <*> 0 . DP=14;DPR=14,0;I16=12,2,0,0,523,20051,0,0,809,47641,0,0,270,6030,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,159:7:0:0:7,0,0,0:7,0 0,6,83:2:0:0:1,1,0,0:2,0 0,15,139:5:0:0:4,1,0,0:5,0 +17 155 . C <*> 0 . DP=14;DPR=14,0;I16=12,2,0,0,542,21254,0,0,809,47641,0,0,268,5976,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,172:7:0:0:7,0,0,0:7,0 0,6,85:2:0:0:1,1,0,0:2,0 0,15,139:5:0:0:4,1,0,0:5,0 +17 156 . C <*> 0 . DP=14;DPR=14,0;I16=12,2,0,0,536,20884,0,0,809,47641,0,0,266,5934,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,163:7:0:0:7,0,0,0:7,0 0,6,84:2:0:0:1,1,0,0:2,0 0,15,150:5:0:0:4,1,0,0:5,0 +17 157 . C <*> 0 . DP=14;DPR=14,0;I16=12,2,0,0,555,22081,0,0,809,47641,0,0,264,5904,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,169:7:0:0:7,0,0,0:7,0 0,6,85:2:0:0:1,1,0,0:2,0 0,15,149:5:0:0:4,1,0,0:5,0 +17 158 . T <*> 0 . DP=14;DPR=14,0;I16=12,2,0,0,568,23154,0,0,809,47641,0,0,262,5886,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,170:7:0:0:7,0,0,0:7,0 0,6,84:2:0:0:1,1,0,0:2,0 0,15,159:5:0:0:4,1,0,0:5,0 +17 159 . A <*> 0 . DP=15;DPR=14,0;I16=12,2,0,0,519,19467,0,0,809,47641,0,0,260,5880,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,157:7:0:0:7,0,0,0:7,0 0,6,83:2:0:0:1,1,0,0:2,0 0,15,135:5:0:0:4,1,0,0:5,0 +17 160 . G <*> 0 . DP=15;DPR=15,0;I16=13,2,0,0,547,20633,0,0,869,51241,0,0,259,5887,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,165:7:0:0:7,0,0,0:7,0 0,6,85:2:0:0:1,1,0,0:2,0 0,18,139:6:0:0:5,1,0,0:6,0 +17 161 . A <*> 0 . DP=15;DPR=15,0;I16=13,2,0,0,568,21610,0,0,869,51241,0,0,258,5908,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,157:7:0:0:7,0,0,0:7,0 0,6,83:2:0:0:1,1,0,0:2,0 0,18,162:6:0:0:5,1,0,0:6,0 +17 162 . A <*> 0 . DP=15;DPR=15,0;I16=13,2,0,0,557,21139,0,0,869,51241,0,0,255,5843,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,147:7:0:0:7,0,0,0:7,0 0,6,87:2:0:0:1,1,0,0:2,0 0,18,167:6:0:0:5,1,0,0:6,0 +17 163 . G <*> 0 . DP=14;DPR=14,0;I16=12,2,0,0,503,18645,0,0,809,47641,0,0,253,5791,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,153:7:0:0:7,0,0,0:7,0 0,6,79:2:0:0:1,1,0,0:2,0 0,15,138:5:0:0:4,1,0,0:5,0 +17 164 . T <*> 0 . DP=14;DPR=14,0;I16=12,2,0,0,460,15968,0,0,809,47641,0,0,252,5750,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,18,131:6:0:0:6,0,0,0:6,0 0,6,79:2:0:0:1,1,0,0:2,0 0,18,136:6:0:0:5,1,0,0:6,0 +17 165 . G <*> 0 . DP=14;DPR=12,0;I16=10,2,0,0,456,17460,0,0,689,40441,0,0,226,5094,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,18,149:6:0:0:6,0,0,0:6,0 0,6,80:2:0:0:1,1,0,0:2,0 0,12,122:4:0:0:3,1,0,0:4,0 +17 166 . A <*> 0 . DP=14;DPR=13,0;I16=11,2,0,0,496,19138,0,0,749,44041,0,0,227,5077,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,18,145:6:0:0:6,0,0,0:6,0 0,6,82:2:0:0:1,1,0,0:2,0 0,15,148:5:0:0:4,1,0,0:5,0 +17 167 . A <*> 0 . DP=14;DPR=13,0;I16=11,2,0,0,477,17851,0,0,749,44041,0,0,227,5071,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,18,132:6:0:0:6,0,0,0:6,0 0,6,86:2:0:0:1,1,0,0:2,0 0,15,147:5:0:0:4,1,0,0:5,0 +17 168 . G <*> 0 . DP=14;DPR=14,0;I16=12,2,0,0,481,18015,0,0,809,47641,0,0,252,5702,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,18,145:6:0:0:6,0,0,0:6,0 0,6,82:2:0:0:1,1,0,0:2,0 0,18,140:6:0:0:5,1,0,0:6,0 +17 169 . C <*> 0 . DP=13;DPR=12,0;I16=10,2,0,0,402,14224,0,0,689,40441,0,0,227,5045,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,15,106:5:0:0:5,0,0,0:5,0 0,6,76:2:0:0:1,1,0,0:2,0 0,15,145:5:0:0:4,1,0,0:5,0 +17 170 . C <*> 0 . DP=13;DPR=13,0;I16=11,2,0,0,447,16383,0,0,749,44041,0,0,251,5601,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,15,128:5:0:0:5,0,0,0:5,0 0,6,80:2:0:0:1,1,0,0:2,0 0,18,143:6:0:0:5,1,0,0:6,0 +17 171 . A <*> 0 . DP=13;DPR=13,0;I16=11,2,0,0,500,19366,0,0,749,44041,0,0,250,5546,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,15,134:5:0:0:5,0,0,0:5,0 0,6,81:2:0:0:1,1,0,0:2,0 0,18,166:6:0:0:5,1,0,0:6,0 +17 172 . C <*> 0 . DP=13;DPR=12,0;I16=10,2,0,0,439,16395,0,0,689,40441,0,0,241,5441,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,15,138:5:0:0:5,0,0,0:5,0 0,6,75:2:0:0:1,1,0,0:2,0 0,15,129:5:0:0:4,1,0,0:5,0 +17 173 . C <*> 0 . DP=13;DPR=13,0;I16=11,2,0,0,435,15225,0,0,749,44041,0,0,248,5478,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,15,121:5:0:0:5,0,0,0:5,0 0,6,76:2:0:0:1,1,0,0:2,0 0,18,146:6:0:0:5,1,0,0:6,0 +17 174 . G <*> 0 . DP=13;DPR=12,0;I16=11,1,0,0,351,10685,0,0,689,40441,0,0,238,5364,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,15,111:5:0:0:5,0,0,0:5,0 0,3,27:1:0:0:1,0,0,0:1,0 0,18,117:6:0:0:5,1,0,0:6,0 +17 175 . C <*> 0 . DP=14;DPR=14,0;I16=13,1,0,0,511,19161,0,0,809,47641,0,0,249,5463,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,18,143:6:0:0:6,0,0,0:6,0 0,3,41:1:0:0:1,0,0,0:1,0 0,21,175:7:0:0:6,1,0,0:7,0 +17 176 . C <*> 0 . DP=14;DPR=14,0;I16=13,1,0,0,489,17733,0,0,809,47641,0,0,251,5477,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,18,146:6:0:0:6,0,0,0:6,0 0,3,44:1:0:0:1,0,0,0:1,0 0,21,152:7:0:0:6,1,0,0:7,0 +17 177 . C <*> 0 . DP=14;DPR=14,0;I16=13,1,0,0,488,17328,0,0,809,47641,0,0,253,5507,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,18,138:6:0:0:6,0,0,0:6,0 0,3,44:1:0:0:1,0,0,0:1,0 0,21,158:7:0:0:6,1,0,0:7,0 +17 178 . A <*> 0 . DP=14;DPR=14,0;I16=13,1,0,0,519,19485,0,0,809,47641,0,0,254,5502,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,18,147:6:0:0:6,0,0,0:6,0 0,3,42:1:0:0:1,0,0,0:1,0 0,21,172:7:0:0:6,1,0,0:7,0 +17 179 . A <*> 0 . DP=14;DPR=14,0;I16=13,1,0,0,478,17278,0,0,809,47641,0,0,255,5511,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,18,134:6:0:0:6,0,0,0:6,0 0,3,44:1:0:0:1,0,0,0:1,0 0,21,170:7:0:0:6,1,0,0:7,0 +17 180 . A <*> 0 . DP=14;DPR=13,0;I16=12,1,0,0,425,14653,0,0,749,44041,0,0,250,5498,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,18,126:6:0:0:6,0,0,0:6,0 0,3,43:1:0:0:1,0,0,0:1,0 0,18,148:6:0:0:5,1,0,0:6,0 +17 181 . G <*> 0 . DP=14;DPR=12,0;I16=11,1,0,0,450,17152,0,0,689,40441,0,0,233,5233,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,18,156:6:0:0:6,0,0,0:6,0 0,3,41:1:0:0:1,0,0,0:1,0 0,15,138:5:0:0:4,1,0,0:5,0 +17 182 . A <*> 0 . DP=15;DPR=15,0;I16=14,1,0,0,515,18235,0,0,869,51241,0,0,258,5622,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,150:7:0:0:7,0,0,0:7,0 0,3,43:1:0:0:1,0,0,0:1,0 0,21,159:7:0:0:6,1,0,0:7,0 +17 183 . C <*> 0 . DP=15;DPR=14,0;I16=13,1,0,0,483,17419,0,0,809,47641,0,0,235,5063,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,159:7:0:0:7,0,0,0:7,0 0,3,40:1:0:0:1,0,0,0:1,0 0,18,139:6:0:0:5,1,0,0:6,0 +17 184 . A <*> 0 . DP=15;DPR=15,0;I16=14,1,0,0,535,19667,0,0,869,51241,0,0,262,5770,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,158:7:0:0:7,0,0,0:7,0 0,3,41:1:0:0:1,0,0,0:1,0 0,21,163:7:0:0:6,1,0,0:7,0 +17 185 . C <*> 0 . DP=15;DPR=14,0;I16=13,1,0,0,487,17295,0,0,809,47641,0,0,238,5192,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,150:7:0:0:7,0,0,0:7,0 0,3,38:1:0:0:1,0,0,0:1,0 0,18,160:6:0:0:5,1,0,0:6,0 +17 186 . G <*> 0 . DP=15;DPR=13,0;I16=12,1,0,0,381,11429,0,0,749,44041,0,0,239,5253,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,18,117:6:0:0:6,0,0,0:6,0 0,3,32:1:0:0:1,0,0,0:1,0 0,18,124:6:0:0:5,1,0,0:6,0 +17 187 . C <*> 0 . DP=14;DPR=14,0;I16=13,1,0,0,511,18979,0,0,809,47641,0,0,266,5952,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,18,147:6:0:0:6,0,0,0:6,0 0,3,38:1:0:0:1,0,0,0:1,0 0,21,172:7:0:0:6,1,0,0:7,0 +17 188 . C <*> 0 . DP=14;DPR=14,0;I16=13,1,0,0,496,18042,0,0,809,47641,0,0,267,5989,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,18,147:6:0:0:6,0,0,0:6,0 0,3,37:1:0:0:1,0,0,0:1,0 0,21,162:7:0:0:6,1,0,0:7,0 +17 189 . C <*> 0 . DP=15;DPR=15,0;I16=13,2,0,0,552,20504,0,0,838,48482,0,0,268,6040,0,0;QS=3,0;MQSB=0;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,18,152:6:0:0:6,0,0,0:6,0 0,6,67:2:0:0:1,1,0,0:2,0 0,21,167:7:0:0:6,1,0,0:7,0 +17 190 . A <*> 0 . DP=15;DPR=14,0;I16=12,2,0,0,500,18230,0,0,778,44882,0,0,243,5381,0,0;QS=3,0;MQSB=0;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,18,138:6:0:0:6,0,0,0:6,0 0,6,68:2:0:0:1,1,0,0:2,0 0,18,159:6:0:0:5,1,0,0:6,0 +17 191 . T <*> 0 . DP=15;DPR=15,0;I16=13,2,0,0,534,19276,0,0,838,48482,0,0,267,5939,0,0;QS=3,0;MQSB=0;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,18,143:6:0:0:6,0,0,0:6,0 0,6,67:2:0:0:1,1,0,0:2,0 0,21,169:7:0:0:6,1,0,0:7,0 +17 192 . G <*> 0 . DP=15;DPR=15,0;I16=13,2,0,0,499,17439,0,0,838,48482,0,0,266,5890,0,0;QS=3,0;MQSB=0;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,18,143:6:0:0:6,0,0,0:6,0 0,6,67:2:0:0:1,1,0,0:2,0 0,21,151:7:0:0:6,1,0,0:7,0 +17 193 . T <*> 0 . DP=15;DPR=15,0;I16=13,2,0,0,505,17811,0,0,838,48482,0,0,265,5859,0,0;QS=3,0;MQSB=0;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,18,140:6:0:0:6,0,0,0:6,0 0,6,63:2:0:0:1,1,0,0:2,0 0,21,157:7:0:0:6,1,0,0:7,0 +17 194 . C <*> 0 . DP=14;DPR=14,0;I16=12,2,0,0,467,16569,0,0,778,44882,0,0,265,5845,0,0;QS=3,0;MQSB=0;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,18,142:6:0:0:6,0,0,0:6,0 0,6,67:2:0:0:1,1,0,0:2,0 0,18,145:6:0:0:5,1,0,0:6,0 +17 195 . C <*> 0 . DP=14;DPR=14,0;I16=11,3,0,0,503,18647,0,0,747,42123,0,0,266,5846,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,18,159:6:0:0:5,1,0,0:6,0 0,6,71:2:0:0:1,1,0,0:2,0 0,18,160:6:0:0:5,1,0,0:6,0 +17 196 . A <*> 0 . DP=14;DPR=14,0;I16=11,3,0,0,482,17400,0,0,747,42123,0,0,268,5862,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,18,166:6:0:0:5,1,0,0:6,0 0,6,69:2:0:0:1,1,0,0:2,0 0,18,138:6:0:0:5,1,0,0:6,0 +17 197 . G <*> 0 . DP=14;DPR=14,0;I16=11,3,0,0,481,17391,0,0,747,42123,0,0,270,5894,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,18,164:6:0:0:5,1,0,0:6,0 0,6,68:2:0:0:1,1,0,0:2,0 0,18,134:6:0:0:5,1,0,0:6,0 +17 198 . C <*> 0 . DP=14;DPR=14,0;I16=11,3,0,0,539,20957,0,0,747,42123,0,0,271,5893,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,18,172:6:0:0:5,1,0,0:6,0 0,6,70:2:0:0:1,1,0,0:2,0 0,18,164:6:0:0:5,1,0,0:6,0 +17 199 . T <*> 0 . DP=14;DPR=14,0;I16=11,3,0,0,505,19197,0,0,747,42123,0,0,271,5861,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,18,162:6:0:0:5,1,0,0:6,0 0,6,73:2:0:0:1,1,0,0:2,0 0,18,154:6:0:0:5,1,0,0:6,0 +17 200 . T <*> 0 . DP=15;DPR=15,0;I16=11,4,0,0,544,19918,0,0,776,42964,0,0,270,5798,0,0;QS=3,0;MQSB=0.0161635;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,18,161:6:0:0:5,1,0,0:6,0 0,9,89:3:0:0:1,2,0,0:3,0 0,18,154:6:0:0:5,1,0,0:6,0 +17 201 . A <*> 0 . DP=16;DPR=16,0;I16=12,4,0,0,568,20416,0,0,836,46564,0,0,269,5703,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,171:7:0:0:6,1,0,0:7,0 0,9,89:3:0:0:1,2,0,0:3,0 0,18,157:6:0:0:5,1,0,0:6,0 +17 202 . A <*> 0 . DP=16;DPR=16,0;I16=12,4,0,0,566,20590,0,0,836,46564,0,0,269,5627,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,178:7:0:0:6,1,0,0:7,0 0,9,84:3:0:0:1,2,0,0:3,0 0,18,163:6:0:0:5,1,0,0:6,0 +17 203 . C <*> 0 . DP=16;DPR=16,0;I16=12,4,0,0,557,20119,0,0,836,46564,0,0,269,5571,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,166:7:0:0:6,1,0,0:7,0 0,9,90:3:0:0:1,2,0,0:3,0 0,18,153:6:0:0:5,1,0,0:6,0 +17 204 . C <*> 0 . DP=16;DPR=16,0;I16=12,4,0,0,591,22379,0,0,836,46564,0,0,269,5535,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,173:7:0:0:6,1,0,0:7,0 0,9,91:3:0:0:1,2,0,0:3,0 0,18,163:6:0:0:5,1,0,0:6,0 +17 205 . T <*> 0 . DP=16;DPR=16,0;I16=12,4,0,0,635,25281,0,0,836,46564,0,0,269,5519,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,188:7:0:0:6,1,0,0:7,0 0,9,95:3:0:0:1,2,0,0:3,0 0,18,173:6:0:0:5,1,0,0:6,0 +17 206 . G <*> 0 . DP=16;DPR=16,0;I16=12,4,0,0,577,21337,0,0,836,46564,0,0,269,5523,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,180:7:0:0:6,1,0,0:7,0 0,9,89:3:0:0:1,2,0,0:3,0 0,18,143:6:0:0:5,1,0,0:6,0 +17 207 . C <*> 0 . DP=16;DPR=16,0;I16=12,4,0,0,574,21076,0,0,836,46564,0,0,269,5547,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,179:7:0:0:6,1,0,0:7,0 0,9,93:3:0:0:1,2,0,0:3,0 0,18,151:6:0:0:5,1,0,0:6,0 +17 208 . A <*> 0 . DP=16;DPR=16,0;I16=12,4,0,0,576,21486,0,0,836,46564,0,0,268,5540,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,184:7:0:0:6,1,0,0:7,0 0,9,93:3:0:0:1,2,0,0:3,0 0,18,154:6:0:0:5,1,0,0:6,0 +17 209 . T <*> 0 . DP=16;DPR=16,0;I16=12,4,0,0,567,20475,0,0,836,46564,0,0,267,5551,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,173:7:0:0:6,1,0,0:7,0 0,9,91:3:0:0:1,2,0,0:3,0 0,18,146:6:0:0:5,1,0,0:6,0 +17 210 . C <*> 0 . DP=16;DPR=16,0;I16=12,4,0,0,577,21109,0,0,836,46564,0,0,266,5580,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,185:7:0:0:6,1,0,0:7,0 0,9,92:3:0:0:1,2,0,0:3,0 0,18,151:6:0:0:5,1,0,0:6,0 +17 211 . C <*> 0 . DP=16;DPR=16,0;I16=12,4,0,0,563,20227,0,0,836,46564,0,0,265,5627,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,172:7:0:0:6,1,0,0:7,0 0,9,92:3:0:0:1,2,0,0:3,0 0,18,153:6:0:0:5,1,0,0:6,0 +17 212 . C <*> 0 . DP=16;DPR=16,0;I16=12,4,0,0,589,22179,0,0,836,46564,0,0,263,5643,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,181:7:0:0:6,1,0,0:7,0 0,9,92:3:0:0:1,2,0,0:3,0 0,18,152:6:0:0:5,1,0,0:6,0 +17 213 . T <*> 0 . DP=16;DPR=16,0;I16=12,4,0,0,598,22838,0,0,836,46564,0,0,262,5678,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,181:7:0:0:6,1,0,0:7,0 0,9,95:3:0:0:1,2,0,0:3,0 0,18,165:6:0:0:5,1,0,0:6,0 +17 214 . A <*> 0 . DP=16;DPR=15,0;I16=11,4,0,0,529,19401,0,0,776,42964,0,0,240,5248,0,0;QS=3,0;MQSB=0.0161635;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,176:7:0:0:6,1,0,0:7,0 0,9,92:3:0:0:1,2,0,0:3,0 0,15,118:5:0:0:4,1,0,0:5,0 +17 215 . G <*> 0 . DP=15;DPR=15,0;I16=12,3,0,0,521,19073,0,0,807,45723,0,0,262,5754,0,0;QS=3,0;MQSB=0.0342181;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,185:7:0:0:6,1,0,0:7,0 0,9,90:3:0:0:1,2,0,0:3,0 0,15,105:5:0:0:5,0,0,0:5,0 +17 216 . A <*> 0 . DP=14;DPR=13,0;I16=10,3,0,0,464,16900,0,0,687,38523,0,0,238,5166,0,0;QS=3,0;MQSB=0.040184;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,173:7:0:0:6,1,0,0:7,0 0,9,92:3:0:0:1,2,0,0:3,0 0,9,81:3:0:0:3,0,0,0:3,0 +17 217 . A <*> 0 . DP=14;DPR=14,0;I16=11,3,0,0,515,19433,0,0,747,42123,0,0,264,5842,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,181:7:0:0:6,1,0,0:7,0 0,9,90:3:0:0:1,2,0,0:3,0 0,12,97:4:0:0:4,0,0,0:4,0 +17 218 . G <*> 0 . DP=14;DPR=14,0;I16=11,3,0,0,507,18957,0,0,747,42123,0,0,265,5907,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,178:7:0:0:6,1,0,0:7,0 0,9,90:3:0:0:1,2,0,0:3,0 0,12,110:4:0:0:4,0,0,0:4,0 +17 219 . T <*> 0 . DP=14;DPR=14,0;I16=11,3,0,0,470,16286,0,0,747,42123,0,0,266,5986,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,173:7:0:0:6,1,0,0:7,0 0,9,88:3:0:0:1,2,0,0:3,0 0,12,89:4:0:0:4,0,0,0:4,0 +17 220 . G <*> 0 . DP=14;DPR=13,0;I16=10,3,0,0,485,18307,0,0,687,38523,0,0,242,5454,0,0;QS=3,0;MQSB=0.040184;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,188:7:0:0:6,1,0,0:7,0 0,9,88:3:0:0:1,2,0,0:3,0 0,9,80:3:0:0:3,0,0,0:3,0 +17 221 . A <*> 0 . DP=14;DPR=14,0;I16=11,3,0,0,487,17615,0,0,747,42123,0,0,267,6135,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,176:7:0:0:6,1,0,0:7,0 0,9,88:3:0:0:1,2,0,0:3,0 0,12,101:4:0:0:4,0,0,0:4,0 +17 222 . A <*> 0 . DP=14;DPR=13,0;I16=10,3,0,0,465,17367,0,0,687,38523,0,0,242,5578,0,0;QS=3,0;MQSB=0.040184;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,186:7:0:0:6,1,0,0:7,0 0,9,85:3:0:0:1,2,0,0:3,0 0,9,69:3:0:0:3,0,0,0:3,0 +17 223 . G <*> 0 . DP=13;DPR=12,0;I16=9,3,0,0,405,14327,0,0,627,34923,0,0,243,5657,0,0;QS=3,0;MQSB=0.0443614;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,18,168:6:0:0:5,1,0,0:6,0 0,6,53:2:0:0:0,2,0,0:2,0 0,12,81:4:0:0:4,0,0,0:4,0 +17 224 . G <*> 0 . DP=12;DPR=12,0;I16=9,3,0,0,379,12759,0,0,627,34923,0,0,270,6370,0,0;QS=3,0;MQSB=0.0443614;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,18,168:6:0:0:5,1,0,0:6,0 0,6,50:2:0:0:0,2,0,0:2,0 0,12,70:4:0:0:4,0,0,0:4,0 +17 225 . C <*> 0 . DP=12;DPR=11,0;I16=8,3,0,0,382,13896,0,0,567,31323,0,0,261,6345,0,0;QS=3,0;MQSB=0.0497871;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,18,165:6:0:0:5,1,0,0:6,0 0,6,48:2:0:0:0,2,0,0:2,0 0,9,83:3:0:0:3,0,0,0:3,0 +17 226 . A <*> 0 . DP=13;DPR=11,0;I16=8,3,0,0,381,13669,0,0,567,31323,0,0,248,5894,0,0;QS=3,0;MQSB=0.0497871;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,18,166:6:0:0:5,1,0,0:6,0 0,6,53:2:0:0:0,2,0,0:2,0 0,9,84:3:0:0:3,0,0,0:3,0 +17 227 . C <*> 0 . DP=13;DPR=12,0;I16=8,4,0,0,406,14306,0,0,596,32164,0,0,267,6253,0,0;QS=3,0;MQSB=0.0249144;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,190:7:0:0:5,2,0,0:7,0 0,6,53:2:0:0:0,2,0,0:2,0 0,9,73:3:0:0:3,0,0,0:3,0 +17 228 . C <*> 0 . DP=13;DPR=13,0;I16=9,4,0,0,417,14381,0,0,656,35764,0,0,292,6884,0,0;QS=3,0;MQSB=0.0211283;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,187:7:0:0:5,2,0,0:7,0 0,6,45:2:0:0:0,2,0,0:2,0 0,12,96:4:0:0:4,0,0,0:4,0 +17 229 . G <*> 0 . DP=13;DPR=12,0;I16=9,3,0,0,358,11424,0,0,627,34923,0,0,270,6414,0,0;QS=3,0;MQSB=0.0443614;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,18,136:6:0:0:5,1,0,0:6,0 0,6,53:2:0:0:0,2,0,0:2,0 0,12,70:4:0:0:4,0,0,0:4,0 +17 230 . C <*> 0 . DP=13;DPR=13,0;I16=9,4,0,0,461,16861,0,0,656,35764,0,0,292,6920,0,0;QS=3,0;MQSB=0.0211283;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,186:7:0:0:5,2,0,0:7,0 0,6,53:2:0:0:0,2,0,0:2,0 0,12,100:4:0:0:4,0,0,0:4,0 +17 231 . C <*> 0 . DP=13;DPR=11,0;I16=7,4,0,0,414,15832,0,0,536,28564,0,0,247,5925,0,0;QS=3,0;MQSB=0.0401934;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,18,184:6:0:0:4,2,0,0:6,0 0,6,53:2:0:0:0,2,0,0:2,0 0,9,82:3:0:0:3,0,0,0:3,0 +17 232 . C <*> 0 . DP=14;DPR=13,0;I16=9,4,0,0,471,17371,0,0,656,35764,0,0,267,6363,0,0;QS=3,0;MQSB=0.0211283;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,198:7:0:0:5,2,0,0:7,0 0,6,53:2:0:0:0,2,0,0:2,0 0,12,101:4:0:0:4,0,0,0:4,0 +17 233 . A <*> 0 . DP=14;DPR=14,0;I16=10,4,0,0,496,18142,0,0,716,39364,0,0,292,6984,0,0;QS=3,0;MQSB=0.0183156;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,192:7:0:0:5,2,0,0:7,0 0,6,53:2:0:0:0,2,0,0:2,0 0,15,119:5:0:0:5,0,0,0:5,0 +17 234 . A <*> 0 . DP=14;DPR=14,0;I16=10,4,0,0,502,18390,0,0,716,39364,0,0,292,6988,0,0;QS=3,0;MQSB=0.0183156;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,185:7:0:0:5,2,0,0:7,0 0,6,53:2:0:0:0,2,0,0:2,0 0,15,123:5:0:0:5,0,0,0:5,0 +17 235 . A <*> 0 . DP=14;DPR=13,0;I16=9,4,0,0,476,17652,0,0,656,35764,0,0,267,6375,0,0;QS=3,0;MQSB=0.0211283;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,21,186:7:0:0:5,2,0,0:7,0 0,6,53:2:0:0:0,2,0,0:2,0 0,12,111:4:0:0:4,0,0,0:4,0 +17 236 . G <*> 0 . DP=15;DPR=15,0;I16=11,4,0,0,501,17481,0,0,776,42964,0,0,290,6924,0,0;QS=3,0;MQSB=0.0161635;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,24,206:8:0:0:6,2,0,0:8,0 0,6,53:2:0:0:0,2,0,0:2,0 0,15,103:5:0:0:5,0,0,0:5,0 +17 237 . A <*> 0 . DP=14;DPR=13,0;I16=9,4,0,0,465,16877,0,0,656,35764,0,0,266,6282,0,0;QS=3,0;MQSB=0.0211283;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,24,206:8:0:0:6,2,0,0:8,0 0,6,53:2:0:0:0,2,0,0:2,0 0,9,92:3:0:0:3,0,0,0:3,0 +17 238 . C <*> 0 . DP=14;DPR=14,0;I16=10,4,0,0,482,17238,0,0,716,39364,0,0,292,6900,0,0;QS=3,0;MQSB=0.0183156;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,24,211:8:0:0:6,2,0,0:8,0 0,6,53:2:0:0:0,2,0,0:2,0 0,12,82:4:0:0:4,0,0,0:4,0 +17 239 . A <*> 0 . DP=15;DPR=15,0;I16=10,5,0,0,525,19155,0,0,776,42964,0,0,292,6852,0,0;QS=3,0;MQSB=0.0497871;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,27,223:9:0:0:6,3,0,0:9,0 0,6,50:2:0:0:0,2,0,0:2,0 0,12,108:4:0:0:4,0,0,0:4,0 +17 240 . C <*> 0 . DP=15;DPR=15,0;I16=10,5,0,0,512,17930,0,0,776,42964,0,0,292,6764,0,0;QS=3,0;MQSB=0.0497871;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,27,220:9:0:0:6,3,0,0:9,0 0,6,53:2:0:0:0,2,0,0:2,0 0,12,106:4:0:0:4,0,0,0:4,0 +17 241 . G <*> 0 . DP=15;DPR=14,0;I16=9,5,0,0,444,14636,0,0,716,39364,0,0,269,6159,0,0;QS=3,0;MQSB=0.0561348;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,27,203:9:0:0:6,3,0,0:9,0 0,6,53:2:0:0:0,2,0,0:2,0 0,9,59:3:0:0:3,0,0,0:3,0 +17 242 . C <*> 0 . DP=15;DPR=15,0;I16=10,5,0,0,555,21177,0,0,776,42964,0,0,292,6624,0,0;QS=3,0;MQSB=0.0497871;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,27,242:9:0:0:6,3,0,0:9,0 0,6,53:2:0:0:0,2,0,0:2,0 0,12,94:4:0:0:4,0,0,0:4,0 +17 243 . C <*> 0 . DP=16;DPR=14,0;I16=9,5,0,0,523,19737,0,0,716,39364,0,0,284,6508,0,0;QS=3,0;MQSB=0.0561348;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,24,220:8:0:0:5,3,0,0:8,0 0,6,53:2:0:0:0,2,0,0:2,0 0,12,104:4:0:0:4,0,0,0:4,0 +17 244 . C <*> 0 . DP=16;DPR=16,0;I16=10,6,0,0,620,24272,0,0,805,43805,0,0,298,6568,0,0;QS=3,0;MQSB=0.0253122;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,27,245:9:0:0:6,3,0,0:9,0 0,9,72:3:0:0:0,3,0,0:3,0 0,12,106:4:0:0:4,0,0,0:4,0 +17 245 . A <*> 0 . DP=17;DPR=17,0;I16=10,7,0,0,649,24843,0,0,865,47405,0,0,299,6553,0,0;QS=3,0;MQSB=0.0509867;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,27,236:9:0:0:6,3,0,0:9,0 0,12,93:4:0:0:0,4,0,0:4,0 0,12,115:4:0:0:4,0,0,0:4,0 +17 246 . T <*> 0 . DP=18;DPR=18,0;I16=10,8,0,0,649,23833,0,0,894,48246,0,0,301,6553,0,0;QS=3,0;MQSB=0.0286491;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,30,247:10:0:0:6,4,0,0:10,0 0,12,94:4:0:0:0,4,0,0:4,0 0,12,98:4:0:0:4,0,0,0:4,0 +17 247 . G <*> 0 . DP=18;DPR=18,0;I16=10,8,0,0,642,23610,0,0,894,48246,0,0,304,6570,0,0;QS=3,0;MQSB=0.0286491;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,30,252:10:0:0:6,4,0,0:10,0 0,12,83:4:0:0:0,4,0,0:4,0 0,12,103:4:0:0:4,0,0,0:4,0 +17 248 . T <*> 0 . DP=18;DPR=18,0;I16=10,8,0,0,636,22944,0,0,894,48246,0,0,307,6605,0,0;QS=3,0;MQSB=0.0286491;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,30,234:10:0:0:6,4,0,0:10,0 0,12,86:4:0:0:0,4,0,0:4,0 0,12,114:4:0:0:4,0,0,0:4,0 +17 249 . C <*> 0 . DP=18;DPR=18,0;I16=10,8,0,0,656,24846,0,0,894,48246,0,0,310,6658,0,0;QS=3,0;MQSB=0.0286491;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,30,253:10:0:0:6,4,0,0:10,0 0,12,79:4:0:0:0,4,0,0:4,0 0,12,112:4:0:0:4,0,0,0:4,0 +17 250 . C <*> 0 . DP=19;DPR=19,0;I16=10,9,0,0,694,26160,0,0,923,49087,0,0,311,6631,0,0;QS=3,0;MQSB=0.0168512;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,30,248:10:0:0:6,4,0,0:10,0 0,12,89:4:0:0:0,4,0,0:4,0 0,15,142:5:0:0:4,1,0,0:5,0 +17 251 . A <*> 0 . DP=19;DPR=18,0;I16=9,9,0,0,688,26506,0,0,863,45487,0,0,313,6627,0,0;QS=3,0;MQSB=0.0208913;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,27,233:9:0:0:5,4,0,0:9,0 0,12,97:4:0:0:0,4,0,0:4,0 0,15,148:5:0:0:4,1,0,0:5,0 +17 252 . G <*> 0 . DP=18;DPR=17,0;I16=8,9,0,0,641,24631,0,0,803,41887,0,0,304,6502,0,0;QS=3,0;MQSB=0.026526;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,27,243:9:0:0:5,4,0,0:9,0 0,12,91:4:0:0:0,4,0,0:4,0 0,12,121:4:0:0:3,1,0,0:4,0 +17 253 . C <*> 0 . DP=19;DPR=19,0;I16=9,10,0,0,705,26921,0,0,892,46328,0,0,319,6687,0,0;QS=3,0;MQSB=0.0132999;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,27,247:9:0:0:5,4,0,0:9,0 0,12,86:4:0:0:0,4,0,0:4,0 0,18,155:6:0:0:4,2,0,0:6,0 +17 254 . T <*> 0 . DP=20;DPR=19,0;I16=10,9,0,0,719,27517,0,0,892,46328,0,0,314,6670,0,0;QS=3,0;MQSB=0.00482795;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,30,254:10:0:0:6,4,0,0:10,0 0,9,72:3:0:0:0,3,0,0:3,0 0,18,164:6:0:0:4,2,0,0:6,0 +17 255 . T <*> 0 . DP=21;DPR=21,0;I16=11,10,0,0,750,27076,0,0,1012,53528,0,0,328,6840,0,0;QS=3,0;MQSB=0.00822975;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,241:11:0:0:7,4,0,0:11,0 0,12,95:4:0:0:0,4,0,0:4,0 0,18,161:6:0:0:4,2,0,0:6,0 +17 256 . A <*> 0 . DP=22;DPR=22,0;I16=11,11,0,0,811,30063,0,0,1049,54897,0,0,334,6956,0,0;QS=3,0;MQSB=0.00507916;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:7,4,0,0:11,0 0,15,110:5:0:0:0,5,0,0:5,0 0,18,166:6:0:0:4,2,0,0:6,0 +17 257 . T <*> 0 . DP=22;DPR=22,0;I16=11,11,0,0,814,30420,0,0,1049,54897,0,0,341,7101,0,0;QS=3,0;MQSB=0.00507916;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,247:11:0:0:7,4,0,0:11,0 0,15,113:5:0:0:0,5,0,0:5,0 0,18,168:6:0:0:4,2,0,0:6,0 +17 258 . T <*> 0 . DP=22;DPR=22,0;I16=11,11,0,0,791,28943,0,0,1049,54897,0,0,347,7225,0,0;QS=3,0;MQSB=0.00507916;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,254:11:0:0:7,4,0,0:11,0 0,15,116:5:0:0:0,5,0,0:5,0 0,18,155:6:0:0:4,2,0,0:6,0 +17 259 . C <*> 0 . DP=22;DPR=21,0;I16=11,10,0,0,785,29809,0,0,1020,54056,0,0,332,6936,0,0;QS=3,0;MQSB=0.00822975;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:7,4,0,0:11,0 0,12,90:4:0:0:0,4,0,0:4,0 0,18,170:6:0:0:4,2,0,0:6,0 +17 260 . T <*> 0 . DP=21;DPR=21,0;I16=10,11,0,0,829,32899,0,0,989,51297,0,0,360,7556,0,0;QS=3,0;MQSB=0.00660016;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:7,4,0,0:11,0 0,15,118:5:0:0:0,5,0,0:5,0 0,15,156:5:0:0:3,2,0,0:5,0 +17 261 . G <*> 0 . DP=21;DPR=21,0;I16=10,11,0,0,735,27379,0,0,989,51297,0,0,367,7761,0,0;QS=3,0;MQSB=0.00660016;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,254:11:0:0:7,4,0,0:11,0 0,15,111:5:0:0:0,5,0,0:5,0 0,15,122:5:0:0:3,2,0,0:5,0 +17 262 . C <*> 0 . DP=22;DPR=22,0;I16=10,12,0,0,806,30278,0,0,1049,54897,0,0,373,7941,0,0;QS=3,0;MQSB=0.0122507;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:7,4,0,0:11,0 0,15,99:5:0:0:0,5,0,0:5,0 0,18,164:6:0:0:3,3,0,0:6,0 +17 263 . C <*> 0 . DP=22;DPR=22,0;I16=10,12,0,0,799,29717,0,0,1049,54897,0,0,380,8146,0,0;QS=3,0;MQSB=0.0122507;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:7,4,0,0:11,0 0,15,98:5:0:0:0,5,0,0:5,0 0,18,168:6:0:0:3,3,0,0:6,0 +17 264 . C <*> 0 . DP=22;DPR=22,0;I16=10,12,0,0,821,31325,0,0,1049,54897,0,0,386,8326,0,0;QS=3,0;MQSB=0.0122507;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:7,4,0,0:11,0 0,15,104:5:0:0:0,5,0,0:5,0 0,18,172:6:0:0:3,3,0,0:6,0 +17 265 . A <*> 0 . DP=21;DPR=21,0;I16=9,12,0,0,800,31906,0,0,989,51297,0,0,390,8380,0,0;QS=3,0;MQSB=0.0158903;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:7,4,0,0:11,0 0,15,114:5:0:0:0,5,0,0:5,0 0,15,129:5:0:0:2,3,0,0:5,0 +17 266 . G <*> 0 . DP=21;DPR=20,0;I16=9,11,0,0,747,28155,0,0,960,50456,0,0,369,7833,0,0;QS=3,0;MQSB=0.0237479;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:7,4,0,0:11,0 0,12,97:4:0:0:0,4,0,0:4,0 0,15,138:5:0:0:2,3,0,0:5,0 +17 267 . T <*> 0 . DP=21;DPR=20,0;I16=9,11,0,0,739,27465,0,0,960,50456,0,0,373,7935,0,0;QS=3,0;MQSB=0.0237479;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,254:11:0:0:7,4,0,0:11,0 0,12,101:4:0:0:0,4,0,0:4,0 0,15,149:5:0:0:2,3,0,0:5,0 +17 268 . T <*> 0 . DP=21;DPR=21,0;I16=9,12,0,0,748,27708,0,0,989,51297,0,0,402,8686,0,0;QS=3,0;MQSB=0.0158903;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,238:11:0:0:7,4,0,0:11,0 0,15,110:5:0:0:0,5,0,0:5,0 0,15,156:5:0:0:2,3,0,0:5,0 +17 269 . C <*> 0 . DP=22;DPR=21,0;I16=9,12,0,0,764,28632,0,0,989,51297,0,0,381,8211,0,0;QS=3,0;MQSB=0.0158903;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,36,255:12:0:0:7,5,0,0:12,0 0,12,91:4:0:0:0,4,0,0:4,0 0,15,154:5:0:0:2,3,0,0:5,0 +17 270 . C <*> 0 . DP=22;DPR=21,0;I16=9,12,0,0,758,28146,0,0,989,51297,0,0,385,8337,0,0;QS=3,0;MQSB=0.0158903;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,36,255:12:0:0:7,5,0,0:12,0 0,12,96:4:0:0:0,4,0,0:4,0 0,15,143:5:0:0:2,3,0,0:5,0 +17 271 . T <*> 0 . DP=22;DPR=22,0;I16=9,13,0,0,847,32935,0,0,1018,52138,0,0,413,9065,0,0;QS=3,0;MQSB=0.0109431;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,36,255:12:0:0:7,5,0,0:12,0 0,15,113:5:0:0:0,5,0,0:5,0 0,15,152:5:0:0:2,3,0,0:5,0 +17 272 . C <*> 0 . DP=22;DPR=21,0;I16=9,12,0,0,809,31413,0,0,989,51297,0,0,390,8518,0,0;QS=3,0;MQSB=0.0158903;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,36,255:12:0:0:7,5,0,0:12,0 0,12,96:4:0:0:0,4,0,0:4,0 0,15,149:5:0:0:2,3,0,0:5,0 +17 273 . T <*> 0 . DP=22;DPR=21,0;I16=9,12,0,0,798,30664,0,0,989,51297,0,0,392,8620,0,0;QS=3,0;MQSB=0.0158903;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,36,255:12:0:0:7,5,0,0:12,0 0,12,95:4:0:0:0,4,0,0:4,0 0,15,161:5:0:0:2,3,0,0:5,0 +17 274 . C <*> 0 . DP=22;DPR=21,0;I16=9,12,0,0,763,28177,0,0,989,51297,0,0,394,8746,0,0;QS=3,0;MQSB=0.0158903;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,36,255:12:0:0:7,5,0,0:12,0 0,12,101:4:0:0:0,4,0,0:4,0 0,15,144:5:0:0:2,3,0,0:5,0 +17 275 . C <*> 0 . DP=20;DPR=20,0;I16=7,13,0,0,768,29994,0,0,898,44938,0,0,423,9519,0,0;QS=3,0;MQSB=0.0213617;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:6,5,0,0:11,0 0,15,114:5:0:0:0,5,0,0:5,0 0,12,122:4:0:0:1,3,0,0:4,0 +17 276 . A <*> 0 . DP=20;DPR=20,0;I16=7,13,0,0,805,32931,0,0,898,44938,0,0,424,9538,0,0;QS=3,0;MQSB=0.0213617;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,253:11:0:0:6,5,0,0:11,0 0,15,122:5:0:0:0,5,0,0:5,0 0,12,124:4:0:0:1,3,0,0:4,0 +17 277 . G <*> 0 . DP=20;DPR=20,0;I16=7,13,0,0,764,29732,0,0,898,44938,0,0,425,9579,0,0;QS=3,0;MQSB=0.0213617;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:6,5,0,0:11,0 0,15,114:5:0:0:0,5,0,0:5,0 0,12,121:4:0:0:1,3,0,0:4,0 +17 278 . A <*> 0 . DP=21;DPR=20,0;I16=6,14,0,0,722,26452,0,0,867,42179,0,0,415,9521,0,0;QS=3,0;MQSB=0.0246228;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,30,238:10:0:0:5,5,0,0:10,0 0,18,123:6:0:0:0,6,0,0:6,0 0,12,121:4:0:0:1,3,0,0:4,0 +17 279 . A <*> 0 . DP=22;DPR=22,0;I16=7,15,0,0,786,28694,0,0,956,46620,0,0,427,9677,0,0;QS=3,0;MQSB=0.0124927;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,36,255:12:0:0:6,6,0,0:12,0 0,18,123:6:0:0:0,6,0,0:6,0 0,12,122:4:0:0:1,3,0,0:4,0 +17 280 . A <*> 0 . DP=22;DPR=22,0;I16=7,15,0,0,815,31561,0,0,956,46620,0,0,428,9684,0,0;QS=3,0;MQSB=0.0124927;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,36,253:12:0:0:6,6,0,0:12,0 0,18,130:6:0:0:0,6,0,0:6,0 0,12,129:4:0:0:1,3,0,0:4,0 +17 281 . G <*> 0 . DP=22;DPR=22,0;I16=7,15,0,0,820,31416,0,0,956,46620,0,0,428,9662,0,0;QS=3,0;MQSB=0.0124927;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,36,255:12:0:0:6,6,0,0:12,0 0,18,122:6:0:0:0,6,0,0:6,0 0,12,123:4:0:0:1,3,0,0:4,0 +17 282 . G <*> 0 . DP=22;DPR=22,0;I16=7,15,0,0,806,30420,0,0,956,46620,0,0,427,9609,0,0;QS=3,0;MQSB=0.0124927;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,36,253:12:0:0:6,6,0,0:12,0 0,18,124:6:0:0:0,6,0,0:6,0 0,12,119:4:0:0:1,3,0,0:4,0 +17 283 . C <*> 0 . DP=23;DPR=22,0;I16=7,15,0,0,827,31785,0,0,956,46620,0,0,426,9574,0,0;QS=3,0;MQSB=0.0124927;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,36,255:12:0:0:6,6,0,0:12,0 0,18,125:6:0:0:0,6,0,0:6,0 0,12,122:4:0:0:1,3,0,0:4,0 +17 284 . T <*> 0 . DP=23;DPR=23,0;I16=7,16,0,0,901,35479,0,0,1016,50220,0,0,431,9593,0,0;QS=3,0;MQSB=0.0194969;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,36,255:12:0:0:6,6,0,0:12,0 0,18,126:6:0:0:0,6,0,0:6,0 0,15,144:5:0:0:1,4,0,0:5,0 +17 285 . G <*> 0 . DP=23;DPR=23,0;I16=7,16,0,0,860,32856,0,0,1016,50220,0,0,431,9607,0,0;QS=3,0;MQSB=0.0194969;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,36,255:12:0:0:6,6,0,0:12,0 0,18,119:6:0:0:0,6,0,0:6,0 0,15,132:5:0:0:1,4,0,0:5,0 +17 286 . C <*> 0 . DP=24;DPR=24,0;I16=8,16,0,0,875,32883,0,0,1076,53820,0,0,431,9641,0,0;QS=3,0;MQSB=0.0132999;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,36,255:12:0:0:6,6,0,0:12,0 0,21,150:7:0:0:1,6,0,0:7,0 0,15,134:5:0:0:1,4,0,0:5,0 +17 287 . A <*> 0 . DP=25;DPR=25,0;I16=9,16,0,0,895,32957,0,0,1136,57420,0,0,432,9696,0,0;QS=3,0;MQSB=0.00934348;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,36,255:12:0:0:6,6,0,0:12,0 0,24,178:8:0:0:2,6,0,0:8,0 0,15,133:5:0:0:1,4,0,0:5,0 +17 288 . T <*> 0 . DP=25;DPR=25,0;I16=9,16,0,0,931,35011,0,0,1136,57420,0,0,432,9674,0,0;QS=3,0;MQSB=0.00934348;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,36,255:12:0:0:6,6,0,0:12,0 0,24,184:8:0:0:2,6,0,0:8,0 0,15,146:5:0:0:1,4,0,0:5,0 +17 289 . G <*> 0 . DP=25;DPR=25,0;I16=9,16,0,0,939,36117,0,0,1136,57420,0,0,432,9676,0,0;QS=3,0;MQSB=0.00934348;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,36,255:12:0:0:6,6,0,0:12,0 0,24,185:8:0:0:2,6,0,0:8,0 0,15,136:5:0:0:1,4,0,0:5,0 +17 290 . G <*> 0 . DP=23;DPR=23,0;I16=8,15,0,0,805,29157,0,0,1047,52979,0,0,433,9651,0,0;QS=3,0;MQSB=0.0177152;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,240:11:0:0:5,6,0,0:11,0 0,21,164:7:0:0:2,5,0,0:7,0 0,15,126:5:0:0:1,4,0,0:5,0 +17 291 . T <*> 0 . DP=24;DPR=23,0;I16=8,15,0,0,840,31616,0,0,1047,52979,0,0,421,9479,0,0;QS=3,0;MQSB=0.0177152;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,244:11:0:0:5,6,0,0:11,0 0,21,168:7:0:0:2,5,0,0:7,0 0,15,136:5:0:0:1,4,0,0:5,0 +17 292 . T <*> 0 . DP=25;DPR=25,0;I16=9,16,0,0,888,32274,0,0,1167,60179,0,0,436,9668,0,0;QS=3,0;MQSB=0.0197089;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,253:11:0:0:5,6,0,0:11,0 0,24,181:8:0:0:3,5,0,0:8,0 0,18,156:6:0:0:1,5,0,0:6,0 +17 293 . G <*> 0 . DP=26;DPR=25,0;I16=10,15,0,0,934,35232,0,0,1167,60179,0,0,424,9488,0,0;QS=3,0;MQSB=0.0095249;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,36,255:12:0:0:6,6,0,0:12,0 0,24,196:8:0:0:3,5,0,0:8,0 0,15,145:5:0:0:1,4,0,0:5,0 +17 294 . A <*> 0 . DP=26;DPR=26,0;I16=10,16,0,0,931,33937,0,0,1227,63779,0,0,443,9785,0,0;QS=3,0;MQSB=0.0149748;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,36,252:12:0:0:6,6,0,0:12,0 0,24,201:8:0:0:3,5,0,0:8,0 0,18,161:6:0:0:1,5,0,0:6,0 +17 295 . C <*> 0 . DP=25;DPR=24,0;I16=10,14,0,0,897,33973,0,0,1169,62097,0,0,430,9544,0,0;QS=3,0;MQSB=0.0310726;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:6,5,0,0:11,0 0,21,180:7:0:0:3,4,0,0:7,0 0,18,159:6:0:0:1,5,0,0:6,0 +17 296 . A <*> 0 . DP=25;DPR=25,0;I16=10,15,0,0,874,31846,0,0,1198,62938,0,0,451,9905,0,0;QS=3,0;MQSB=0.0213617;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:6,5,0,0:11,0 0,24,169:8:0:0:3,5,0,0:8,0 0,18,169:6:0:0:1,5,0,0:6,0 +17 297 . C <*> 0 . DP=25;DPR=24,0;I16=9,15,0,0,901,34305,0,0,1138,59338,0,0,445,9901,0,0;QS=3,0;MQSB=0.0273237;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:6,5,0,0:11,0 0,21,174:7:0:0:2,5,0,0:7,0 0,18,161:6:0:0:1,5,0,0:6,0 +17 298 . A <*> 0 . DP=26;DPR=26,0;I16=11,15,0,0,936,34652,0,0,1258,66538,0,0,459,10121,0,0;QS=3,0;MQSB=0.017008;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:6,5,0,0:11,0 0,24,184:8:0:0:3,5,0,0:8,0 0,21,191:7:0:0:2,5,0,0:7,0 +17 299 . C <*> 0 . DP=27;DPR=26,0;I16=11,15,0,0,971,36863,0,0,1258,66538,0,0,464,10266,0,0;QS=3,0;MQSB=0.017008;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:6,5,0,0:11,0 0,24,193:8:0:0:3,5,0,0:8,0 0,21,189:7:0:0:2,5,0,0:7,0 +17 300 . A <*> 0 . DP=27;DPR=26,0;I16=11,15,0,0,1001,39455,0,0,1258,66538,0,0,469,10437,0,0;QS=3,0;MQSB=0.017008;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:6,5,0,0:11,0 0,24,204:8:0:0:3,5,0,0:8,0 0,21,210:7:0:0:2,5,0,0:7,0 +17 301 . G <*> 0 . DP=25;DPR=24,0;I16=10,14,0,0,928,36116,0,0,1169,62097,0,0,476,10632,0,0;QS=3,0;MQSB=0.0310726;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,30,255:10:0:0:5,5,0,0:10,0 0,21,195:7:0:0:3,4,0,0:7,0 0,21,196:7:0:0:2,5,0,0:7,0 +17 302 . T <*> 0 . DP=25;DPR=24,0;I16=10,14,0,0,879,32885,0,0,1169,62097,0,0,483,10849,0,0;QS=3,0;MQSB=0.0310726;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,30,231:10:0:0:5,5,0,0:10,0 0,21,172:7:0:0:3,4,0,0:7,0 0,21,202:7:0:0:2,5,0,0:7,0 +17 302 . T TA 0 . INDEL;IDV=7;IMF=1;DP=25;DPR=6,19;I16=2,4,8,11,214,7674,793,33369,236,10564,993,55133,109,2229,377,8629;QS=0.511212,2.48879;VDB=0.27613;SGB=-4.22417;MQSB=0.0443614;MQ0F=0 PL:DP:DV:SP:DP4:DPR 167,0,96:11:6:6:1,4,4,2:5,6 157,0,9:7:6:0:1,0,2,4:1,6 201,21,0:7:7:0:0,0,2,5:0,7 +17 303 . G <*> 0 . DP=25;DPR=25,0;I16=10,15,0,0,976,38516,0,0,1229,65697,0,0,497,11181,0,0;QS=3,0;MQSB=0.0443614;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:5,6,0,0:11,0 0,21,197:7:0:0:3,4,0,0:7,0 0,21,195:7:0:0:2,5,0,0:7,0 +17 304 . C <*> 0 . DP=27;DPR=27,0;I16=11,16,0,0,991,37005,0,0,1318,70138,0,0,503,11359,0,0;QS=3,0;MQSB=0.129164;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:5,6,0,0:11,0 0,24,206:8:0:0:4,4,0,0:8,0 0,24,200:8:0:0:2,6,0,0:8,0 +17 305 . C <*> 0 . DP=27;DPR=27,0;I16=11,16,0,0,1057,41761,0,0,1318,70138,0,0,510,11508,0,0;QS=3,0;MQSB=0.129164;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:5,6,0,0:11,0 0,24,213:8:0:0:4,4,0,0:8,0 0,24,211:8:0:0:2,6,0,0:8,0 +17 306 . T <*> 0 . DP=27;DPR=27,0;I16=11,16,0,0,1033,40253,0,0,1318,70138,0,0,517,11679,0,0;QS=3,0;MQSB=0.129164;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:5,6,0,0:11,0 0,24,207:8:0:0:4,4,0,0:8,0 0,24,217:8:0:0:2,6,0,0:8,0 +17 307 . G <*> 0 . DP=27;DPR=26,0;I16=11,15,0,0,984,37886,0,0,1289,69297,0,0,498,11198,0,0;QS=3,0;MQSB=0.174566;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:5,6,0,0:11,0 0,21,189:7:0:0:4,3,0,0:7,0 0,24,203:8:0:0:2,6,0,0:8,0 +17 308 . C <*> 0 . DP=27;DPR=27,0;I16=11,16,0,0,892,30810,0,0,1318,70138,0,0,529,11991,0,0;QS=3,0;MQSB=0.129164;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:5,6,0,0:11,0 0,24,178:8:0:0:4,4,0,0:8,0 0,24,185:8:0:0:2,6,0,0:8,0 +17 309 . G <*> 0 . DP=27;DPR=27,0;I16=11,16,0,0,951,34599,0,0,1318,70138,0,0,535,12183,0,0;QS=3,0;MQSB=0.129164;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,243:11:0:0:5,6,0,0:11,0 0,24,183:8:0:0:4,4,0,0:8,0 0,24,205:8:0:0:2,6,0,0:8,0 +17 310 . A <*> 0 . DP=27;DPR=27,0;I16=11,16,0,0,1001,38063,0,0,1318,70138,0,0,540,12350,0,0;QS=3,0;MQSB=0.129164;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:5,6,0,0:11,0 0,24,200:8:0:0:4,4,0,0:8,0 0,24,217:8:0:0:2,6,0,0:8,0 +17 311 . C <*> 0 . DP=27;DPR=27,0;I16=11,16,0,0,1037,40263,0,0,1318,70138,0,0,544,12492,0,0;QS=3,0;MQSB=0.129164;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:5,6,0,0:11,0 0,24,215:8:0:0:4,4,0,0:8,0 0,24,210:8:0:0:2,6,0,0:8,0 +17 312 . A <*> 0 . DP=26;DPR=26,0;I16=10,16,0,0,985,38043,0,0,1258,66538,0,0,549,12657,0,0;QS=3,0;MQSB=0.157183;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,30,237:10:0:0:4,6,0,0:10,0 0,24,215:8:0:0:4,4,0,0:8,0 0,24,218:8:0:0:2,6,0,0:8,0 +17 313 . A <*> 0 . DP=26;DPR=26,0;I16=10,16,0,0,983,37969,0,0,1258,66538,0,0,551,12695,0,0;QS=3,0;MQSB=0.157183;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,30,235:10:0:0:4,6,0,0:10,0 0,24,219:8:0:0:4,4,0,0:8,0 0,24,215:8:0:0:2,6,0,0:8,0 +17 314 . A <*> 0 . DP=27;DPR=27,0;I16=10,17,0,0,1050,41798,0,0,1318,70138,0,0,553,12757,0,0;QS=3,0;MQSB=0.195223;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,250:11:0:0:4,7,0,0:11,0 0,24,217:8:0:0:4,4,0,0:8,0 0,24,227:8:0:0:2,6,0,0:8,0 +17 315 . G <*> 0 . DP=26;DPR=26,0;I16=10,16,0,0,1025,40941,0,0,1289,69297,0,0,557,12843,0,0;QS=3,0;MQSB=0.252051;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,30,252:10:0:0:4,6,0,0:10,0 0,24,216:8:0:0:4,4,0,0:8,0 0,24,225:8:0:0:2,6,0,0:8,0 +17 316 . C <*> 0 . DP=27;DPR=25,0;I16=10,15,0,0,983,39393,0,0,1252,67928,0,0,535,12277,0,0;QS=3,0;MQSB=0.312403;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,30,255:10:0:0:4,6,0,0:10,0 0,21,183:7:0:0:4,3,0,0:7,0 0,24,224:8:0:0:2,6,0,0:8,0 +17 317 . T <*> 0 . DP=27;DPR=26,0;I16=10,16,0,0,1028,41392,0,0,1320,72056,0,0,547,12557,0,0;QS=3,0;MQSB=0.377061;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,30,255:10:0:0:4,6,0,0:10,0 0,24,230:8:0:0:4,4,0,0:8,0 0,24,206:8:0:0:2,6,0,0:8,0 +17 318 . G <*> 0 . DP=27;DPR=27,0;I16=10,17,0,0,1038,40546,0,0,1349,72897,0,0,570,13018,0,0;QS=3,0;MQSB=0.297797;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,30,249:10:0:0:4,6,0,0:10,0 0,27,235:9:0:0:4,5,0,0:9,0 0,24,208:8:0:0:2,6,0,0:8,0 +17 319 . A <*> 0 . DP=27;DPR=26,0;I16=9,17,0,0,994,38654,0,0,1289,69297,0,0,560,12906,0,0;QS=3,0;MQSB=0.346864;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,30,249:10:0:0:4,6,0,0:10,0 0,27,228:9:0:0:4,5,0,0:9,0 0,21,185:7:0:0:1,6,0,0:7,0 +17 320 . A <*> 0 . DP=27;DPR=27,0;I16=10,17,0,0,1022,39418,0,0,1349,72897,0,0,573,13053,0,0;QS=3,0;MQSB=0.297797;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,30,247:10:0:0:4,6,0,0:10,0 0,27,230:9:0:0:4,5,0,0:9,0 0,24,211:8:0:0:2,6,0,0:8,0 +17 321 . T <*> 0 . DP=27;DPR=27,0;I16=10,17,0,0,1026,39772,0,0,1349,72897,0,0,573,13029,0,0;QS=3,0;MQSB=0.297797;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,30,253:10:0:0:4,6,0,0:10,0 0,27,214:9:0:0:4,5,0,0:9,0 0,24,218:8:0:0:2,6,0,0:8,0 +17 322 . G <*> 0 . DP=28;DPR=28,0;I16=10,18,0,0,1091,43151,0,0,1409,76497,0,0,573,13029,0,0;QS=3,0;MQSB=0.343265;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,30,255:10:0:0:4,6,0,0:10,0 0,27,226:9:0:0:4,5,0,0:9,0 0,27,223:9:0:0:2,7,0,0:9,0 +17 323 . C <*> 0 . DP=28;DPR=27,0;I16=9,18,0,0,1067,42619,0,0,1349,72897,0,0,565,12939,0,0;QS=3,0;MQSB=0.394987;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,30,255:10:0:0:4,6,0,0:10,0 0,27,225:9:0:0:4,5,0,0:9,0 0,24,198:8:0:0:1,7,0,0:8,0 +17 324 . T <*> 0 . DP=30;DPR=30,0;I16=12,18,0,0,1145,44221,0,0,1529,83697,0,0,573,13001,0,0;QS=3,0;MQSB=0.264959;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,30,253:10:0:0:4,6,0,0:10,0 0,27,237:9:0:0:4,5,0,0:9,0 0,33,255:11:0:0:4,7,0,0:11,0 +17 325 . A <*> 0 . DP=31;DPR=31,0;I16=13,18,0,0,1132,42058,0,0,1589,87297,0,0,573,12925,0,0;QS=3,0;MQSB=0.235201;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:5,6,0,0:11,0 0,27,208:9:0:0:4,5,0,0:9,0 0,33,255:11:0:0:4,7,0,0:11,0 +17 326 . T <*> 0 . DP=31;DPR=31,0;I16=13,18,0,0,1157,44193,0,0,1589,87297,0,0,574,12878,0,0;QS=3,0;MQSB=0.235201;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:5,6,0,0:11,0 0,27,216:9:0:0:4,5,0,0:9,0 0,33,255:11:0:0:4,7,0,0:11,0 +17 327 . C <*> 0 . DP=31;DPR=31,0;I16=13,18,0,0,1147,43895,0,0,1589,87297,0,0,575,12861,0,0;QS=3,0;MQSB=0.235201;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:5,6,0,0:11,0 0,27,198:9:0:0:4,5,0,0:9,0 0,33,255:11:0:0:4,7,0,0:11,0 +17 328 . A <*> 0 . DP=31;DPR=31,0;I16=13,18,0,0,1167,44531,0,0,1589,87297,0,0,574,12776,0,0;QS=3,0;MQSB=0.235201;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:5,6,0,0:11,0 0,27,226:9:0:0:4,5,0,0:9,0 0,33,255:11:0:0:4,7,0,0:11,0 +17 329 . T <*> 0 . DP=31;DPR=31,0;I16=13,18,0,0,1210,47742,0,0,1589,87297,0,0,572,12676,0,0;QS=3,0;MQSB=0.235201;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:5,6,0,0:11,0 0,27,237:9:0:0:4,5,0,0:9,0 0,33,255:11:0:0:4,7,0,0:11,0 +17 330 . T <*> 0 . DP=31;DPR=31,0;I16=13,18,0,0,1185,45839,0,0,1589,87297,0,0,568,12510,0,0;QS=3,0;MQSB=0.235201;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,254:11:0:0:5,6,0,0:11,0 0,27,231:9:0:0:4,5,0,0:9,0 0,33,255:11:0:0:4,7,0,0:11,0 +17 331 . T <*> 0 . DP=32;DPR=32,0;I16=14,18,0,0,1154,42510,0,0,1649,90897,0,0,563,12327,0,0;QS=3,0;MQSB=0.210122;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:5,6,0,0:11,0 0,27,222:9:0:0:4,5,0,0:9,0 0,36,255:12:0:0:5,7,0,0:12,0 +17 332 . A <*> 0 . DP=32;DPR=32,0;I16=14,18,0,0,1156,42666,0,0,1649,90897,0,0,560,12178,0,0;QS=3,0;MQSB=0.210122;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,36,255:12:0:0:6,6,0,0:12,0 0,27,214:9:0:0:4,5,0,0:9,0 0,33,255:11:0:0:4,7,0,0:11,0 +17 333 . A <*> 0 . DP=32;DPR=32,0;I16=14,18,0,0,1141,41987,0,0,1649,90897,0,0,558,12064,0,0;QS=3,0;MQSB=0.210122;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,36,255:12:0:0:6,6,0,0:12,0 0,27,223:9:0:0:4,5,0,0:9,0 0,33,255:11:0:0:4,7,0,0:11,0 +17 334 . A <*> 0 . DP=32;DPR=32,0;I16=14,18,0,0,1162,43328,0,0,1649,90897,0,0,556,11986,0,0;QS=3,0;MQSB=0.210122;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,36,255:12:0:0:6,6,0,0:12,0 0,27,221:9:0:0:4,5,0,0:9,0 0,33,255:11:0:0:4,7,0,0:11,0 +17 335 . A <*> 0 . DP=32;DPR=30,0;I16=12,18,0,0,1077,40287,0,0,1529,83697,0,0,552,11934,0,0;QS=3,0;MQSB=0.264959;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,30,250:10:0:0:4,6,0,0:10,0 0,27,219:9:0:0:4,5,0,0:9,0 0,33,251:11:0:0:4,7,0,0:11,0 +17 336 . A <*> 0 . DP=32;DPR=31,0;I16=14,17,0,0,1088,39758,0,0,1612,89528,0,0,536,11574,0,0;QS=3,0;MQSB=0.274662;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:5,6,0,0:11,0 0,24,211:8:0:0:4,4,0,0:8,0 0,36,255:12:0:0:5,7,0,0:12,0 +17 337 . C <*> 0 . DP=32;DPR=30,0;I16=13,17,0,0,1115,42381,0,0,1552,85928,0,0,531,11565,0,0;QS=3,0;MQSB=0.301511;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,30,255:10:0:0:4,6,0,0:10,0 0,24,202:8:0:0:4,4,0,0:8,0 0,36,255:12:0:0:5,7,0,0:12,0 +17 338 . T <*> 0 . DP=30;DPR=30,0;I16=14,16,0,0,1191,47979,0,0,1560,86456,0,0,554,11878,0,0;QS=3,0;MQSB=0.242376;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,30,255:10:0:0:5,5,0,0:10,0 0,24,226:8:0:0:4,4,0,0:8,0 0,36,255:12:0:0:5,7,0,0:12,0 +17 339 . C <*> 0 . DP=31;DPR=31,0;I16=14,17,0,0,1130,43210,0,0,1589,87297,0,0,554,11874,0,0;QS=3,0;MQSB=0.175471;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:5,6,0,0:11,0 0,24,185:8:0:0:4,4,0,0:8,0 0,36,255:12:0:0:5,7,0,0:12,0 +17 340 . C <*> 0 . DP=31;DPR=31,0;I16=14,17,0,0,1196,47044,0,0,1589,87297,0,0,554,11852,0,0;QS=3,0;MQSB=0.175471;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:5,6,0,0:11,0 0,24,221:8:0:0:4,4,0,0:8,0 0,36,255:12:0:0:5,7,0,0:12,0 +17 341 . T <*> 0 . DP=31;DPR=31,0;I16=14,17,0,0,1227,48995,0,0,1589,87297,0,0,554,11862,0,0;QS=3,0;MQSB=0.175471;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:5,6,0,0:11,0 0,24,216:8:0:0:4,4,0,0:8,0 0,36,255:12:0:0:5,7,0,0:12,0 +17 342 . T <*> 0 . DP=31;DPR=31,0;I16=14,17,0,0,1162,43942,0,0,1589,87297,0,0,554,11904,0,0;QS=3,0;MQSB=0.175471;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:5,6,0,0:11,0 0,24,210:8:0:0:4,4,0,0:8,0 0,36,255:12:0:0:5,7,0,0:12,0 +17 343 . G <*> 0 . DP=32;DPR=31,0;I16=14,17,0,0,1150,43702,0,0,1620,90056,0,0,550,11962,0,0;QS=3,0;MQSB=0.283511;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,30,249:10:0:0:5,5,0,0:10,0 0,27,218:9:0:0:4,5,0,0:9,0 0,36,255:12:0:0:5,7,0,0:12,0 +17 344 . C <*> 0 . DP=32;DPR=32,0;I16=14,18,0,0,1181,45169,0,0,1649,90897,0,0,554,12036,0,0;QS=3,0;MQSB=0.210122;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:5,6,0,0:11,0 0,27,217:9:0:0:4,5,0,0:9,0 0,36,255:12:0:0:5,7,0,0:12,0 +17 345 . T <*> 0 . DP=31;DPR=31,0;I16=14,17,0,0,1205,47259,0,0,1589,87297,0,0,555,12129,0,0;QS=3,0;MQSB=0.175471;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:5,6,0,0:11,0 0,24,221:8:0:0:4,4,0,0:8,0 0,36,255:12:0:0:5,7,0,0:12,0 +17 346 . G <*> 0 . DP=31;DPR=31,0;I16=15,16,0,0,1147,43597,0,0,1620,90056,0,0,557,12255,0,0;QS=3,0;MQSB=0.220358;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:6,5,0,0:11,0 0,24,212:8:0:0:4,4,0,0:8,0 0,36,255:12:0:0:5,7,0,0:12,0 +17 347 . G <*> 0 . DP=31;DPR=30,0;I16=14,16,0,0,1119,42227,0,0,1560,86456,0,0,545,12189,0,0;QS=3,0;MQSB=0.242376;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,30,251:10:0:0:5,5,0,0:10,0 0,24,207:8:0:0:4,4,0,0:8,0 0,36,255:12:0:0:5,7,0,0:12,0 +17 348 . T <*> 0 . DP=32;DPR=31,0;I16=15,16,0,0,1145,43007,0,0,1620,90056,0,0,546,12300,0,0;QS=3,0;MQSB=0.220358;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,30,243:10:0:0:5,5,0,0:10,0 0,27,228:9:0:0:5,4,0,0:9,0 0,36,255:12:0:0:5,7,0,0:12,0 +17 349 . T <*> 0 . DP=32;DPR=32,0;I16=16,16,0,0,1194,45350,0,0,1680,93656,0,0,565,12731,0,0;QS=3,0;MQSB=0.201402;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,246:11:0:0:6,5,0,0:11,0 0,27,230:9:0:0:5,4,0,0:9,0 0,36,255:12:0:0:5,7,0,0:12,0 +17 350 . T <*> 0 . DP=31;DPR=31,0;I16=16,15,0,0,1142,43072,0,0,1651,92815,0,0,567,12837,0,0;QS=3,0;MQSB=0.286505;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,249:11:0:0:6,5,0,0:11,0 0,27,230:9:0:0:5,4,0,0:9,0 0,33,255:11:0:0:5,6,0,0:11,0 +17 351 . G <*> 0 . DP=31;DPR=31,0;I16=16,15,0,0,1146,43750,0,0,1651,92815,0,0,568,12920,0,0;QS=3,0;MQSB=0.286505;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:6,5,0,0:11,0 0,27,212:9:0:0:5,4,0,0:9,0 0,33,255:11:0:0:5,6,0,0:11,0 +17 352 . A <*> 0 . DP=31;DPR=30,0;I16=16,14,0,0,1150,45520,0,0,1591,89215,0,0,544,12404,0,0;QS=3,0;MQSB=0.242376;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:6,5,0,0:11,0 0,24,224:8:0:0:5,3,0,0:8,0 0,33,255:11:0:0:5,6,0,0:11,0 +17 353 . G <*> 0 . DP=29;DPR=29,0;I16=15,14,0,0,1109,43095,0,0,1562,88374,0,0,570,13064,0,0;QS=3,0;MQSB=0.424373;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,30,255:10:0:0:5,5,0,0:10,0 0,27,231:9:0:0:5,4,0,0:9,0 0,30,255:10:0:0:5,5,0,0:10,0 +17 354 . A <*> 0 . DP=28;DPR=28,0;I16=14,14,0,0,1078,42938,0,0,1502,84774,0,0,571,13075,0,0;QS=3,0;MQSB=0.450096;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,27,225:9:0:0:4,5,0,0:9,0 0,27,244:9:0:0:5,4,0,0:9,0 0,30,255:10:0:0:5,5,0,0:10,0 +17 355 . G T,<*> 0 . DP=28;DPR=27,1,0;I16=14,13,0,1,1001,37907,41,1681,1442,81174,60,3600,547,12487,25,625;QS=2.875,0.125,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.450096;BQB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 14,0,200,38,203,231:9:1:0:4,4,0,1:8,1,0 0,27,222,27,222,222:9:0:0:5,4,0,0:9,0,0 0,30,255,30,255,255:10:0:0:5,5,0,0:10,0,0 +17 356 . G <*> 0 . DP=27;DPR=27,0;I16=14,13,0,0,993,37481,0,0,1465,83405,0,0,574,13174,0,0;QS=3,0;MQSB=0.580277;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,27,228:9:0:0:4,5,0,0:9,0 0,24,201:8:0:0:5,3,0,0:8,0 0,30,255:10:0:0:5,5,0,0:10,0 +17 357 . C <*> 0 . DP=28;DPR=27,0;I16=14,13,0,0,1021,39471,0,0,1465,83405,0,0,550,12584,0,0;QS=3,0;MQSB=0.580277;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,30,255:10:0:0:5,5,0,0:10,0 0,24,205:8:0:0:5,3,0,0:8,0 0,27,251:9:0:0:4,5,0,0:9,0 +17 358 . A <*> 0 . DP=28;DPR=28,0;I16=15,13,0,0,1050,40518,0,0,1525,87005,0,0,576,13216,0,0;QS=3,0;MQSB=0.556581;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,30,254:10:0:0:5,5,0,0:10,0 0,24,197:8:0:0:5,3,0,0:8,0 0,30,255:10:0:0:5,5,0,0:10,0 +17 359 . G <*> 0 . DP=29;DPR=28,0;I16=15,13,0,0,1085,42761,0,0,1525,87005,0,0,552,12620,0,0;QS=3,0;MQSB=0.556581;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,30,255:10:0:0:5,5,0,0:10,0 0,21,187:7:0:0:5,2,0,0:7,0 0,33,255:11:0:0:5,6,0,0:11,0 +17 360 . A <*> 0 . DP=29;DPR=29,0;I16=15,14,0,0,1111,43259,0,0,1585,90605,0,0,579,13297,0,0;QS=3,0;MQSB=0.604224;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,30,252:10:0:0:5,5,0,0:10,0 0,24,220:8:0:0:5,3,0,0:8,0 0,33,255:11:0:0:5,6,0,0:11,0 +17 361 . A <*> 0 . DP=29;DPR=29,0;I16=15,14,0,0,1116,43442,0,0,1585,90605,0,0,579,13273,0,0;QS=3,0;MQSB=0.604224;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,30,252:10:0:0:5,5,0,0:10,0 0,24,219:8:0:0:5,3,0,0:8,0 0,33,255:11:0:0:5,6,0,0:11,0 +17 362 . A <*> 0 . DP=29;DPR=29,0;I16=16,13,0,0,1104,42700,0,0,1585,90605,0,0,580,13272,0,0;QS=3,0;MQSB=0.535133;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:6,5,0,0:11,0 0,24,218:8:0:0:5,3,0,0:8,0 0,30,255:10:0:0:5,5,0,0:10,0 +17 363 . A <*> 0 . DP=29;DPR=29,0;I16=16,13,0,0,1087,41437,0,0,1585,90605,0,0,581,13245,0,0;QS=3,0;MQSB=0.535133;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:6,5,0,0:11,0 0,24,213:8:0:0:5,3,0,0:8,0 0,30,255:10:0:0:5,5,0,0:10,0 +17 364 . T <*> 0 . DP=29;DPR=29,0;I16=16,13,0,0,1032,37960,0,0,1585,90605,0,0,582,13244,0,0;QS=3,0;MQSB=0.535133;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,250:11:0:0:6,5,0,0:11,0 0,24,205:8:0:0:5,3,0,0:8,0 0,30,255:10:0:0:5,5,0,0:10,0 +17 365 . G <*> 0 . DP=29;DPR=29,0;I16=16,13,0,0,1105,43079,0,0,1585,90605,0,0,582,13218,0,0;QS=3,0;MQSB=0.535133;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:6,5,0,0:11,0 0,24,211:8:0:0:5,3,0,0:8,0 0,30,255:10:0:0:5,5,0,0:10,0 +17 366 . A <*> 0 . DP=29;DPR=29,0;I16=16,13,0,0,1090,41562,0,0,1585,90605,0,0,581,13167,0,0;QS=3,0;MQSB=0.535133;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:6,5,0,0:11,0 0,24,211:8:0:0:5,3,0,0:8,0 0,30,255:10:0:0:5,5,0,0:10,0 +17 367 . T <*> 0 . DP=29;DPR=29,0;I16=16,13,0,0,1055,39149,0,0,1585,90605,0,0,579,13093,0,0;QS=3,0;MQSB=0.535133;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:6,5,0,0:11,0 0,24,204:8:0:0:5,3,0,0:8,0 0,30,255:10:0:0:5,5,0,0:10,0 +17 368 . A <*> 0 . DP=29;DPR=29,0;I16=16,13,0,0,1054,39632,0,0,1585,90605,0,0,576,12998,0,0;QS=3,0;MQSB=0.535133;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:6,5,0,0:11,0 0,24,208:8:0:0:5,3,0,0:8,0 0,30,255:10:0:0:5,5,0,0:10,0 +17 369 . T <*> 0 . DP=28;DPR=27,0;I16=16,11,0,0,1037,40275,0,0,1496,86164,0,0,548,12256,0,0;QS=3,0;MQSB=0.659218;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,30,250:10:0:0:6,4,0,0:10,0 0,21,196:7:0:0:5,2,0,0:7,0 0,30,255:10:0:0:5,5,0,0:10,0 +17 370 . C <*> 0 . DP=28;DPR=28,0;I16=16,12,0,0,1045,40219,0,0,1556,89764,0,0,570,12790,0,0;QS=3,0;MQSB=0.705296;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,30,255:10:0:0:6,4,0,0:10,0 0,24,201:8:0:0:5,3,0,0:8,0 0,30,255:10:0:0:5,5,0,0:10,0 +17 371 . T <*> 0 . DP=29;DPR=29,0;I16=16,13,0,0,1155,46591,0,0,1616,93364,0,0,567,12725,0,0;QS=3,0;MQSB=0.744925;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,30,255:10:0:0:6,4,0,0:10,0 0,24,227:8:0:0:5,3,0,0:8,0 0,33,255:11:0:0:5,6,0,0:11,0 +17 372 . C <*> 0 . DP=30;DPR=30,0;I16=16,14,0,0,1139,44019,0,0,1676,96964,0,0,564,12636,0,0;QS=3,0;MQSB=0.779025;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:6,5,0,0:11,0 0,24,215:8:0:0:5,3,0,0:8,0 0,33,255:11:0:0:5,6,0,0:11,0 +17 373 . A <*> 0 . DP=30;DPR=30,0;I16=16,14,0,0,1142,44118,0,0,1676,96964,0,0,561,12525,0,0;QS=3,0;MQSB=0.779025;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:6,5,0,0:11,0 0,24,220:8:0:0:5,3,0,0:8,0 0,33,255:11:0:0:5,6,0,0:11,0 +17 374 . T <*> 0 . DP=30;DPR=30,0;I16=16,14,0,0,1098,41180,0,0,1676,96964,0,0,556,12344,0,0;QS=3,0;MQSB=0.779025;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:6,5,0,0:11,0 0,24,221:8:0:0:5,3,0,0:8,0 0,33,255:11:0:0:5,6,0,0:11,0 +17 375 . A T,<*> 0 . DP=31;DPR=30,1,0;I16=17,13,0,1,1138,43798,14,196,1676,96964,60,3600,547,12177,4,16;QS=2.9661,0.0338983,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.763662;BQB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,36,255,36,255,255:12:0:0:7,5,0,0:12,0,0 0,24,218,24,218,218:8:0:0:5,3,0,0:8,0,0 0,18,255,30,255,255:11:1:0:5,5,0,1:10,1,0 +17 376 . G <*> 0 . DP=31;DPR=31,0;I16=17,14,0,0,1131,42581,0,0,1736,100564,0,0,547,12073,0,0;QS=3,0;MQSB=0.763662;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,36,255:12:0:0:7,5,0,0:12,0 0,24,220:8:0:0:5,3,0,0:8,0 0,33,255:11:0:0:5,6,0,0:11,0 +17 377 . T <*> 0 . DP=31;DPR=30,0;I16=16,14,0,0,1105,41629,0,0,1676,96964,0,0,518,11360,0,0;QS=3,0;MQSB=0.779025;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:6,5,0,0:11,0 0,24,211:8:0:0:5,3,0,0:8,0 0,33,255:11:0:0:5,6,0,0:11,0 +17 378 . T <*> 0 . DP=30;DPR=30,0;I16=18,12,0,0,1098,41066,0,0,1707,99723,0,0,541,11927,0,0;QS=3,0;MQSB=0.878946;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,39,255:13:0:0:8,5,0,0:13,0 0,21,186:7:0:0:5,2,0,0:7,0 0,30,255:10:0:0:5,5,0,0:10,0 +17 379 . G <*> 0 . DP=29;DPR=28,0;I16=18,10,0,0,1053,40181,0,0,1618,95282,0,0,534,11848,0,0;QS=3,0;MQSB=0.981777;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:8,3,0,0:11,0 0,21,187:7:0:0:5,2,0,0:7,0 0,30,255:10:0:0:5,5,0,0:10,0 +17 380 . C <*> 0 . DP=29;DPR=28,0;I16=18,10,0,0,1087,42743,0,0,1618,95282,0,0,514,11172,0,0;QS=3,0;MQSB=0.981777;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,36,255:12:0:0:8,4,0,0:12,0 0,18,177:6:0:0:5,1,0,0:6,0 0,30,255:10:0:0:5,5,0,0:10,0 +17 381 . T <*> 0 . DP=29;DPR=29,0;I16=18,11,0,0,1168,47412,0,0,1678,98882,0,0,537,11729,0,0;QS=3,0;MQSB=0.987702;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,36,255:12:0:0:8,4,0,0:12,0 0,21,212:7:0:0:5,2,0,0:7,0 0,30,255:10:0:0:5,5,0,0:10,0 +17 382 . T <*> 0 . DP=29;DPR=28,0;I16=17,11,0,0,1054,40450,0,0,1618,95282,0,0,510,11068,0,0;QS=3,0;MQSB=0.990092;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,33,255:11:0:0:7,4,0,0:11,0 0,21,182:7:0:0:5,2,0,0:7,0 0,30,255:10:0:0:5,5,0,0:10,0 +17 383 . T <*> 0 . DP=29;DPR=28,0;I16=18,10,0,0,1052,39798,0,0,1618,95282,0,0,507,11013,0,0;QS=3,0;MQSB=0.981777;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,36,255:12:0:0:8,4,0,0:12,0 0,18,165:6:0:0:5,1,0,0:6,0 0,30,255:10:0:0:5,5,0,0:10,0 +17 384 . A <*> 0 . DP=31;DPR=30,0;I16=19,11,0,0,1077,39885,0,0,1738,102482,0,0,504,10988,0,0;QS=3,0;MQSB=0.985292;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,39,255:13:0:0:8,5,0,0:13,0 0,21,176:7:0:0:6,1,0,0:7,0 0,30,255:10:0:0:5,5,0,0:10,0 +17 385 . C <*> 0 . DP=31;DPR=31,0;I16=19,12,0,0,1118,41180,0,0,1798,106082,0,0,527,11569,0,0;QS=3,0;MQSB=0.989977;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,39,255:13:0:0:8,5,0,0:13,0 0,24,186:8:0:0:6,2,0,0:8,0 0,30,255:10:0:0:5,5,0,0:10,0 +17 386 . T <*> 0 . DP=30;DPR=30,0;I16=18,12,0,0,1158,45592,0,0,1738,102482,0,0,526,11556,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,39,255:13:0:0:8,5,0,0:13,0 0,21,191:7:0:0:5,2,0,0:7,0 0,30,255:10:0:0:5,5,0,0:10,0 +17 387 . T <*> 0 . DP=30;DPR=30,0;I16=18,12,0,0,1105,41821,0,0,1738,102482,0,0,525,11573,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,39,255:13:0:0:8,5,0,0:13,0 0,21,187:7:0:0:5,2,0,0:7,0 0,30,255:10:0:0:5,5,0,0:10,0 +17 388 . T <*> 0 . DP=29;DPR=29,0;I16=17,12,0,0,1089,41577,0,0,1678,98882,0,0,523,11519,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,39,255:13:0:0:8,5,0,0:13,0 0,18,180:6:0:0:4,2,0,0:6,0 0,30,255:10:0:0:5,5,0,0:10,0 +17 389 . G <*> 0 . DP=29;DPR=29,0;I16=17,12,0,0,1067,40095,0,0,1678,98882,0,0,520,11444,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,39,255:13:0:0:8,5,0,0:13,0 0,18,171:6:0:0:4,2,0,0:6,0 0,30,255:10:0:0:5,5,0,0:10,0 +17 390 . C <*> 0 . DP=29;DPR=29,0;I16=17,12,0,0,1071,40423,0,0,1678,98882,0,0,517,11399,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,39,255:13:0:0:8,5,0,0:13,0 0,18,162:6:0:0:4,2,0,0:6,0 0,30,255:10:0:0:5,5,0,0:10,0 +17 391 . A <*> 0 . DP=29;DPR=29,0;I16=18,11,0,0,1091,41603,0,0,1647,96123,0,0,515,11383,0,0;QS=3,0;MQSB=0.995968;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,39,255:13:0:0:8,5,0,0:13,0 0,18,163:6:0:0:4,2,0,0:6,0 0,30,255:10:0:0:6,4,0,0:10,0 +17 392 . T <*> 0 . DP=29;DPR=29,0;I16=18,11,0,0,1046,38838,0,0,1647,96123,0,0,515,11395,0,0;QS=3,0;MQSB=0.995968;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,39,255:13:0:0:8,5,0,0:13,0 0,15,153:5:0:0:3,2,0,0:5,0 0,33,255:11:0:0:7,4,0,0:11,0 +17 393 . A <*> 0 . DP=28;DPR=28,0;I16=17,11,0,0,1014,37582,0,0,1587,92523,0,0,517,11435,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,36,255:12:0:0:7,5,0,0:12,0 0,15,133:5:0:0:3,2,0,0:5,0 0,33,255:11:0:0:7,4,0,0:11,0 +17 394 . T <*> 0 . DP=28;DPR=28,0;I16=17,11,0,0,1022,38342,0,0,1587,92523,0,0,519,11503,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,36,255:12:0:0:7,5,0,0:12,0 0,15,141:5:0:0:3,2,0,0:5,0 0,33,255:11:0:0:7,4,0,0:11,0 +17 395 . T <*> 0 . DP=28;DPR=28,0;I16=17,11,0,0,1060,40596,0,0,1587,92523,0,0,521,11599,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,36,255:12:0:0:7,5,0,0:12,0 0,15,164:5:0:0:3,2,0,0:5,0 0,33,255:11:0:0:7,4,0,0:11,0 +17 396 . T <*> 0 . DP=28;DPR=28,0;I16=17,11,0,0,1032,39228,0,0,1587,92523,0,0,523,11723,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,36,255:12:0:0:7,5,0,0:12,0 0,15,158:5:0:0:3,2,0,0:5,0 0,33,255:11:0:0:7,4,0,0:11,0 +17 397 . T <*> 0 . DP=28;DPR=28,0;I16=17,11,0,0,1046,39510,0,0,1587,92523,0,0,524,11824,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,36,255:12:0:0:7,5,0,0:12,0 0,15,149:5:0:0:3,2,0,0:5,0 0,33,255:11:0:0:7,4,0,0:11,0 +17 398 . A <*> 0 . DP=28;DPR=28,0;I16=17,11,0,0,1021,38105,0,0,1587,92523,0,0,524,11850,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,39,255:13:0:0:8,5,0,0:13,0 0,15,144:5:0:0:3,2,0,0:5,0 0,30,255:10:0:0:6,4,0,0:10,0 +17 399 . A <*> 0 . DP=28;DPR=28,0;I16=17,11,0,0,1015,38469,0,0,1587,92523,0,0,526,11900,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,39,255:13:0:0:8,5,0,0:13,0 0,15,140:5:0:0:3,2,0,0:5,0 0,30,255:10:0:0:6,4,0,0:10,0 +17 400 . A <*> 0 . DP=29;DPR=29,0;I16=17,12,0,0,1056,39702,0,0,1647,96123,0,0,526,11828,0,0;QS=3,0;MQSB=0.988062;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,39,255:13:0:0:8,5,0,0:13,0 0,15,159:5:0:0:3,2,0,0:5,0 0,33,255:11:0:0:6,5,0,0:11,0 +17 401 . A <*> 0 . DP=29;DPR=28,0;I16=17,11,0,0,1052,40302,0,0,1587,92523,0,0,501,11113,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,39,255:13:0:0:8,5,0,0:13,0 0,15,160:5:0:0:3,2,0,0:5,0 0,30,255:10:0:0:6,4,0,0:10,0 +17 402 . T <*> 0 . DP=29;DPR=29,0;I16=17,12,0,0,1082,41232,0,0,1647,96123,0,0,526,11680,0,0;QS=3,0;MQSB=0.988062;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,39,255:13:0:0:8,5,0,0:13,0 0,15,149:5:0:0:3,2,0,0:5,0 0,33,255:11:0:0:6,5,0,0:11,0 +17 403 . T <*> 0 . DP=29;DPR=29,0;I16=17,12,0,0,1085,40985,0,0,1647,96123,0,0,526,11654,0,0;QS=3,0;MQSB=0.988062;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,39,255:13:0:0:8,5,0,0:13,0 0,15,148:5:0:0:3,2,0,0:5,0 0,33,255:11:0:0:6,5,0,0:11,0 +17 404 . G <*> 0 . DP=29;DPR=29,0;I16=17,12,0,0,1074,40524,0,0,1647,96123,0,0,525,11609,0,0;QS=3,0;MQSB=0.988062;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,39,255:13:0:0:8,5,0,0:13,0 0,15,131:5:0:0:3,2,0,0:5,0 0,33,255:11:0:0:6,5,0,0:11,0 +17 405 . T <*> 0 . DP=27;DPR=26,0;I16=16,10,0,0,988,37870,0,0,1498,88082,0,0,519,11543,0,0;QS=3,0;MQSB=0.987578;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,39,255:13:0:0:8,5,0,0:13,0 0,9,103:3:0:0:2,1,0,0:3,0 0,30,255:10:0:0:6,4,0,0:10,0 +17 406 . G <*> 0 . DP=27;DPR=27,0;I16=16,11,0,0,976,36752,0,0,1558,91682,0,0,527,11601,0,0;QS=3,0;MQSB=0.992419;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,39,255:13:0:0:8,5,0,0:13,0 0,12,125:4:0:0:2,2,0,0:4,0 0,30,247:10:0:0:6,4,0,0:10,0 +17 407 . A <*> 0 . DP=27;DPR=27,0;I16=16,11,0,0,1007,38355,0,0,1558,91682,0,0,526,11538,0,0;QS=3,0;MQSB=0.992419;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,39,255:13:0:0:8,5,0,0:13,0 0,12,125:4:0:0:2,2,0,0:4,0 0,30,255:10:0:0:6,4,0,0:10,0 +17 408 . C <*> 0 . DP=28;DPR=27,0;I16=16,11,0,0,1006,38136,0,0,1558,91682,0,0,521,11489,0,0;QS=3,0;MQSB=0.992419;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,42,255:14:0:0:8,6,0,0:14,0 0,9,110:3:0:0:2,1,0,0:3,0 0,30,244:10:0:0:6,4,0,0:10,0 +17 409 . T <*> 0 . DP=29;DPR=29,0;I16=17,12,0,0,1100,42734,0,0,1678,98882,0,0,525,11503,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,42,255:14:0:0:8,6,0,0:14,0 0,12,131:4:0:0:2,2,0,0:4,0 0,33,255:11:0:0:7,4,0,0:11,0 +17 410 . T <*> 0 . DP=29;DPR=29,0;I16=17,12,0,0,1035,38325,0,0,1678,98882,0,0,524,11432,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,42,255:14:0:0:8,6,0,0:14,0 0,12,125:4:0:0:2,2,0,0:4,0 0,33,255:11:0:0:7,4,0,0:11,0 +17 411 . T <*> 0 . DP=29;DPR=27,0;I16=17,10,0,0,1003,37747,0,0,1558,91682,0,0,496,10716,0,0;QS=3,0;MQSB=0.984677;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,42,255:14:0:0:8,6,0,0:14,0 0,9,104:3:0:0:2,1,0,0:3,0 0,30,255:10:0:0:7,3,0,0:10,0 +17 412 . C T,<*> 0 . DP=30;DPR=29,1,0;I16=17,12,1,0,1094,42458,14,196,1678,98882,60,3600,495,10659,25,625;QS=2.97455,0.0254545,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.991968;BQB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,30,255,42,255,255:15:1:0:8,6,1,0:14,1,0 0,12,124,12,124,124:4:0:0:2,2,0,0:4,0,0 0,33,255,33,255,255:11:0:0:7,4,0,0:11,0,0 +17 413 . A <*> 0 . DP=31;DPR=31,0;I16=18,13,0,0,1189,45985,0,0,1798,106082,0,0,520,11258,0,0;QS=3,0;MQSB=0.995005;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,51,255:17:0:0:9,8,0,0:17,0 0,9,102:3:0:0:2,1,0,0:3,0 0,33,255:11:0:0:7,4,0,0:11,0 +17 414 . T <*> 0 . DP=30;DPR=30,0;I16=18,12,0,0,1151,44355,0,0,1738,102482,0,0,523,11265,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,48,255:16:0:0:9,7,0,0:16,0 0,9,109:3:0:0:2,1,0,0:3,0 0,33,255:11:0:0:7,4,0,0:11,0 +17 415 . G <*> 0 . DP=30;DPR=30,0;I16=18,12,0,0,1131,43175,0,0,1738,102482,0,0,526,11306,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,48,255:16:0:0:9,7,0,0:16,0 0,9,110:3:0:0:2,1,0,0:3,0 0,33,255:11:0:0:7,4,0,0:11,0 +17 416 . G <*> 0 . DP=30;DPR=29,0;I16=17,12,0,0,1083,41273,0,0,1678,98882,0,0,514,11156,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,48,255:16:0:0:9,7,0,0:16,0 0,9,114:3:0:0:2,1,0,0:3,0 0,30,253:10:0:0:6,4,0,0:10,0 +17 417 . C <*> 0 . DP=30;DPR=30,0;I16=18,12,0,0,1114,42244,0,0,1738,102482,0,0,531,11439,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,48,255:16:0:0:9,7,0,0:16,0 0,9,108:3:0:0:2,1,0,0:3,0 0,33,255:11:0:0:7,4,0,0:11,0 +17 418 . A <*> 0 . DP=30;DPR=30,0;I16=18,12,0,0,1146,44248,0,0,1738,102482,0,0,532,11478,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,48,255:16:0:0:9,7,0,0:16,0 0,9,111:3:0:0:2,1,0,0:3,0 0,33,255:11:0:0:7,4,0,0:11,0 +17 419 . T <*> 0 . DP=30;DPR=30,0;I16=18,12,0,0,1117,42327,0,0,1738,102482,0,0,532,11498,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,48,255:16:0:0:9,7,0,0:16,0 0,9,112:3:0:0:2,1,0,0:3,0 0,33,255:11:0:0:7,4,0,0:11,0 +17 420 . A <*> 0 . DP=31;DPR=31,0;I16=18,13,0,0,1117,41011,0,0,1798,106082,0,0,532,11550,0,0;QS=3,0;MQSB=0.995005;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,48,255:16:0:0:9,7,0,0:16,0 0,9,108:3:0:0:2,1,0,0:3,0 0,36,255:12:0:0:7,5,0,0:12,0 +17 421 . A <*> 0 . DP=33;DPR=33,0;I16=19,14,0,0,1208,45398,0,0,1887,110523,0,0,533,11635,0,0;QS=3,0;MQSB=0.986656;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,48,255:16:0:0:9,7,0,0:16,0 0,9,113:3:0:0:2,1,0,0:3,0 0,42,255:14:0:0:8,6,0,0:14,0 +17 422 . A <*> 0 . DP=33;DPR=32,0;I16=19,13,0,0,1205,46441,0,0,1827,106923,0,0,510,11082,0,0;QS=3,0;MQSB=0.991023;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,48,255:16:0:0:9,7,0,0:16,0 0,9,116:3:0:0:2,1,0,0:3,0 0,39,255:13:0:0:8,5,0,0:13,0 +17 423 . T <*> 0 . DP=32;DPR=32,0;I16=19,13,0,0,1202,45416,0,0,1827,106923,0,0,538,11818,0,0;QS=3,0;MQSB=0.991023;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,48,255:16:0:0:9,7,0,0:16,0 0,9,110:3:0:0:2,1,0,0:3,0 0,39,255:13:0:0:8,5,0,0:13,0 +17 424 . A <*> 0 . DP=32;DPR=32,0;I16=19,13,0,0,1147,41685,0,0,1827,106923,0,0,539,11867,0,0;QS=3,0;MQSB=0.991023;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,48,255:16:0:0:9,7,0,0:16,0 0,9,106:3:0:0:2,1,0,0:3,0 0,39,255:13:0:0:8,5,0,0:13,0 +17 425 . A <*> 0 . DP=29;DPR=29,0;I16=16,13,0,0,1070,40616,0,0,1647,96123,0,0,542,11900,0,0;QS=3,0;MQSB=0.976248;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,45,255:15:0:0:8,7,0,0:15,0 0,9,111:3:0:0:2,1,0,0:3,0 0,33,249:11:0:0:6,5,0,0:11,0 +17 426 . T <*> 0 . DP=29;DPR=28,0;I16=16,12,0,0,997,36561,0,0,1587,92523,0,0,519,11287,0,0;QS=3,0;MQSB=0.982906;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,45,255:15:0:0:8,7,0,0:15,0 0,9,105:3:0:0:2,1,0,0:3,0 0,30,225:10:0:0:6,4,0,0:10,0 +17 427 . A <*> 0 . DP=29;DPR=29,0;I16=16,13,0,0,1024,37266,0,0,1647,96123,0,0,546,11952,0,0;QS=3,0;MQSB=0.976248;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,45,255:15:0:0:8,7,0,0:15,0 0,9,111:3:0:0:2,1,0,0:3,0 0,33,242:11:0:0:6,5,0,0:11,0 +17 428 . C <*> 0 . DP=29;DPR=29,0;I16=16,13,0,0,1064,39706,0,0,1647,96123,0,0,548,12020,0,0;QS=3,0;MQSB=0.976248;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,45,255:15:0:0:8,7,0,0:15,0 0,9,111:3:0:0:2,1,0,0:3,0 0,33,254:11:0:0:6,5,0,0:11,0 +17 429 . T <*> 0 . DP=30;DPR=30,0;I16=16,14,0,0,1150,44918,0,0,1707,99723,0,0,549,12067,0,0;QS=3,0;MQSB=0.969373;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,48,255:16:0:0:8,8,0,0:16,0 0,9,115:3:0:0:2,1,0,0:3,0 0,33,255:11:0:0:6,5,0,0:11,0 +17 430 . G <*> 0 . DP=30;DPR=30,0;I16=16,14,0,0,1113,42443,0,0,1707,99723,0,0,551,12145,0,0;QS=3,0;MQSB=0.969373;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,48,255:16:0:0:8,8,0,0:16,0 0,9,112:3:0:0:2,1,0,0:3,0 0,33,246:11:0:0:6,5,0,0:11,0 +17 431 . G <*> 0 . DP=30;DPR=28,0;I16=14,14,0,0,1003,36953,0,0,1587,92523,0,0,553,12255,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,45,255:15:0:0:7,8,0,0:15,0 0,9,101:3:0:0:2,1,0,0:3,0 0,30,225:10:0:0:5,5,0,0:10,0 +17 432 . T <*> 0 . DP=28;DPR=28,0;I16=14,14,0,0,1049,39621,0,0,1587,92523,0,0,556,12346,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,45,255:15:0:0:7,8,0,0:15,0 0,9,114:3:0:0:2,1,0,0:3,0 0,30,255:10:0:0:5,5,0,0:10,0 +17 433 . T <*> 0 . DP=28;DPR=26,0;I16=14,12,0,0,949,35443,0,0,1467,85323,0,0,509,11217,0,0;QS=3,0;MQSB=0.967472;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,42,255:14:0:0:7,7,0,0:14,0 0,9,112:3:0:0:2,1,0,0:3,0 0,27,227:9:0:0:5,4,0,0:9,0 +17 434 . T <*> 0 . DP=29;DPR=29,0;I16=15,14,0,0,1036,37654,0,0,1647,96123,0,0,561,12567,0,0;QS=3,0;MQSB=0.960561;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,48,255:16:0:0:8,8,0,0:16,0 0,9,98:3:0:0:2,1,0,0:3,0 0,30,243:10:0:0:5,5,0,0:10,0 +17 435 . A <*> 0 . DP=29;DPR=28,0;I16=15,13,0,0,1024,37970,0,0,1587,92523,0,0,556,12560,0,0;QS=3,0;MQSB=0.968414;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,45,255:15:0:0:8,7,0,0:15,0 0,9,103:3:0:0:2,1,0,0:3,0 0,30,237:10:0:0:5,5,0,0:10,0 +17 436 . T <*> 0 . DP=28;DPR=28,0;I16=14,14,0,0,998,36220,0,0,1587,92523,0,0,564,12654,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,48,255:16:0:0:8,8,0,0:16,0 0,9,110:3:0:0:2,1,0,0:3,0 0,27,223:9:0:0:4,5,0,0:9,0 +17 437 . T <*> 0 . DP=28;DPR=27,0;I16=13,14,0,0,990,36832,0,0,1558,91682,0,0,549,12435,0,0;QS=3,0;MQSB=0.999706;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,48,255:16:0:0:8,8,0,0:16,0 0,9,109:3:0:0:2,1,0,0:3,0 0,24,207:8:0:0:3,5,0,0:8,0 +17 438 . A <*> 0 . DP=28;DPR=27,0;I16=14,13,0,0,972,35640,0,0,1527,88923,0,0,540,12082,0,0;QS=3,0;MQSB=0.9585;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,48,255:16:0:0:8,8,0,0:16,0 0,9,107:3:0:0:2,1,0,0:3,0 0,24,216:8:0:0:4,4,0,0:8,0 +17 439 . C <*> 0 . DP=28;DPR=28,0;I16=14,14,0,0,1055,40273,0,0,1587,92523,0,0,563,12649,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,48,255:16:0:0:8,8,0,0:16,0 0,9,107:3:0:0:2,1,0,0:3,0 0,27,224:9:0:0:4,5,0,0:9,0 +17 440 . A <*> 0 . DP=28;DPR=28,0;I16=14,14,0,0,1095,43251,0,0,1587,92523,0,0,561,12615,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,48,255:16:0:0:8,8,0,0:16,0 0,9,115:3:0:0:2,1,0,0:3,0 0,27,247:9:0:0:4,5,0,0:9,0 +17 441 . G <*> 0 . DP=29;DPR=29,0;I16=15,14,0,0,1068,40344,0,0,1647,96123,0,0,559,12605,0,0;QS=3,0;MQSB=0.960561;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,51,255:17:0:0:9,8,0,0:17,0 0,9,104:3:0:0:2,1,0,0:3,0 0,27,198:9:0:0:4,5,0,0:9,0 +17 442 . A <*> 0 . DP=29;DPR=29,0;I16=15,14,0,0,1091,41507,0,0,1647,96123,0,0,558,12620,0,0;QS=3,0;MQSB=0.960561;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,51,255:17:0:0:9,8,0,0:17,0 0,9,112:3:0:0:2,1,0,0:3,0 0,27,233:9:0:0:4,5,0,0:9,0 +17 443 . A <*> 0 . DP=30;DPR=29,0;I16=15,14,0,0,1173,49439,0,0,1647,96123,0,0,557,12661,0,0;QS=3,0;MQSB=0.960561;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,51,255:17:0:0:9,8,0,0:17,0 0,9,129:3:0:0:2,1,0,0:3,0 0,27,246:9:0:0:4,5,0,0:9,0 +17 444 . G <*> 0 . DP=29;DPR=28,0;I16=15,13,0,0,1095,44661,0,0,1587,92523,0,0,557,12727,0,0;QS=3,0;MQSB=0.968414;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,51,255:17:0:0:9,8,0,0:17,0 0,6,91:2:0:0:2,0,0,0:2,0 0,27,227:9:0:0:4,5,0,0:9,0 +17 445 . C <*> 0 . DP=30;DPR=29,0;I16=16,13,0,0,1100,43706,0,0,1647,96123,0,0,557,12817,0,0;QS=3,0;MQSB=0.976248;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,51,255:17:0:0:9,8,0,0:17,0 0,9,111:3:0:0:3,0,0,0:3,0 0,27,219:9:0:0:4,5,0,0:9,0 +17 446 . A <*> 0 . DP=30;DPR=29,0;I16=16,13,0,0,1107,44265,0,0,1647,96123,0,0,557,12881,0,0;QS=3,0;MQSB=0.976248;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,51,255:17:0:0:9,8,0,0:17,0 0,9,115:3:0:0:3,0,0,0:3,0 0,27,232:9:0:0:4,5,0,0:9,0 +17 447 . C <*> 0 . DP=29;DPR=28,0;I16=16,12,0,0,1108,45364,0,0,1618,95282,0,0,555,12817,0,0;QS=3,0;MQSB=0.856268;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,48,255:16:0:0:9,7,0,0:16,0 0,9,114:3:0:0:3,0,0,0:3,0 0,27,235:9:0:0:4,5,0,0:9,0 +17 448 . T <*> 0 . DP=29;DPR=28,0;I16=16,12,0,0,1125,47237,0,0,1618,95282,0,0,553,12773,0,0;QS=3,0;MQSB=0.856268;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,48,255:16:0:0:9,7,0,0:16,0 0,9,118:3:0:0:3,0,0,0:3,0 0,27,240:9:0:0:4,5,0,0:9,0 +17 449 . A <*> 0 . DP=28;DPR=27,0;I16=15,12,0,0,1091,45981,0,0,1558,91682,0,0,552,12748,0,0;QS=3,0;MQSB=0.84246;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,48,255:16:0:0:9,7,0,0:16,0 0,6,90:2:0:0:2,0,0,0:2,0 0,27,245:9:0:0:4,5,0,0:9,0 +17 450 . G <*> 0 . DP=28;DPR=27,0;I16=15,12,0,0,1069,44603,0,0,1558,91682,0,0,551,12741,0,0;QS=3,0;MQSB=0.84246;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,48,255:16:0:0:9,7,0,0:16,0 0,6,91:2:0:0:2,0,0,0:2,0 0,27,233:9:0:0:4,5,0,0:9,0 +17 451 . A <*> 0 . DP=28;DPR=27,0;I16=15,12,0,0,1021,41371,0,0,1558,91682,0,0,550,12752,0,0;QS=3,0;MQSB=0.84246;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,48,255:16:0:0:9,7,0,0:16,0 0,6,93:2:0:0:2,0,0,0:2,0 0,27,244:9:0:0:4,5,0,0:9,0 +17 452 . A <*> 0 . DP=31;DPR=29,0;I16=18,11,0,0,1079,43353,0,0,1678,98882,0,0,530,12420,0,0;QS=3,0;MQSB=0.884952;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,54,255:18:0:0:11,7,0,0:18,0 0,9,110:3:0:0:3,0,0,0:3,0 0,24,225:8:0:0:4,4,0,0:8,0 +17 453 . A <*> 0 . DP=31;DPR=28,0;I16=17,11,0,0,1037,41069,0,0,1649,98041,0,0,508,11882,0,0;QS=3,0;MQSB=0.967085;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,54,255:18:0:0:11,7,0,0:18,0 0,9,111:3:0:0:3,0,0,0:3,0 0,21,221:7:0:0:3,4,0,0:7,0 +17 454 . A <*> 0 . DP=31;DPR=30,0;I16=18,12,0,0,1158,47028,0,0,1738,102482,0,0,554,12904,0,0;QS=3,0;MQSB=0.878946;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,51,255:17:0:0:10,7,0,0:17,0 0,9,113:3:0:0:3,0,0,0:3,0 0,30,255:10:0:0:5,5,0,0:10,0 +17 455 . T <*> 0 . DP=32;DPR=30,0;I16=17,13,0,0,1148,46574,0,0,1715,100251,0,0,550,12864,0,0;QS=3,0;MQSB=0.973855;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,48,255:16:0:0:9,7,0,0:16,0 0,9,113:3:0:0:3,0,0,0:3,0 0,33,255:11:0:0:5,6,0,0:11,0 +17 456 . G <*> 0 . DP=32;DPR=30,0;I16=17,13,0,0,1161,47287,0,0,1746,103010,0,0,534,12296,0,0;QS=3,0;MQSB=0.998031;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,51,255:17:0:0:10,7,0,0:17,0 0,9,116:3:0:0:3,0,0,0:3,0 0,30,245:10:0:0:4,6,0,0:10,0 +17 457 . C <*> 0 . DP=33;DPR=32,0;I16=19,13,0,0,1218,48642,0,0,1835,107451,0,0,563,12967,0,0;QS=3,0;MQSB=0.985204;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,54,255:18:0:0:11,7,0,0:18,0 0,9,118:3:0:0:3,0,0,0:3,0 0,33,255:11:0:0:5,6,0,0:11,0 +17 458 . A <*> 0 . DP=33;DPR=32,0;I16=19,13,0,0,1226,49034,0,0,1835,107451,0,0,568,12990,0,0;QS=3,0;MQSB=0.985204;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,54,255:18:0:0:11,7,0,0:18,0 0,9,111:3:0:0:3,0,0,0:3,0 0,33,255:11:0:0:5,6,0,0:11,0 +17 459 . T <*> 0 . DP=33;DPR=31,0;I16=18,13,0,0,1167,46981,0,0,1775,103851,0,0,565,12945,0,0;QS=3,0;MQSB=0.980167;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,54,255:18:0:0:11,7,0,0:18,0 0,6,92:2:0:0:2,0,0,0:2,0 0,33,255:11:0:0:5,6,0,0:11,0 +17 460 . G <*> 0 . DP=32;DPR=31,0;I16=19,12,0,0,1219,50105,0,0,1775,103851,0,0,575,12929,0,0;QS=3,0;MQSB=0.989977;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,54,255:18:0:0:11,7,0,0:18,0 0,9,116:3:0:0:3,0,0,0:3,0 0,30,255:10:0:0:5,5,0,0:10,0 +17 461 . T <*> 0 . DP=32;DPR=31,0;I16=19,12,0,0,1213,49819,0,0,1775,103851,0,0,577,12845,0,0;QS=3,0;MQSB=0.989977;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,54,255:18:0:0:11,7,0,0:18,0 0,9,115:3:0:0:3,0,0,0:3,0 0,30,255:10:0:0:5,5,0,0:10,0 +17 462 . G <*> 0 . DP=32;DPR=31,0;I16=19,12,0,0,1190,48962,0,0,1775,103851,0,0,580,12792,0,0;QS=3,0;MQSB=0.989977;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,51,255:17:0:0:10,7,0,0:17,0 0,12,119:4:0:0:4,0,0,0:4,0 0,30,241:10:0:0:5,5,0,0:10,0 +17 463 . G <*> 0 . DP=32;DPR=31,0;I16=19,12,0,0,1114,44214,0,0,1775,103851,0,0,584,12770,0,0;QS=3,0;MQSB=0.989977;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,51,255:17:0:0:10,7,0,0:17,0 0,12,114:4:0:0:4,0,0,0:4,0 0,30,221:10:0:0:5,5,0,0:10,0 +17 464 . A <*> 0 . DP=32;DPR=29,0;I16=18,11,0,0,1100,43908,0,0,1686,99410,0,0,556,12106,0,0;QS=3,0;MQSB=0.99095;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,51,255:17:0:0:10,7,0,0:17,0 0,12,133:4:0:0:4,0,0,0:4,0 0,24,213:8:0:0:4,4,0,0:8,0 +17 465 . C <*> 0 . DP=33;DPR=31,0;I16=20,11,0,0,1191,48085,0,0,1775,103851,0,0,586,12786,0,0;QS=3,0;MQSB=0.996597;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,51,255:17:0:0:10,7,0,0:17,0 0,15,140:5:0:0:5,0,0,0:5,0 0,27,231:9:0:0:5,4,0,0:9,0 +17 466 . A <*> 0 . DP=34;DPR=33,0;I16=21,12,0,0,1293,53311,0,0,1895,111051,0,0,597,12897,0,0;QS=3,0;MQSB=0.995633;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,54,255:18:0:0:11,7,0,0:18,0 0,15,154:5:0:0:5,0,0,0:5,0 0,30,255:10:0:0:5,5,0,0:10,0 +17 467 . A <*> 0 . DP=34;DPR=32,0;I16=21,11,0,0,1256,51450,0,0,1835,107451,0,0,597,12891,0,0;QS=3,0;MQSB=0.998231;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,54,255:18:0:0:11,7,0,0:18,0 0,15,157:5:0:0:5,0,0,0:5,0 0,27,248:9:0:0:5,4,0,0:9,0 +17 468 . A <*> 0 . DP=35;DPR=34,0;I16=22,12,0,0,1274,51268,0,0,1955,114651,0,0,604,12904,0,0;QS=3,0;MQSB=0.997406;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,57,255:19:0:0:12,7,0,0:19,0 0,15,154:5:0:0:5,0,0,0:5,0 0,30,251:10:0:0:5,5,0,0:10,0 +17 469 . A <*> 0 . DP=35;DPR=34,0;I16=22,12,0,0,1285,52989,0,0,1955,114651,0,0,608,12940,0,0;QS=3,0;MQSB=0.997406;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,57,255:19:0:0:12,7,0,0:19,0 0,15,146:5:0:0:5,0,0,0:5,0 0,30,255:10:0:0:5,5,0,0:10,0 +17 470 . G <*> 0 . DP=35;DPR=34,0;I16=22,12,0,0,1281,51055,0,0,1955,114651,0,0,612,13016,0,0;QS=3,0;MQSB=0.997406;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,57,255:19:0:0:12,7,0,0:19,0 0,15,148:5:0:0:5,0,0,0:5,0 0,30,238:10:0:0:5,5,0,0:10,0 +17 471 . T <*> 0 . DP=36;DPR=33,0;I16=22,11,0,0,1239,49021,0,0,1918,113282,0,0,599,12825,0,0;QS=3,0;MQSB=0.915545;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,57,255:19:0:0:12,7,0,0:19,0 0,15,150:5:0:0:5,0,0,0:5,0 0,27,232:9:0:0:5,4,0,0:9,0 +17 472 . T <*> 0 . DP=35;DPR=33,0;I16=21,12,0,0,1245,48915,0,0,1926,113810,0,0,595,12559,0,0;QS=3,0;MQSB=0.988858;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,57,255:19:0:0:12,7,0,0:19,0 0,15,153:5:0:0:5,0,0,0:5,0 0,27,237:9:0:0:4,5,0,0:9,0 +17 473 . G <*> 0 . DP=35;DPR=33,0;I16=21,12,0,0,1307,53473,0,0,1926,113810,0,0,599,12651,0,0;QS=3,0;MQSB=0.988858;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,57,255:19:0:0:12,7,0,0:19,0 0,15,141:5:0:0:5,0,0,0:5,0 0,27,249:9:0:0:4,5,0,0:9,0 +17 474 . G <*> 0 . DP=36;DPR=34,0;I16=22,12,0,0,1284,51708,0,0,1986,117410,0,0,602,12734,0,0;QS=3,0;MQSB=0.986937;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,57,255:19:0:0:12,7,0,0:19,0 0,15,131:5:0:0:5,0,0,0:5,0 0,30,255:10:0:0:5,5,0,0:10,0 +17 475 . G <*> 0 . DP=36;DPR=35,0;I16=23,12,0,0,1311,51609,0,0,2015,118251,0,0,631,13485,0,0;QS=3,0;MQSB=0.998642;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,57,255:19:0:0:12,7,0,0:19,0 0,15,141:5:0:0:5,0,0,0:5,0 0,33,252:11:0:0:6,5,0,0:11,0 +17 476 . A <*> 0 . DP=36;DPR=35,0;I16=23,12,0,0,1312,52078,0,0,2015,118251,0,0,634,13606,0,0;QS=3,0;MQSB=0.998642;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,57,255:19:0:0:12,7,0,0:19,0 0,15,157:5:0:0:5,0,0,0:5,0 0,33,255:11:0:0:6,5,0,0:11,0 +17 477 . T <*> 0 . DP=36;DPR=35,0;I16=23,12,0,0,1318,52668,0,0,2015,118251,0,0,637,13773,0,0;QS=3,0;MQSB=0.998642;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,57,255:19:0:0:12,7,0,0:19,0 0,15,148:5:0:0:5,0,0,0:5,0 0,33,255:11:0:0:6,5,0,0:11,0 +17 478 . T <*> 0 . DP=38;DPR=37,0;I16=25,12,0,0,1338,51774,0,0,2135,125451,0,0,637,13833,0,0;QS=3,0;MQSB=0.999868;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,60,255:20:0:0:13,7,0,0:20,0 0,18,154:6:0:0:6,0,0,0:6,0 0,33,255:11:0:0:6,5,0,0:11,0 +17 479 . A <*> 0 . DP=38;DPR=37,0;I16=25,12,0,0,1420,57788,0,0,2135,125451,0,0,639,13935,0,0;QS=3,0;MQSB=0.999868;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,60,255:20:0:0:13,7,0,0:20,0 0,18,163:6:0:0:6,0,0,0:6,0 0,33,255:11:0:0:6,5,0,0:11,0 +17 480 . G <*> 0 . DP=37;DPR=36,0;I16=25,11,0,0,1438,60172,0,0,2075,121851,0,0,641,14029,0,0;QS=3,0;MQSB=0.999853;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,57,255:19:0:0:13,6,0,0:19,0 0,18,165:6:0:0:6,0,0,0:6,0 0,33,255:11:0:0:6,5,0,0:11,0 +17 481 . G <*> 0 . DP=37;DPR=36,0;I16=25,11,0,0,1392,55824,0,0,2075,121851,0,0,642,14112,0,0;QS=3,0;MQSB=0.999853;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,57,255:19:0:0:13,6,0,0:19,0 0,18,165:6:0:0:6,0,0,0:6,0 0,33,255:11:0:0:6,5,0,0:11,0 +17 482 . A <*> 0 . DP=37;DPR=35,0;I16=24,11,0,0,1352,55134,0,0,2015,118251,0,0,618,13608,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,57,255:19:0:0:13,6,0,0:19,0 0,15,143:5:0:0:5,0,0,0:5,0 0,33,255:11:0:0:6,5,0,0:11,0 +17 483 . G <*> 0 . DP=37;DPR=36,0;I16=24,12,0,0,1417,57747,0,0,2075,121851,0,0,642,14240,0,0;QS=3,0;MQSB=0.999437;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,57,255:19:0:0:12,7,0,0:19,0 0,18,165:6:0:0:6,0,0,0:6,0 0,33,255:11:0:0:6,5,0,0:11,0 +17 484 . A <*> 0 . DP=36;DPR=35,0;I16=24,11,0,0,1340,53992,0,0,2015,118251,0,0,643,14281,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,54,255:18:0:0:12,6,0,0:18,0 0,18,168:6:0:0:6,0,0,0:6,0 0,33,255:11:0:0:6,5,0,0:11,0 +17 485 . G <*> 0 . DP=35;DPR=35,0;I16=23,12,0,0,1329,51411,0,0,2015,118251,0,0,669,14931,0,0;QS=3,0;MQSB=0.998642;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,54,255:18:0:0:12,6,0,0:18,0 0,18,160:6:0:0:5,1,0,0:6,0 0,33,255:11:0:0:6,5,0,0:11,0 +17 486 . A <*> 0 . DP=34;DPR=34,0;I16=22,12,0,0,1311,51523,0,0,1955,114651,0,0,671,14989,0,0;QS=3,0;MQSB=0.997406;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,51,255:17:0:0:11,6,0,0:17,0 0,18,173:6:0:0:5,1,0,0:6,0 0,33,255:11:0:0:6,5,0,0:11,0 +17 487 . G <*> 0 . DP=34;DPR=34,0;I16=22,12,0,0,1306,50760,0,0,1955,114651,0,0,672,15030,0,0;QS=3,0;MQSB=0.997406;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,51,255:17:0:0:11,6,0,0:17,0 0,18,169:6:0:0:5,1,0,0:6,0 0,33,255:11:0:0:6,5,0,0:11,0 +17 488 . A <*> 0 . DP=35;DPR=34,0;I16=22,12,0,0,1274,48140,0,0,1986,117410,0,0,646,14380,0,0;QS=3,0;MQSB=0.986937;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,54,255:18:0:0:12,6,0,0:18,0 0,18,177:6:0:0:5,1,0,0:6,0 0,30,255:10:0:0:5,5,0,0:10,0 +17 489 . A <*> 0 . DP=35;DPR=35,0;I16=23,12,0,0,1264,46916,0,0,2015,118251,0,0,671,15015,0,0;QS=3,0;MQSB=0.998642;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,54,255:18:0:0:12,6,0,0:18,0 0,18,175:6:0:0:5,1,0,0:6,0 0,33,255:11:0:0:6,5,0,0:11,0 +17 490 . A <*> 0 . DP=36;DPR=36,0;I16=24,12,0,0,1332,50280,0,0,2075,121851,0,0,671,15061,0,0;QS=3,0;MQSB=0.999437;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,54,255:18:0:0:12,6,0,0:18,0 0,21,188:7:0:0:6,1,0,0:7,0 0,33,255:11:0:0:6,5,0,0:11,0 +17 491 . T <*> 0 . DP=36;DPR=36,0;I16=24,12,0,0,1284,46802,0,0,2075,121851,0,0,671,15093,0,0;QS=3,0;MQSB=0.999437;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,54,255:18:0:0:12,6,0,0:18,0 0,21,178:7:0:0:6,1,0,0:7,0 0,33,255:11:0:0:6,5,0,0:11,0 +17 492 . G <*> 0 . DP=35;DPR=33,0;I16=21,12,0,0,1252,48326,0,0,1926,113810,0,0,621,13859,0,0;QS=3,0;MQSB=0.988858;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,51,255:17:0:0:11,6,0,0:17,0 0,18,172:6:0:0:5,1,0,0:6,0 0,30,251:10:0:0:5,5,0,0:10,0 +17 493 . A <*> 0 . DP=34;DPR=33,0;I16=22,11,0,0,1273,49481,0,0,1926,113810,0,0,650,14672,0,0;QS=3,0;MQSB=0.981935;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,54,255:18:0:0:12,6,0,0:18,0 0,21,186:7:0:0:6,1,0,0:7,0 0,24,240:8:0:0:4,4,0,0:8,0 +17 494 . A <*> 0 . DP=34;DPR=34,0;I16=22,12,0,0,1326,52604,0,0,1986,117410,0,0,672,15182,0,0;QS=3,0;MQSB=0.986937;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,54,255:18:0:0:12,6,0,0:18,0 0,21,196:7:0:0:6,1,0,0:7,0 0,27,255:9:0:0:4,5,0,0:9,0 +17 495 . G <*> 0 . DP=34;DPR=33,0;I16=21,12,0,0,1255,48577,0,0,1926,113810,0,0,647,14611,0,0;QS=3,0;MQSB=0.988858;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,54,255:18:0:0:12,6,0,0:18,0 0,18,168:6:0:0:5,1,0,0:6,0 0,27,244:9:0:0:4,5,0,0:9,0 +17 496 . A <*> 0 . DP=34;DPR=34,0;I16=22,12,0,0,1250,46926,0,0,1986,117410,0,0,670,15220,0,0;QS=3,0;MQSB=0.986937;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,54,255:18:0:0:12,6,0,0:18,0 0,21,186:7:0:0:6,1,0,0:7,0 0,27,249:9:0:0:4,5,0,0:9,0 +17 497 . C <*> 0 . DP=34;DPR=34,0;I16=22,12,0,0,1250,47006,0,0,1986,117410,0,0,665,15087,0,0;QS=3,0;MQSB=0.986937;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,54,255:18:0:0:12,6,0,0:18,0 0,21,164:7:0:0:6,1,0,0:7,0 0,27,239:9:0:0:4,5,0,0:9,0 +17 498 . A <*> 0 . DP=34;DPR=34,0;I16=22,12,0,0,1286,49158,0,0,1986,117410,0,0,661,14987,0,0;QS=3,0;MQSB=0.986937;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,54,255:18:0:0:12,6,0,0:18,0 0,21,185:7:0:0:6,1,0,0:7,0 0,27,252:9:0:0:4,5,0,0:9,0 +17 499 . T <*> 0 . DP=34;DPR=34,0;I16=23,11,0,0,1224,45284,0,0,1986,117410,0,0,659,14919,0,0;QS=3,0;MQSB=0.979712;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,51,255:17:0:0:12,5,0,0:17,0 0,21,183:7:0:0:6,1,0,0:7,0 0,30,255:10:0:0:5,5,0,0:10,0 +17 500 . A <*> 0 . DP=34;DPR=34,0;I16=23,11,0,0,1230,45152,0,0,1986,117410,0,0,657,14833,0,0;QS=3,0;MQSB=0.979712;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,51,255:17:0:0:12,5,0,0:17,0 0,21,179:7:0:0:6,1,0,0:7,0 0,30,255:10:0:0:5,5,0,0:10,0 +17 501 . T <*> 0 . DP=33;DPR=33,0;I16=23,10,0,0,1241,47167,0,0,1926,113810,0,0,656,14778,0,0;QS=3,0;MQSB=0.972757;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,51,255:17:0:0:12,5,0,0:17,0 0,21,186:7:0:0:6,1,0,0:7,0 0,27,241:9:0:0:5,4,0,0:9,0 +17 502 . G <*> 0 . DP=33;DPR=33,0;I16=23,10,0,0,1215,45829,0,0,1926,113810,0,0,655,14753,0,0;QS=3,0;MQSB=0.972757;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,51,255:17:0:0:12,5,0,0:17,0 0,21,183:7:0:0:6,1,0,0:7,0 0,27,235:9:0:0:5,4,0,0:9,0 +17 503 . T <*> 0 . DP=34;DPR=34,0;I16=23,11,0,0,1194,43366,0,0,1986,117410,0,0,654,14758,0,0;QS=3,0;MQSB=0.979712;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,54,255:18:0:0:12,6,0,0:18,0 0,21,177:7:0:0:6,1,0,0:7,0 0,27,234:9:0:0:5,4,0,0:9,0 +17 504 . C <*> 0 . DP=34;DPR=34,0;I16=23,11,0,0,1218,45552,0,0,1986,117410,0,0,651,14643,0,0;QS=3,0;MQSB=0.979712;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,54,255:18:0:0:12,6,0,0:18,0 0,21,183:7:0:0:6,1,0,0:7,0 0,27,219:9:0:0:5,4,0,0:9,0 +17 505 . C <*> 0 . DP=35;DPR=34,0;I16=23,11,0,0,1207,44321,0,0,1986,117410,0,0,641,14509,0,0;QS=3,0;MQSB=0.979712;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,54,255:18:0:0:12,6,0,0:18,0 0,21,189:7:0:0:6,1,0,0:7,0 0,27,221:9:0:0:5,4,0,0:9,0 +17 506 . A <*> 0 . DP=35;DPR=35,0;I16=24,11,0,0,1266,46776,0,0,2046,121010,0,0,646,14504,0,0;QS=3,0;MQSB=0.977529;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,57,255:19:0:0:13,6,0,0:19,0 0,21,188:7:0:0:6,1,0,0:7,0 0,27,231:9:0:0:5,4,0,0:9,0 +17 507 . C <*> 0 . DP=35;DPR=34,0;I16=23,11,0,0,1220,45016,0,0,1986,117410,0,0,635,14401,0,0;QS=3,0;MQSB=0.979712;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,54,255:18:0:0:12,6,0,0:18,0 0,21,183:7:0:0:6,1,0,0:7,0 0,27,226:9:0:0:5,4,0,0:9,0 +17 508 . A <*> 0 . DP=34;DPR=34,0;I16=24,10,0,0,1204,44542,0,0,1986,117410,0,0,643,14491,0,0;QS=3,0;MQSB=0.970272;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,54,255:18:0:0:13,5,0,0:18,0 0,21,189:7:0:0:6,1,0,0:7,0 0,27,220:9:0:0:5,4,0,0:9,0 +17 509 . C <*> 0 . DP=34;DPR=34,0;I16=24,10,0,0,1272,48272,0,0,1986,117410,0,0,640,14430,0,0;QS=3,0;MQSB=0.970272;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,54,255:18:0:0:13,5,0,0:18,0 0,21,186:7:0:0:6,1,0,0:7,0 0,27,241:9:0:0:5,4,0,0:9,0 +17 510 . A <*> 0 . DP=34;DPR=33,0;I16=22,11,0,0,1194,44196,0,0,1926,113810,0,0,613,13773,0,0;QS=3,0;MQSB=0.981935;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,54,255:18:0:0:12,6,0,0:18,0 0,21,187:7:0:0:6,1,0,0:7,0 0,24,221:8:0:0:4,4,0,0:8,0 +17 511 . A <*> 0 . DP=34;DPR=34,0;I16=23,11,0,0,1222,45562,0,0,1986,117410,0,0,637,14395,0,0;QS=3,0;MQSB=0.979712;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,57,255:19:0:0:13,6,0,0:19,0 0,21,195:7:0:0:6,1,0,0:7,0 0,24,233:8:0:0:4,4,0,0:8,0 +17 512 . A C,<*> 0 . DP=33;DPR=32,1,0;I16=22,10,0,1,1121,40793,13,169,1866,110210,60,3600,628,14340,9,81;QS=2.97719,0.022807,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.981935;BQB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,39,255,51,255,255:18:1:0:12,5,0,1:17,1,0 0,21,183,21,183,183:7:0:0:6,1,0,0:7,0,0 0,24,231,24,231,231:8:0:0:4,4,0,0:8,0,0 +17 513 . A <*> 0 . DP=32;DPR=30,0;I16=20,10,0,0,1115,42183,0,0,1746,103010,0,0,598,13624,0,0;QS=3,0;MQSB=0.980594;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,48,255:16:0:0:11,5,0,0:16,0 0,18,175:6:0:0:5,1,0,0:6,0 0,24,233:8:0:0:4,4,0,0:8,0 +17 514 . A T,<*> 0 . DP=32;DPR=29,1,0;I16=20,9,0,1,1066,40004,16,256,1686,99410,60,3600,586,13500,11,121;QS=2.97075,0.0292505,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.980594;BQB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,31,255,45,255,255:16:1:0:11,4,0,1:15,1,0 0,18,171,18,171,171:6:0:0:5,1,0,0:6,0,0 0,24,235,24,235,235:8:0:0:4,4,0,0:8,0,0 +17 515 . C <*> 0 . DP=32;DPR=28,0;I16=18,10,0,0,1010,37294,0,0,1626,95810,0,0,561,12915,0,0;QS=3,0;MQSB=0.986018;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,42,255:14:0:0:9,5,0,0:14,0 0,18,167:6:0:0:5,1,0,0:6,0 0,24,211:8:0:0:4,4,0,0:8,0 +17 516 . C <*> 0 . DP=32;DPR=31,0;I16=21,10,0,0,1100,40570,0,0,1806,106610,0,0,612,13954,0,0;QS=3,0;MQSB=0.977926;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,48,255:16:0:0:11,5,0,0:16,0 0,21,187:7:0:0:6,1,0,0:7,0 0,24,215:8:0:0:4,4,0,0:8,0 +17 517 . T <*> 0 . DP=33;DPR=33,0;I16=23,10,0,0,1269,49995,0,0,1926,113810,0,0,636,14626,0,0;QS=3,0;MQSB=0.972757;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,54,255:18:0:0:13,5,0,0:18,0 0,21,201:7:0:0:6,1,0,0:7,0 0,24,242:8:0:0:4,4,0,0:8,0 +17 518 . G <*> 0 . DP=34;DPR=34,0;I16=24,10,0,0,1247,46839,0,0,1986,117410,0,0,636,14696,0,0;QS=3,0;MQSB=0.970272;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,57,255:19:0:0:14,5,0,0:19,0 0,21,182:7:0:0:6,1,0,0:7,0 0,24,220:8:0:0:4,4,0,0:8,0 +17 519 . T <*> 0 . DP=36;DPR=36,0;I16=25,11,0,0,1283,46693,0,0,2106,124610,0,0,636,14742,0,0;QS=3,0;MQSB=0.975394;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,63,255:21:0:0:15,6,0,0:21,0 0,21,177:7:0:0:6,1,0,0:7,0 0,24,224:8:0:0:4,4,0,0:8,0 +17 520 . T <*> 0 . DP=36;DPR=35,0;I16=24,11,0,0,1238,44894,0,0,2046,121010,0,0,613,14193,0,0;QS=3,0;MQSB=0.977529;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,60,255:20:0:0:14,6,0,0:20,0 0,21,180:7:0:0:6,1,0,0:7,0 0,24,223:8:0:0:4,4,0,0:8,0 +17 521 . C <*> 0 . DP=34;DPR=34,0;I16=25,9,0,0,1280,49454,0,0,1986,117410,0,0,641,14875,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,60,255:20:0:0:15,5,0,0:20,0 0,21,191:7:0:0:6,1,0,0:7,0 0,21,204:7:0:0:4,3,0,0:7,0 +17 522 . A <*> 0 . DP=32;DPR=32,0;I16=24,8,0,0,1158,43228,0,0,1897,112969,0,0,646,14960,0,0;QS=3,0;MQSB=0.872525;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,60,255:20:0:0:15,5,0,0:20,0 0,21,185:7:0:0:6,1,0,0:7,0 0,15,170:5:0:0:3,2,0,0:5,0 +17 523 . T G,<*> 0 . DP=32;DPR=31,1,0;I16=23,8,1,0,1184,45708,15,225,1837,109369,60,3600,626,14446,25,625;QS=2.9794,0.0206044,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.872525;BQB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,44,255,57,255,255:20:1:0:14,5,1,0:19,1,0 0,21,191,21,191,191:7:0:0:6,1,0,0:7,0,0 0,15,166,15,166,166:5:0:0:3,2,0,0:5,0,0 +17 524 . T <*> 0 . DP=32;DPR=31,0;I16=24,7,0,0,1084,39474,0,0,1837,109369,0,0,629,14483,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,60,255:20:0:0:15,5,0,0:20,0 0,21,194:7:0:0:6,1,0,0:7,0 0,12,140:4:0:0:3,1,0,0:4,0 +17 525 . G <*> 0 . DP=32;DPR=31,0;I16=24,7,0,0,1181,45669,0,0,1837,109369,0,0,631,14495,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,60,255:20:0:0:15,5,0,0:20,0 0,21,188:7:0:0:6,1,0,0:7,0 0,12,129:4:0:0:3,1,0,0:4,0 +17 526 . C <*> 0 . DP=32;DPR=31,0;I16=24,7,0,0,1146,43950,0,0,1860,111600,0,0,633,14531,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,60,255:20:0:0:15,5,0,0:20,0 0,21,185:7:0:0:6,1,0,0:7,0 0,12,131:4:0:0:3,1,0,0:4,0 +17 527 . A <*> 0 . DP=33;DPR=32,0;I16=24,8,0,0,1209,46265,0,0,1897,112969,0,0,636,14634,0,0;QS=3,0;MQSB=0.872525;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,57,255:19:0:0:14,5,0,0:19,0 0,21,194:7:0:0:6,1,0,0:7,0 0,18,181:6:0:0:4,2,0,0:6,0 +17 528 . G <*> 0 . DP=33;DPR=32,0;I16=24,8,0,0,1256,49824,0,0,1897,112969,0,0,634,14484,0,0;QS=3,0;MQSB=0.872525;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,60,255:20:0:0:15,5,0,0:20,0 0,18,169:6:0:0:5,1,0,0:6,0 0,18,193:6:0:0:4,2,0,0:6,0 +17 529 . C <*> 0 . DP=32;DPR=31,0;I16=24,7,0,0,1148,44362,0,0,1837,109369,0,0,633,14357,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,54,255:18:0:0:14,4,0,0:18,0 0,21,187:7:0:0:6,1,0,0:7,0 0,18,184:6:0:0:4,2,0,0:6,0 +17 530 . T <*> 0 . DP=32;DPR=32,0;I16=25,7,0,0,1244,49168,0,0,1897,112969,0,0,657,14883,0,0;QS=3,0;MQSB=0.850154;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,57,255:19:0:0:15,4,0,0:19,0 0,21,196:7:0:0:6,1,0,0:7,0 0,18,202:6:0:0:4,2,0,0:6,0 +17 531 . T <*> 0 . DP=32;DPR=32,0;I16=25,7,0,0,1177,44171,0,0,1897,112969,0,0,654,14714,0,0;QS=3,0;MQSB=0.850154;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,57,255:19:0:0:15,4,0,0:19,0 0,21,181:7:0:0:6,1,0,0:7,0 0,18,193:6:0:0:4,2,0,0:6,0 +17 532 . T <*> 0 . DP=32;DPR=31,0;I16=24,7,0,0,1153,43543,0,0,1837,109369,0,0,630,14116,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,54,255:18:0:0:14,4,0,0:18,0 0,21,181:7:0:0:6,1,0,0:7,0 0,18,192:6:0:0:4,2,0,0:6,0 +17 533 . C <*> 0 . DP=32;DPR=31,0;I16=24,7,0,0,1142,43940,0,0,1837,109369,0,0,619,13649,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,54,255:18:0:0:14,4,0,0:18,0 0,21,178:7:0:0:6,1,0,0:7,0 0,18,180:6:0:0:4,2,0,0:6,0 +17 534 . T <*> 0 . DP=31;DPR=30,0;I16=24,6,0,0,1212,49426,0,0,1777,105769,0,0,615,13479,0,0;QS=3,0;MQSB=0.82403;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,51,255:17:0:0:14,3,0,0:17,0 0,21,205:7:0:0:6,1,0,0:7,0 0,18,205:6:0:0:4,2,0,0:6,0 +17 535 . A <*> 0 . DP=31;DPR=30,0;I16=24,6,0,0,1080,39870,0,0,1777,105769,0,0,611,13341,0,0;QS=3,0;MQSB=0.82403;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,51,255:17:0:0:14,3,0,0:17,0 0,21,194:7:0:0:6,1,0,0:7,0 0,18,189:6:0:0:4,2,0,0:6,0 +17 536 . C <*> 0 . DP=31;DPR=31,0;I16=24,7,0,0,1097,40707,0,0,1837,109369,0,0,631,13809,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,54,255:18:0:0:14,4,0,0:18,0 0,21,184:7:0:0:6,1,0,0:7,0 0,18,157:6:0:0:4,2,0,0:6,0 +17 537 . C <*> 0 . DP=31;DPR=29,0;I16=22,7,0,0,1034,38564,0,0,1717,102169,0,0,587,12861,0,0;QS=3,0;MQSB=0.854582;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,48,255:16:0:0:12,4,0,0:16,0 0,21,172:7:0:0:6,1,0,0:7,0 0,18,183:6:0:0:4,2,0,0:6,0 +17 538 . A <*> 0 . DP=31;DPR=31,0;I16=24,7,0,0,1138,42478,0,0,1837,109369,0,0,620,13536,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,54,255:18:0:0:14,4,0,0:18,0 0,21,189:7:0:0:6,1,0,0:7,0 0,18,181:6:0:0:4,2,0,0:6,0 +17 539 . T <*> 0 . DP=31;DPR=31,0;I16=24,7,0,0,1134,42070,0,0,1837,109369,0,0,614,13422,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,54,255:18:0:0:14,4,0,0:18,0 0,21,178:7:0:0:6,1,0,0:7,0 0,18,181:6:0:0:4,2,0,0:6,0 +17 540 . C <*> 0 . DP=31;DPR=31,0;I16=24,7,0,0,1148,43768,0,0,1837,109369,0,0,608,13340,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,54,255:18:0:0:14,4,0,0:18,0 0,21,177:7:0:0:6,1,0,0:7,0 0,18,178:6:0:0:4,2,0,0:6,0 +17 541 . A <*> 0 . DP=32;DPR=30,0;I16=24,6,0,0,1083,40483,0,0,1777,105769,0,0,551,11991,0,0;QS=3,0;MQSB=0.82403;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,51,255:17:0:0:13,4,0,0:17,0 0,24,180:8:0:0:7,1,0,0:8,0 0,15,150:5:0:0:4,1,0,0:5,0 +17 542 . C <*> 0 . DP=33;DPR=31,0;I16=25,6,0,0,1123,41759,0,0,1837,109369,0,0,570,12552,0,0;QS=3,0;MQSB=0.822578;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,51,255:17:0:0:14,3,0,0:17,0 0,24,172:8:0:0:7,1,0,0:8,0 0,18,174:6:0:0:4,2,0,0:6,0 +17 543 . C <*> 0 . DP=34;DPR=34,0;I16=25,9,0,0,1219,45959,0,0,1986,117410,0,0,601,13245,0,0;QS=3,0;MQSB=0.621145;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,57,255:19:0:0:14,5,0,0:19,0 0,27,194:9:0:0:7,2,0,0:9,0 0,18,188:6:0:0:4,2,0,0:6,0 +17 544 . A <*> 0 . DP=33;DPR=32,0;I16=24,8,0,0,1170,43898,0,0,1866,110210,0,0,570,12506,0,0;QS=3,0;MQSB=0.579578;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,54,255:18:0:0:13,5,0,0:18,0 0,24,192:8:0:0:7,1,0,0:8,0 0,18,180:6:0:0:4,2,0,0:6,0 +17 545 . A <*> 0 . DP=33;DPR=33,0;I16=25,8,0,0,1174,43602,0,0,1926,113810,0,0,587,12951,0,0;QS=3,0;MQSB=0.576102;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,57,255:19:0:0:14,5,0,0:19,0 0,24,190:8:0:0:7,1,0,0:8,0 0,18,184:6:0:0:4,2,0,0:6,0 +17 546 . A <*> 0 . DP=32;DPR=32,0;I16=24,8,0,0,1126,41444,0,0,1866,110210,0,0,580,12802,0,0;QS=3,0;MQSB=0.579578;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,57,255:19:0:0:14,5,0,0:19,0 0,21,166:7:0:0:6,1,0,0:7,0 0,18,193:6:0:0:4,2,0,0:6,0 +17 547 . A <*> 0 . DP=32;DPR=31,0;I16=24,7,0,0,1129,42381,0,0,1806,106610,0,0,547,12009,0,0;QS=3,0;MQSB=0.525788;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,54,255:18:0:0:14,4,0,0:18,0 0,21,180:7:0:0:6,1,0,0:7,0 0,18,195:6:0:0:4,2,0,0:6,0 +17 548 . A <*> 0 . DP=33;DPR=32,0;I16=23,9,0,0,1153,42673,0,0,1866,110210,0,0,561,12489,0,0;QS=3,0;MQSB=0.628357;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,54,255:18:0:0:13,5,0,0:18,0 0,21,181:7:0:0:6,1,0,0:7,0 0,21,211:7:0:0:4,3,0,0:7,0 +17 549 . T G,<*> 0 . DP=32;DPR=30,1,0;I16=22,8,0,1,1101,40987,20,400,1746,103010,60,3600,530,11716,25,625;QS=2.96748,0.0325203,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.632337;BQB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,31,255,48,255,255:17:1:0:12,4,0,1:16,1,0 0,21,168,21,168,168:7:0:0:6,1,0,0:7,0,0 0,21,208,21,208,208:7:0:0:4,3,0,0:7,0,0 +17 550 . T <*> 0 . DP=32;DPR=31,0;I16=22,9,0,0,1052,37298,0,0,1806,106610,0,0,548,12176,0,0;QS=3,0;MQSB=0.632337;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,51,255:17:0:0:12,5,0,0:17,0 0,21,150:7:0:0:6,1,0,0:7,0 0,21,220:7:0:0:4,3,0,0:7,0 +17 551 . G <*> 0 . DP=31;DPR=31,0;I16=22,9,0,0,1121,41639,0,0,1806,106610,0,0,541,12045,0,0;QS=3,0;MQSB=0.632337;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,51,255:17:0:0:12,5,0,0:17,0 0,21,172:7:0:0:6,1,0,0:7,0 0,21,208:7:0:0:4,3,0,0:7,0 +17 552 . C <*> 0 . DP=30;DPR=30,0;I16=21,9,0,0,1093,41365,0,0,1746,103010,0,0,535,11947,0,0;QS=3,0;MQSB=0.636601;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,48,255:16:0:0:11,5,0,0:16,0 0,21,167:7:0:0:6,1,0,0:7,0 0,21,208:7:0:0:4,3,0,0:7,0 +17 553 . A <*> 0 . DP=30;DPR=28,0;I16=20,8,0,0,981,35387,0,0,1626,95810,0,0,485,10831,0,0;QS=3,0;MQSB=0.596163;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,45,255:15:0:0:10,5,0,0:15,0 0,18,150:6:0:0:5,1,0,0:6,0 0,21,194:7:0:0:5,2,0,0:7,0 +17 554 . A <*> 0 . DP=30;DPR=28,0;I16=19,9,0,0,975,35601,0,0,1626,95810,0,0,488,10906,0,0;QS=3,0;MQSB=0.646113;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,45,255:15:0:0:10,5,0,0:15,0 0,15,139:5:0:0:4,1,0,0:5,0 0,24,211:8:0:0:5,3,0,0:8,0 +17 555 . A <*> 0 . DP=30;DPR=30,0;I16=20,10,0,0,1024,36526,0,0,1746,103010,0,0,514,11392,0,0;QS=3,0;MQSB=0.679025;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,51,255:17:0:0:11,6,0,0:17,0 0,18,150:6:0:0:5,1,0,0:6,0 0,21,211:7:0:0:4,3,0,0:7,0 +17 556 . C <*> 0 . DP=29;DPR=29,0;I16=20,9,0,0,1055,39195,0,0,1709,101641,0,0,509,11219,0,0;QS=3,0;MQSB=0.894839;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,51,255:17:0:0:11,6,0,0:17,0 0,18,158:6:0:0:5,1,0,0:6,0 0,18,186:6:0:0:4,2,0,0:6,0 +17 557 . A <*> 0 . DP=27;DPR=27,0;I16=18,9,0,0,987,36749,0,0,1589,94441,0,0,506,11074,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,45,255:15:0:0:9,6,0,0:15,0 0,18,157:6:0:0:5,1,0,0:6,0 0,18,186:6:0:0:4,2,0,0:6,0 +17 558 . A <*> 0 . DP=27;DPR=26,0;I16=18,8,0,0,948,35808,0,0,1560,93600,0,0,477,10281,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,45,255:15:0:0:9,6,0,0:15,0 0,15,143:5:0:0:5,0,0,0:5,0 0,18,177:6:0:0:4,2,0,0:6,0 +17 559 . C A,<*> 0 . DP=27;DPR=25,1,0;I16=17,8,0,1,908,33726,14,196,1500,90000,29,841,448,9516,25,625;QS=2.92708,0.0729167,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.90038;BQB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,42,255,42,255,255:14:0:0:8,6,0,0:14,0,0 0,4,116,15,119,123:6:1:0:5,0,0,1:5,1,0 0,18,169,18,169,169:6:0:0:4,2,0,0:6,0,0 +17 560 . C <*> 0 . DP=28;DPR=28,0;I16=19,9,0,0,992,36552,0,0,1649,98041,0,0,494,10654,0,0;QS=3,0;MQSB=0.896555;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,45,255:15:0:0:9,6,0,0:15,0 0,18,160:6:0:0:5,1,0,0:6,0 0,21,181:7:0:0:5,2,0,0:7,0 +17 561 . A <*> 0 . DP=28;DPR=27,0;I16=18,9,0,0,963,35455,0,0,1589,94441,0,0,466,9946,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,42,255:14:0:0:8,6,0,0:14,0 0,18,158:6:0:0:5,1,0,0:6,0 0,21,194:7:0:0:5,2,0,0:7,0 +17 562 . C <*> 0 . DP=28;DPR=27,0;I16=18,9,0,0,1006,38392,0,0,1589,94441,0,0,463,9893,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,42,255:14:0:0:8,6,0,0:14,0 0,18,153:6:0:0:5,1,0,0:6,0 0,21,187:7:0:0:5,2,0,0:7,0 +17 563 . A <*> 0 . DP=27;DPR=26,0;I16=17,9,0,0,893,32413,0,0,1529,90841,0,0,460,9820,0,0;QS=3,0;MQSB=0.90038;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,42,255:14:0:0:8,6,0,0:14,0 0,15,149:5:0:0:4,1,0,0:5,0 0,21,179:7:0:0:5,2,0,0:7,0 +17 564 . C <*> 0 . DP=27;DPR=27,0;I16=18,9,0,0,859,28747,0,0,1589,94441,0,0,482,10402,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,45,255:15:0:0:9,6,0,0:15,0 0,15,121:5:0:0:4,1,0,0:5,0 0,21,182:7:0:0:5,2,0,0:7,0 +17 565 . G <*> 0 . DP=30;DPR=26,0;I16=17,9,0,0,818,26928,0,0,1560,93600,0,0,454,9764,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,45,255:15:0:0:9,6,0,0:15,0 0,12,96:4:0:0:3,1,0,0:4,0 0,21,154:7:0:0:5,2,0,0:7,0 +17 566 . C <*> 0 . DP=29;DPR=26,0;I16=15,11,0,0,903,33405,0,0,1529,90841,0,0,424,9084,0,0;QS=3,0;MQSB=0.927041;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,45,255:15:0:0:7,8,0,0:15,0 0,15,155:5:0:0:3,2,0,0:5,0 0,18,167:6:0:0:5,1,0,0:6,0 +17 567 . C <*> 0 . DP=30;DPR=27,0;I16=15,12,0,0,932,33774,0,0,1589,94441,0,0,462,10178,0,0;QS=3,0;MQSB=0.935229;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,45,255:15:0:0:7,8,0,0:15,0 0,15,155:5:0:0:3,2,0,0:5,0 0,21,196:7:0:0:5,2,0,0:7,0 +17 568 . C <*> 0 . DP=29;DPR=28,0;I16=15,13,0,0,1057,40817,0,0,1649,98041,0,0,482,10438,0,0;QS=3,0;MQSB=0.942064;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,48,255:16:0:0:8,8,0,0:16,0 0,18,183:6:0:0:3,3,0,0:6,0 0,18,189:6:0:0:4,2,0,0:6,0 +17 569 . T <*> 0 . DP=30;DPR=28,0;I16=16,12,0,0,1056,41296,0,0,1649,98041,0,0,493,10655,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,45,255:15:0:0:8,7,0,0:15,0 0,18,190:6:0:0:3,3,0,0:6,0 0,21,213:7:0:0:5,2,0,0:7,0 +17 570 . T <*> 0 . DP=30;DPR=28,0;I16=16,12,0,0,954,34972,0,0,1680,100800,0,0,472,10086,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,48,255:16:0:0:8,8,0,0:16,0 0,15,157:5:0:0:3,2,0,0:5,0 0,21,195:7:0:0:5,2,0,0:7,0 +17 571 . C <*> 0 . DP=31;DPR=29,0;I16=17,12,0,0,1061,40675,0,0,1740,104400,0,0,472,10158,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,51,255:17:0:0:9,8,0,0:17,0 0,15,155:5:0:0:3,2,0,0:5,0 0,21,193:7:0:0:5,2,0,0:7,0 +17 572 . A <*> 0 . DP=31;DPR=30,0;I16=18,12,0,0,1102,42642,0,0,1769,105241,0,0,499,10887,0,0;QS=3,0;MQSB=0.929991;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,51,255:17:0:0:9,8,0,0:17,0 0,21,203:7:0:0:4,3,0,0:7,0 0,18,175:6:0:0:5,1,0,0:6,0 +17 573 . A <*> 0 . DP=31;DPR=30,0;I16=18,12,0,0,1057,38473,0,0,1769,105241,0,0,501,10975,0,0;QS=3,0;MQSB=0.929991;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,51,255:17:0:0:9,8,0,0:17,0 0,21,199:7:0:0:4,3,0,0:7,0 0,18,178:6:0:0:5,1,0,0:6,0 +17 574 . C A,<*> 0 . DP=31;DPR=29,1,0;I16=18,11,0,1,1088,41328,15,225,1740,104400,29,841,478,10422,25,625;QS=2.94071,0.0592885,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.929991;BQB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,48,255,48,255,255:16:0:0:8,8,0,0:16,0,0 0,9,170,21,173,177:8:1:0:5,2,0,1:7,1,0 0,18,173,18,173,173:6:0:0:5,1,0,0:6,0,0 +17 575 . T <*> 0 . DP=30;DPR=26,0;I16=16,10,0,0,1024,41260,0,0,1560,93600,0,0,448,9842,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,42,255:14:0:0:7,7,0,0:14,0 0,21,209:7:0:0:5,2,0,0:7,0 0,15,163:5:0:0:4,1,0,0:5,0 +17 576 . G <*> 0 . DP=30;DPR=29,0;I16=17,12,0,0,1047,40077,0,0,1709,101641,0,0,507,11087,0,0;QS=3,0;MQSB=0.931617;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,48,255:16:0:0:8,8,0,0:16,0 0,24,208:8:0:0:5,3,0,0:8,0 0,15,151:5:0:0:4,1,0,0:5,0 +17 577 . G <*> 0 . DP=30;DPR=28,0;I16=16,12,0,0,999,37747,0,0,1649,98041,0,0,489,10755,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,45,255:15:0:0:7,8,0,0:15,0 0,24,204:8:0:0:5,3,0,0:8,0 0,15,146:5:0:0:4,1,0,0:5,0 +17 578 . G <*> 0 . DP=29;DPR=29,0;I16=16,13,0,0,975,34803,0,0,1709,101641,0,0,520,11286,0,0;QS=3,0;MQSB=0.940317;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,48,255:16:0:0:7,9,0,0:16,0 0,24,198:8:0:0:5,3,0,0:8,0 0,15,151:5:0:0:4,1,0,0:5,0 +17 579 . G <*> 0 . DP=30;DPR=28,0;I16=15,13,0,0,1028,38752,0,0,1649,98041,0,0,484,10514,0,0;QS=3,0;MQSB=0.942064;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,48,255:16:0:0:8,8,0,0:16,0 0,24,224:8:0:0:4,4,0,0:8,0 0,12,145:4:0:0:3,1,0,0:4,0 +17 580 . A C,<*> 0 . DP=30;DPR=29,1,0;I16=15,14,1,0,1060,39178,16,256,1709,101641,60,3600,510,11078,17,289;QS=2.97338,0.0266223,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.946202;BQB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,34,255,48,255,255:17:1:0:7,9,1,0:16,1,0 0,24,221,24,221,221:8:0:0:4,4,0,0:8,0,0 0,15,155,15,155,155:5:0:0:4,1,0,0:5,0,0 +17 581 . A <*> 0 . DP=31;DPR=31,0;I16=16,15,0,0,1083,39215,0,0,1829,108841,0,0,530,11384,0,0;QS=3,0;MQSB=0.951229;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,54,255:18:0:0:8,10,0,0:18,0 0,24,223:8:0:0:4,4,0,0:8,0 0,15,153:5:0:0:4,1,0,0:5,0 +17 582 . C <*> 0 . DP=31;DPR=30,0;I16=15,15,0,0,1080,39870,0,0,1769,105241,0,0,519,11211,0,0;QS=3,0;MQSB=0.952765;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,51,255:17:0:0:7,10,0,0:17,0 0,24,207:8:0:0:4,4,0,0:8,0 0,15,151:5:0:0:4,1,0,0:5,0 +17 583 . T <*> 0 . DP=30;DPR=30,0;I16=16,14,0,0,1136,43996,0,0,1769,105241,0,0,539,11523,0,0;QS=3,0;MQSB=0.946202;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,51,255:17:0:0:8,9,0,0:17,0 0,24,238:8:0:0:4,4,0,0:8,0 0,15,163:5:0:0:4,1,0,0:5,0 +17 584 . C <*> 0 . DP=31;DPR=29,0;I16=16,13,0,0,1051,39351,0,0,1709,101641,0,0,499,10619,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,51,255:17:0:0:8,9,0,0:17,0 0,21,207:7:0:0:4,3,0,0:7,0 0,15,157:5:0:0:4,1,0,0:5,0 +17 585 . A <*> 0 . DP=31;DPR=31,0;I16=17,14,0,0,1096,39866,0,0,1798,106082,0,0,549,11751,0,0;QS=3,0;MQSB=0.998229;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,54,255:18:0:0:9,9,0,0:18,0 0,24,211:8:0:0:4,4,0,0:8,0 0,15,157:5:0:0:4,1,0,0:5,0 +17 586 . T <*> 0 . DP=31;DPR=30,0;I16=16,14,0,0,1081,39839,0,0,1738,102482,0,0,546,11796,0,0;QS=3,0;MQSB=0.999136;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,51,255:17:0:0:8,9,0,0:17,0 0,24,212:8:0:0:4,4,0,0:8,0 0,15,156:5:0:0:4,1,0,0:5,0 +17 587 . C <*> 0 . DP=31;DPR=30,0;I16=17,13,0,0,1070,39402,0,0,1769,105241,0,0,532,11350,0,0;QS=3,0;MQSB=0.963674;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,54,255:18:0:0:9,9,0,0:18,0 0,21,201:7:0:0:4,3,0,0:7,0 0,15,155:5:0:0:4,1,0,0:5,0 +17 588 . A <*> 0 . DP=31;DPR=31,0;I16=17,14,0,0,1126,41642,0,0,1798,106082,0,0,562,12140,0,0;QS=3,0;MQSB=0.998229;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,54,255:18:0:0:9,9,0,0:18,0 0,24,222:8:0:0:4,4,0,0:8,0 0,15,164:5:0:0:4,1,0,0:5,0 +17 589 . A <*> 0 . DP=31;DPR=31,0;I16=17,14,0,0,1157,43973,0,0,1798,106082,0,0,568,12340,0,0;QS=3,0;MQSB=0.998229;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,54,255:18:0:0:9,9,0,0:18,0 0,24,236:8:0:0:4,4,0,0:8,0 0,15,165:5:0:0:4,1,0,0:5,0 +17 590 . C <*> 0 . DP=32;DPR=30,0;I16=16,14,0,0,1094,41302,0,0,1769,105241,0,0,549,11951,0,0;QS=3,0;MQSB=0.958545;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,54,255:18:0:0:9,9,0,0:18,0 0,18,192:6:0:0:3,3,0,0:6,0 0,18,175:6:0:0:4,2,0,0:6,0 +17 591 . A <*> 0 . DP=31;DPR=31,0;I16=16,15,0,0,1165,44163,0,0,1798,106082,0,0,579,12695,0,0;QS=3,0;MQSB=0.999805;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,54,255:18:0:0:9,9,0,0:18,0 0,21,209:7:0:0:3,4,0,0:7,0 0,18,188:6:0:0:4,2,0,0:6,0 +17 592 . A <*> 0 . DP=31;DPR=30,0;I16=15,15,0,0,1114,42144,0,0,1738,102482,0,0,571,12651,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,51,255:17:0:0:8,9,0,0:17,0 0,21,215:7:0:0:3,4,0,0:7,0 0,18,182:6:0:0:4,2,0,0:6,0 +17 593 . C <*> 0 . DP=31;DPR=29,0;I16=15,14,0,0,1065,39889,0,0,1709,101641,0,0,550,12132,0,0;QS=3,0;MQSB=0.954405;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,51,255:17:0:0:8,9,0,0:17,0 0,18,191:6:0:0:3,3,0,0:6,0 0,18,174:6:0:0:4,2,0,0:6,0 +17 594 . A <*> 0 . DP=33;DPR=32,0;I16=16,16,0,0,1163,42917,0,0,1858,109682,0,0,572,12672,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,51,255:17:0:0:8,9,0,0:17,0 0,21,205:7:0:0:3,4,0,0:7,0 0,24,212:8:0:0:5,3,0,0:8,0 +17 595 . A <*> 0 . DP=33;DPR=33,0;I16=17,16,0,0,1130,39996,0,0,1918,113282,0,0,589,12905,0,0;QS=3,0;MQSB=0.999838;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,54,255:18:0:0:9,9,0,0:18,0 0,21,198:7:0:0:3,4,0,0:7,0 0,24,213:8:0:0:5,3,0,0:8,0 +17 596 . A <*> 0 . DP=33;DPR=32,0;I16=16,16,0,0,1059,37039,0,0,1858,109682,0,0,590,12952,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,51,255:17:0:0:8,9,0,0:17,0 0,21,169:7:0:0:3,4,0,0:7,0 0,24,230:8:0:0:5,3,0,0:8,0 +17 597 . C <*> 0 . DP=33;DPR=33,0;I16=17,16,0,0,1196,44890,0,0,1918,113282,0,0,592,12990,0,0;QS=3,0;MQSB=0.999838;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,54,255:18:0:0:9,9,0,0:18,0 0,21,204:7:0:0:3,4,0,0:7,0 0,24,220:8:0:0:5,3,0,0:8,0 +17 598 . T <*> 0 . DP=33;DPR=32,0;I16=16,16,0,0,1214,47104,0,0,1858,109682,0,0,593,13013,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,51,255:17:0:0:8,9,0,0:17,0 0,21,217:7:0:0:3,4,0,0:7,0 0,24,239:8:0:0:5,3,0,0:8,0 +17 599 . T <*> 0 . DP=33;DPR=33,0;I16=16,17,0,0,1183,43669,0,0,1918,113282,0,0,599,13095,0,0;QS=3,0;MQSB=0.999838;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,51,255:17:0:0:8,9,0,0:17,0 0,21,197:7:0:0:3,4,0,0:7,0 0,27,247:9:0:0:5,4,0,0:9,0 +17 600 . G <*> 0 . DP=32;DPR=32,0;I16=15,17,0,0,1174,44066,0,0,1858,109682,0,0,601,13145,0,0;QS=3,0;MQSB=0.999287;MQ0F=0 PL:DP:DV:SP:DP4:DPR 0,51,255:17:0:0:8,9,0,0:17,0 0,21,194:7:0:0:3,4,0,0:7,0 0,24,232:8:0:0:4,4,0,0:8,0 diff --git a/test/mpileup/mpileup.5.out b/test/mpileup/mpileup.5.out new file mode 100644 index 000000000..5aa9d4aaa --- /dev/null +++ b/test/mpileup/mpileup.5.out @@ -0,0 +1,529 @@ +##fileformat=VCFv4.2 +##FILTER= +##contig= +##ALT= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##FORMAT= +##INFO= +##INFO= +##INFO= +#CHROM POS ID REF ALT QUAL FILTER INFO FORMAT HG00100 HG00101 HG00102 +17 100 . C <*> 0 . DP=18;ADF=17,0;ADR=0,0;AD=17,0;I16=17,0,0,0,688,29762,0,0,958,55682,0,0,332,7446,0,0;QS=3,0;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,27,189:9:0:9,0:0,0:9,0 0,9,108:3:0:3,0:0,0:3,0 0,15,134:5:0:5,0:0,0:5,0 +17 101 . C <*> 0 . DP=18;ADF=17,0;ADR=0,0;AD=17,0;I16=17,0,0,0,650,27530,0,0,958,55682,0,0,331,7303,0,0;QS=3,0;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,27,182:9:0:9,0:0,0:9,0 0,9,99:3:0:3,0:0,0:3,0 0,15,132:5:0:5,0:0,0:5,0 +17 102 . C <*> 0 . DP=18;ADF=17,0;ADR=0,0;AD=17,0;I16=17,0,0,0,695,30453,0,0,958,55682,0,0,330,7178,0,0;QS=3,0;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,27,188:9:0:9,0:0,0:9,0 0,9,111:3:0:3,0:0,0:3,0 0,15,139:5:0:5,0:0,0:5,0 +17 103 . T <*> 0 . DP=18;ADF=16,0;ADR=0,0;AD=16,0;I16=16,0,0,0,692,31998,0,0,929,54841,0,0,323,7035,0,0;QS=3,0;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,24,189:8:0:8,0:0,0:8,0 0,9,108:3:0:3,0:0,0:3,0 0,15,147:5:0:5,0:0,0:5,0 +17 104 . G <*> 0 . DP=18;ADF=15,0;ADR=0,0;AD=15,0;I16=15,0,0,0,611,26723,0,0,900,54000,0,0,295,6259,0,0;QS=3,0;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,24,178:8:0:8,0:0,0:8,0 0,6,89:2:0:2,0:0,0:2,0 0,15,133:5:0:5,0:0,0:5,0 +17 105 . G <*> 0 . DP=19;ADF=17,0;ADR=0,0;AD=17,0;I16=17,0,0,0,604,23936,0,0,989,58441,0,0,317,6751,0,0;QS=3,0;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,27,170:9:0:9,0:0,0:9,0 0,9,97:3:0:3,0:0,0:3,0 0,15,125:5:0:5,0:0,0:5,0 +17 106 . G <*> 0 . DP=19;ADF=17,0;ADR=0,0;AD=17,0;I16=17,0,0,0,644,26574,0,0,989,58441,0,0,299,6093,0,0;QS=3,0;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,30,190:10:0:10,0:0,0:10,0 0,6,85:2:0:2,0:0,0:2,0 0,15,124:5:0:5,0:0,0:5,0 +17 107 . C <*> 0 . DP=19;ADF=17,0;ADR=0,0;AD=17,0;I16=17,0,0,0,694,30064,0,0,989,58441,0,0,313,6543,0,0;QS=3,0;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,27,192:9:0:9,0:0,0:9,0 0,9,108:3:0:3,0:0,0:3,0 0,15,136:5:0:5,0:0,0:5,0 +17 108 . C <*> 0 . DP=19;ADF=17,0;ADR=0,0;AD=17,0;I16=17,0,0,0,692,30148,0,0,989,58441,0,0,310,6420,0,0;QS=3,0;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,27,190:9:0:9,0:0,0:9,0 0,9,108:3:0:3,0:0,0:3,0 0,15,135:5:0:5,0:0,0:5,0 +17 109 . T <*> 0 . DP=19;ADF=17,0;ADR=0,0;AD=17,0;I16=17,0,0,0,741,34273,0,0,989,58441,0,0,307,6319,0,0;QS=3,0;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,27,195:9:0:9,0:0,0:9,0 0,9,110:3:0:3,0:0,0:3,0 0,15,150:5:0:5,0:0,0:5,0 +17 110 . G <*> 0 . DP=19;ADF=17,0;ADR=0,0;AD=17,0;I16=17,0,0,0,704,31276,0,0,989,58441,0,0,304,6240,0,0;QS=3,0;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,27,194:9:0:9,0:0,0:9,0 0,9,104:3:0:3,0:0,0:3,0 0,15,136:5:0:5,0:0,0:5,0 +17 111 . G <*> 0 . DP=19;ADF=16,0;ADR=0,0;AD=16,0;I16=16,0,0,0,584,24362,0,0,929,54841,0,0,272,5416,0,0;QS=3,0;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,30,167:10:0:10,0:0,0:10,0 0,6,88:2:0:2,0:0,0:2,0 0,12,118:4:0:4,0:0,0:4,0 +17 112 . C <*> 0 . DP=19;ADF=17,0;ADR=0,0;AD=17,0;I16=17,0,0,0,680,29854,0,0,989,58441,0,0,296,6052,0,0;QS=3,0;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,27,191:9:0:9,0:0,0:9,0 0,9,95:3:0:3,0:0,0:3,0 0,15,135:5:0:5,0:0,0:5,0 +17 113 . A <*> 0 . DP=19;ADF=16,0;ADR=0,0;AD=16,0;I16=16,0,0,0,645,28035,0,0,960,57600,0,0,266,5318,0,0;QS=3,0;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,27,176:9:0:9,0:0,0:9,0 0,6,87:2:0:2,0:0,0:2,0 0,15,139:5:0:5,0:0,0:5,0 +17 114 . C <*> 0 . DP=19;ADF=17,0;ADR=0,0;AD=17,0;I16=17,0,0,0,674,28788,0,0,989,58441,0,0,286,5856,0,0;QS=3,0;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,27,182:9:0:9,0:0,0:9,0 0,9,103:3:0:3,0:0,0:3,0 0,15,133:5:0:5,0:0,0:5,0 +17 115 . C <*> 0 . DP=21;ADF=18,0;ADR=0,0;AD=18,0;I16=18,0,0,0,708,30546,0,0,1049,62041,0,0,274,5490,0,0;QS=3,0;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,30,189:10:0:10,0:0,0:10,0 0,6,89:2:0:2,0:0,0:2,0 0,18,147:6:0:6,0:0,0:6,0 +17 116 . A <*> 0 . DP=21;ADF=17,0;ADR=1,0;AD=18,0;I16=17,1,0,0,727,31755,0,0,1049,62041,0,0,253,5079,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,27,183:9:0:9,0:0,0:9,0 0,6,90:2:0:2,0:0,0:2,0 0,21,175:7:0:6,0:1,0:7,0 +17 117 . G <*> 0 . DP=21;ADF=17,0;ADR=1,0;AD=18,0;I16=17,1,0,0,712,30478,0,0,1049,62041,0,0,249,5019,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,27,183:9:0:9,0:0,0:9,0 0,6,85:2:0:2,0:0,0:2,0 0,21,177:7:0:6,0:1,0:7,0 +17 118 . G <*> 0 . DP=20;ADF=16,0;ADR=1,0;AD=17,0;I16=16,1,0,0,636,26574,0,0,958,55682,0,0,266,5426,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,27,175:9:0:9,0:0,0:9,0 0,3,60:1:0:1,0:0,0:1,0 0,21,162:7:0:6,0:1,0:7,0 +17 119 . G <*> 0 . DP=19;ADF=16,0;ADR=1,0;AD=17,0;I16=16,1,0,0,629,26439,0,0,958,55682,0,0,267,5553,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,24,175:8:0:8,0:0,0:8,0 0,6,73:2:0:2,0:0,0:2,0 0,21,160:7:0:6,0:1,0:7,0 +17 120 . A <*> 0 . DP=19;ADF=16,0;ADR=1,0;AD=17,0;I16=16,1,0,0,672,29188,0,0,958,55682,0,0,264,5518,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,24,175:8:0:8,0:0,0:8,0 0,6,83:2:0:2,0:0,0:2,0 0,21,171:7:0:6,0:1,0:7,0 +17 121 . G <*> 0 . DP=19;ADF=16,0;ADR=1,0;AD=17,0;I16=16,1,0,0,662,28460,0,0,958,55682,0,0,260,5454,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,24,181:8:0:8,0:0,0:8,0 0,6,80:2:0:2,0:0,0:2,0 0,21,168:7:0:6,0:1,0:7,0 +17 122 . C <*> 0 . DP=20;ADF=17,0;ADR=1,0;AD=18,0;I16=17,1,0,0,716,31224,0,0,1018,59282,0,0,256,5410,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,24,181:8:0:8,0:0,0:8,0 0,9,99:3:0:3,0:0,0:3,0 0,21,178:7:0:6,0:1,0:7,0 +17 123 . T <*> 0 . DP=18;ADF=15,0;ADR=1,0;AD=16,0;I16=15,1,0,0,661,29997,0,0,898,52082,0,0,255,5385,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,167:7:0:7,0:0,0:7,0 0,9,112:3:0:3,0:0,0:3,0 0,18,166:6:0:5,0:1,0:6,0 +17 124 . T <*> 0 . DP=19;ADF=17,0;ADR=1,0;AD=18,0;I16=17,1,0,0,626,24802,0,0,987,56523,0,0,279,6003,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,27,154:9:0:9,0:0,0:9,0 0,9,104:3:0:3,0:0,0:3,0 0,18,154:6:0:5,0:1,0:6,0 +17 125 . A <*> 0 . DP=18;ADF=15,0;ADR=1,0;AD=16,0;I16=15,1,0,0,611,25689,0,0,898,52082,0,0,254,5340,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,154:7:0:7,0:0,0:7,0 0,9,104:3:0:3,0:0,0:3,0 0,18,162:6:0:5,0:1,0:6,0 +17 126 . A <*> 0 . DP=18;ADF=16,0;ADR=1,0;AD=17,0;I16=16,1,0,0,648,27366,0,0,927,52923,0,0,279,5947,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,24,162:8:0:8,0:0,0:8,0 0,9,107:3:0:3,0:0,0:3,0 0,18,174:6:0:5,0:1,0:6,0 +17 127 . C <*> 0 . DP=18;ADF=16,0;ADR=1,0;AD=17,0;I16=16,1,0,0,646,26972,0,0,927,52923,0,0,279,5949,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,24,163:8:0:8,0:0,0:8,0 0,9,109:3:0:3,0:0,0:3,0 0,18,160:6:0:5,0:1,0:6,0 +17 128 . A <*> 0 . DP=18;ADF=16,0;ADR=1,0;AD=17,0;I16=16,1,0,0,673,28797,0,0,927,52923,0,0,279,5971,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,24,169:8:0:8,0:0,0:8,0 0,9,111:3:0:3,0:0,0:3,0 0,18,162:6:0:5,0:1,0:6,0 +17 129 . A <*> 0 . DP=17;ADF=15,0;ADR=1,0;AD=16,0;I16=15,1,0,0,645,27891,0,0,867,49323,0,0,280,6012,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,24,168:8:0:8,0:0,0:8,0 0,9,113:3:0:3,0:0,0:3,0 0,15,159:5:0:4,0:1,0:5,0 +17 130 . A <*> 0 . DP=17;ADF=15,0;ADR=1,0;AD=16,0;I16=15,1,0,0,641,27295,0,0,867,49323,0,0,281,6071,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,24,169:8:0:8,0:0,0:8,0 0,9,113:3:0:3,0:0,0:3,0 0,15,152:5:0:4,0:1,0:5,0 +17 131 . C <*> 0 . DP=16;ADF=14,0;ADR=1,0;AD=15,0;I16=14,1,0,0,606,25732,0,0,838,48482,0,0,256,5472,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,167:7:0:7,0:0,0:7,0 0,9,110:3:0:3,0:0,0:3,0 0,15,147:5:0:4,0:1,0:5,0 +17 132 . A <*> 0 . DP=16;ADF=14,0;ADR=1,0;AD=15,0;I16=14,1,0,0,627,27579,0,0,838,48482,0,0,256,5514,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,169:7:0:7,0:0,0:7,0 0,9,110:3:0:3,0:0,0:3,0 0,15,151:5:0:4,0:1,0:5,0 +17 133 . T <*> 0 . DP=15;ADF=13,0;ADR=2,0;AD=15,0;I16=13,2,0,0,584,22816,0,0,838,48482,0,0,282,6196,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,163:7:0:7,0:0,0:7,0 0,9,105:3:0:2,0:1,0:3,0 0,15,150:5:0:4,0:1,0:5,0 +17 134 . C <*> 0 . DP=15;ADF=13,0;ADR=2,0;AD=15,0;I16=13,2,0,0,607,24653,0,0,838,48482,0,0,283,6267,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,177:7:0:7,0:0,0:7,0 0,9,105:3:0:2,0:1,0:3,0 0,15,152:5:0:4,0:1,0:5,0 +17 135 . T <*> 0 . DP=15;ADF=13,0;ADR=2,0;AD=15,0;I16=13,2,0,0,600,24178,0,0,838,48482,0,0,284,6352,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,173:7:0:7,0:0,0:7,0 0,9,106:3:0:2,0:1,0:3,0 0,15,156:5:0:4,0:1,0:5,0 +17 136 . G <*> 0 . DP=15;ADF=13,0;ADR=2,0;AD=15,0;I16=13,2,0,0,574,22258,0,0,838,48482,0,0,286,6450,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,172:7:0:7,0:0,0:7,0 0,9,105:3:0:2,0:1,0:3,0 0,15,134:5:0:4,0:1,0:5,0 +17 137 . T <*> 0 . DP=15;ADF=13,0;ADR=2,0;AD=15,0;I16=13,2,0,0,563,21377,0,0,838,48482,0,0,289,6561,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,160:7:0:7,0:0,0:7,0 0,9,104:3:0:2,0:1,0:3,0 0,15,139:5:0:4,0:1,0:5,0 +17 138 . C <*> 0 . DP=15;ADF=13,0;ADR=2,0;AD=15,0;I16=13,2,0,0,584,23088,0,0,838,48482,0,0,291,6637,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,172:7:0:7,0:0,0:7,0 0,9,108:3:0:2,0:1,0:3,0 0,15,142:5:0:4,0:1,0:5,0 +17 139 . C <*> 0 . DP=15;ADF=13,0;ADR=2,0;AD=15,0;I16=13,2,0,0,554,20790,0,0,838,48482,0,0,292,6680,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,161:7:0:7,0:0,0:7,0 0,9,106:3:0:2,0:1,0:3,0 0,15,143:5:0:4,0:1,0:5,0 +17 140 . A <*> 0 . DP=15;ADF=13,0;ADR=2,0;AD=15,0;I16=13,2,0,0,583,22789,0,0,838,48482,0,0,292,6690,0,0;QS=3,0;MQSB=0.576923;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,163:7:0:7,0:0,0:7,0 0,9,107:3:0:2,0:1,0:3,0 0,15,153:5:0:4,0:1,0:5,0 +17 141 . G <*> 0 . DP=14;ADF=12,0;ADR=2,0;AD=14,0;I16=12,2,0,0,534,20750,0,0,778,44882,0,0,292,6664,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,18,158:6:0:6,0:0,0:6,0 0,9,108:3:0:2,0:1,0:3,0 0,15,142:5:0:4,0:1,0:5,0 +17 142 . C <*> 0 . DP=14;ADF=12,0;ADR=2,0;AD=14,0;I16=12,2,0,0,503,18593,0,0,778,44882,0,0,292,6650,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,18,157:6:0:6,0:0,0:6,0 0,9,97:3:0:2,0:1,0:3,0 0,15,129:5:0:4,0:1,0:5,0 +17 143 . G <*> 0 . DP=14;ADF=11,0;ADR=2,0;AD=13,0;I16=11,2,0,0,415,13657,0,0,718,41282,0,0,285,6599,0,0;QS=3,0;MQSB=0.590909;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,18,128:6:0:6,0:0,0:6,0 0,9,95:3:0:2,0:1,0:3,0 0,12,97:4:0:3,0:1,0:4,0 +17 144 . A <*> 0 . DP=14;ADF=12,0;ADR=2,0;AD=14,0;I16=12,2,0,0,519,19725,0,0,778,44882,0,0,291,6609,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,18,152:6:0:6,0:0,0:6,0 0,9,105:3:0:2,0:1,0:3,0 0,15,129:5:0:4,0:1,0:5,0 +17 145 . A <*> 0 . DP=14;ADF=12,0;ADR=2,0;AD=14,0;I16=12,2,0,0,527,20289,0,0,778,44882,0,0,290,6584,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,18,153:6:0:6,0:0,0:6,0 0,9,106:3:0:2,0:1,0:3,0 0,15,138:5:0:4,0:1,0:5,0 +17 146 . T <*> 0 . DP=14;ADF=12,0;ADR=2,0;AD=14,0;I16=12,2,0,0,514,19484,0,0,778,44882,0,0,289,6573,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,18,152:6:0:6,0:0,0:6,0 0,9,103:3:0:2,0:1,0:3,0 0,15,128:5:0:4,0:1,0:5,0 +17 147 . A <*> 0 . DP=14;ADF=12,0;ADR=2,0;AD=14,0;I16=12,2,0,0,515,19213,0,0,778,44882,0,0,288,6576,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,18,150:6:0:6,0:0,0:6,0 0,9,99:3:0:2,0:1,0:3,0 0,15,140:5:0:4,0:1,0:5,0 +17 148 . C <*> 0 . DP=14;ADF=12,0;ADR=2,0;AD=14,0;I16=12,2,0,0,541,21019,0,0,778,44882,0,0,286,6542,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,18,157:6:0:6,0:0,0:6,0 0,9,106:3:0:2,0:1,0:3,0 0,15,146:5:0:4,0:1,0:5,0 +17 149 . C <*> 0 . DP=14;ADF=12,0;ADR=2,0;AD=14,0;I16=12,2,0,0,512,19326,0,0,778,44882,0,0,283,6471,0,0;QS=3,0;MQSB=0.583333;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,18,148:6:0:6,0:0,0:6,0 0,9,109:3:0:2,0:1,0:3,0 0,15,140:5:0:4,0:1,0:5,0 +17 150 . T <*> 0 . DP=13;ADF=11,0;ADR=2,0;AD=13,0;I16=11,2,0,0,511,20251,0,0,749,44041,0,0,280,6362,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,18,153:6:0:6,0:0,0:6,0 0,6,84:2:0:1,0:1,0:2,0 0,15,152:5:0:4,0:1,0:5,0 +17 151 . G <*> 0 . DP=13;ADF=11,0;ADR=2,0;AD=13,0;I16=11,2,0,0,506,19826,0,0,749,44041,0,0,277,6263,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,18,157:6:0:6,0:0,0:6,0 0,6,84:2:0:1,0:1,0:2,0 0,15,144:5:0:4,0:1,0:5,0 +17 152 . C <*> 0 . DP=14;ADF=12,0;ADR=2,0;AD=14,0;I16=12,2,0,0,543,21283,0,0,809,47641,0,0,274,6174,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,168:7:0:7,0:0,0:7,0 0,6,84:2:0:1,0:1,0:2,0 0,15,146:5:0:4,0:1,0:5,0 +17 153 . A <*> 0 . DP=14;ADF=12,0;ADR=2,0;AD=14,0;I16=12,2,0,0,536,20594,0,0,809,47641,0,0,272,6096,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,156:7:0:7,0:0,0:7,0 0,6,81:2:0:1,0:1,0:2,0 0,15,153:5:0:4,0:1,0:5,0 +17 154 . T <*> 0 . DP=14;ADF=12,0;ADR=2,0;AD=14,0;I16=12,2,0,0,523,20051,0,0,809,47641,0,0,270,6030,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,159:7:0:7,0:0,0:7,0 0,6,83:2:0:1,0:1,0:2,0 0,15,139:5:0:4,0:1,0:5,0 +17 155 . C <*> 0 . DP=14;ADF=12,0;ADR=2,0;AD=14,0;I16=12,2,0,0,542,21254,0,0,809,47641,0,0,268,5976,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,172:7:0:7,0:0,0:7,0 0,6,85:2:0:1,0:1,0:2,0 0,15,139:5:0:4,0:1,0:5,0 +17 156 . C <*> 0 . DP=14;ADF=12,0;ADR=2,0;AD=14,0;I16=12,2,0,0,536,20884,0,0,809,47641,0,0,266,5934,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,163:7:0:7,0:0,0:7,0 0,6,84:2:0:1,0:1,0:2,0 0,15,150:5:0:4,0:1,0:5,0 +17 157 . C <*> 0 . DP=14;ADF=12,0;ADR=2,0;AD=14,0;I16=12,2,0,0,555,22081,0,0,809,47641,0,0,264,5904,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,169:7:0:7,0:0,0:7,0 0,6,85:2:0:1,0:1,0:2,0 0,15,149:5:0:4,0:1,0:5,0 +17 158 . T <*> 0 . DP=14;ADF=12,0;ADR=2,0;AD=14,0;I16=12,2,0,0,568,23154,0,0,809,47641,0,0,262,5886,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,170:7:0:7,0:0,0:7,0 0,6,84:2:0:1,0:1,0:2,0 0,15,159:5:0:4,0:1,0:5,0 +17 159 . A <*> 0 . DP=15;ADF=12,0;ADR=2,0;AD=14,0;I16=12,2,0,0,519,19467,0,0,809,47641,0,0,260,5880,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,157:7:0:7,0:0,0:7,0 0,6,83:2:0:1,0:1,0:2,0 0,15,135:5:0:4,0:1,0:5,0 +17 160 . G <*> 0 . DP=15;ADF=13,0;ADR=2,0;AD=15,0;I16=13,2,0,0,547,20633,0,0,869,51241,0,0,259,5887,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,165:7:0:7,0:0,0:7,0 0,6,85:2:0:1,0:1,0:2,0 0,18,139:6:0:5,0:1,0:6,0 +17 161 . A <*> 0 . DP=15;ADF=13,0;ADR=2,0;AD=15,0;I16=13,2,0,0,568,21610,0,0,869,51241,0,0,258,5908,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,157:7:0:7,0:0,0:7,0 0,6,83:2:0:1,0:1,0:2,0 0,18,162:6:0:5,0:1,0:6,0 +17 162 . A <*> 0 . DP=15;ADF=13,0;ADR=2,0;AD=15,0;I16=13,2,0,0,557,21139,0,0,869,51241,0,0,255,5843,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,147:7:0:7,0:0,0:7,0 0,6,87:2:0:1,0:1,0:2,0 0,18,167:6:0:5,0:1,0:6,0 +17 163 . G <*> 0 . DP=14;ADF=12,0;ADR=2,0;AD=14,0;I16=12,2,0,0,503,18645,0,0,809,47641,0,0,253,5791,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,153:7:0:7,0:0,0:7,0 0,6,79:2:0:1,0:1,0:2,0 0,15,138:5:0:4,0:1,0:5,0 +17 164 . T <*> 0 . DP=14;ADF=12,0;ADR=2,0;AD=14,0;I16=12,2,0,0,460,15968,0,0,809,47641,0,0,252,5750,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,18,131:6:0:6,0:0,0:6,0 0,6,79:2:0:1,0:1,0:2,0 0,18,136:6:0:5,0:1,0:6,0 +17 165 . G <*> 0 . DP=14;ADF=10,0;ADR=2,0;AD=12,0;I16=10,2,0,0,456,17460,0,0,689,40441,0,0,226,5094,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,18,149:6:0:6,0:0,0:6,0 0,6,80:2:0:1,0:1,0:2,0 0,12,122:4:0:3,0:1,0:4,0 +17 166 . A <*> 0 . DP=14;ADF=11,0;ADR=2,0;AD=13,0;I16=11,2,0,0,496,19138,0,0,749,44041,0,0,227,5077,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,18,145:6:0:6,0:0,0:6,0 0,6,82:2:0:1,0:1,0:2,0 0,15,148:5:0:4,0:1,0:5,0 +17 167 . A <*> 0 . DP=14;ADF=11,0;ADR=2,0;AD=13,0;I16=11,2,0,0,477,17851,0,0,749,44041,0,0,227,5071,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,18,132:6:0:6,0:0,0:6,0 0,6,86:2:0:1,0:1,0:2,0 0,15,147:5:0:4,0:1,0:5,0 +17 168 . G <*> 0 . DP=14;ADF=12,0;ADR=2,0;AD=14,0;I16=12,2,0,0,481,18015,0,0,809,47641,0,0,252,5702,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,18,145:6:0:6,0:0,0:6,0 0,6,82:2:0:1,0:1,0:2,0 0,18,140:6:0:5,0:1,0:6,0 +17 169 . C <*> 0 . DP=13;ADF=10,0;ADR=2,0;AD=12,0;I16=10,2,0,0,402,14224,0,0,689,40441,0,0,227,5045,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,15,106:5:0:5,0:0,0:5,0 0,6,76:2:0:1,0:1,0:2,0 0,15,145:5:0:4,0:1,0:5,0 +17 170 . C <*> 0 . DP=13;ADF=11,0;ADR=2,0;AD=13,0;I16=11,2,0,0,447,16383,0,0,749,44041,0,0,251,5601,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,15,128:5:0:5,0:0,0:5,0 0,6,80:2:0:1,0:1,0:2,0 0,18,143:6:0:5,0:1,0:6,0 +17 171 . A <*> 0 . DP=13;ADF=11,0;ADR=2,0;AD=13,0;I16=11,2,0,0,500,19366,0,0,749,44041,0,0,250,5546,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,15,134:5:0:5,0:0,0:5,0 0,6,81:2:0:1,0:1,0:2,0 0,18,166:6:0:5,0:1,0:6,0 +17 172 . C <*> 0 . DP=13;ADF=10,0;ADR=2,0;AD=12,0;I16=10,2,0,0,439,16395,0,0,689,40441,0,0,241,5441,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,15,138:5:0:5,0:0,0:5,0 0,6,75:2:0:1,0:1,0:2,0 0,15,129:5:0:4,0:1,0:5,0 +17 173 . C <*> 0 . DP=13;ADF=11,0;ADR=2,0;AD=13,0;I16=11,2,0,0,435,15225,0,0,749,44041,0,0,248,5478,0,0;QS=3,0;MQSB=0.5;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,15,121:5:0:5,0:0,0:5,0 0,6,76:2:0:1,0:1,0:2,0 0,18,146:6:0:5,0:1,0:6,0 +17 174 . G <*> 0 . DP=13;ADF=11,0;ADR=1,0;AD=12,0;I16=11,1,0,0,351,10685,0,0,689,40441,0,0,238,5364,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,15,111:5:0:5,0:0,0:5,0 0,3,27:1:0:1,0:0,0:1,0 0,18,117:6:0:5,0:1,0:6,0 +17 175 . C <*> 0 . DP=14;ADF=13,0;ADR=1,0;AD=14,0;I16=13,1,0,0,511,19161,0,0,809,47641,0,0,249,5463,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,18,143:6:0:6,0:0,0:6,0 0,3,41:1:0:1,0:0,0:1,0 0,21,175:7:0:6,0:1,0:7,0 +17 176 . C <*> 0 . DP=14;ADF=13,0;ADR=1,0;AD=14,0;I16=13,1,0,0,489,17733,0,0,809,47641,0,0,251,5477,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,18,146:6:0:6,0:0,0:6,0 0,3,44:1:0:1,0:0,0:1,0 0,21,152:7:0:6,0:1,0:7,0 +17 177 . C <*> 0 . DP=14;ADF=13,0;ADR=1,0;AD=14,0;I16=13,1,0,0,488,17328,0,0,809,47641,0,0,253,5507,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,18,138:6:0:6,0:0,0:6,0 0,3,44:1:0:1,0:0,0:1,0 0,21,158:7:0:6,0:1,0:7,0 +17 178 . A <*> 0 . DP=14;ADF=13,0;ADR=1,0;AD=14,0;I16=13,1,0,0,519,19485,0,0,809,47641,0,0,254,5502,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,18,147:6:0:6,0:0,0:6,0 0,3,42:1:0:1,0:0,0:1,0 0,21,172:7:0:6,0:1,0:7,0 +17 179 . A <*> 0 . DP=14;ADF=13,0;ADR=1,0;AD=14,0;I16=13,1,0,0,478,17278,0,0,809,47641,0,0,255,5511,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,18,134:6:0:6,0:0,0:6,0 0,3,44:1:0:1,0:0,0:1,0 0,21,170:7:0:6,0:1,0:7,0 +17 180 . A <*> 0 . DP=14;ADF=12,0;ADR=1,0;AD=13,0;I16=12,1,0,0,425,14653,0,0,749,44041,0,0,250,5498,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,18,126:6:0:6,0:0,0:6,0 0,3,43:1:0:1,0:0,0:1,0 0,18,148:6:0:5,0:1,0:6,0 +17 181 . G <*> 0 . DP=14;ADF=11,0;ADR=1,0;AD=12,0;I16=11,1,0,0,450,17152,0,0,689,40441,0,0,233,5233,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,18,156:6:0:6,0:0,0:6,0 0,3,41:1:0:1,0:0,0:1,0 0,15,138:5:0:4,0:1,0:5,0 +17 182 . A <*> 0 . DP=15;ADF=14,0;ADR=1,0;AD=15,0;I16=14,1,0,0,515,18235,0,0,869,51241,0,0,258,5622,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,150:7:0:7,0:0,0:7,0 0,3,43:1:0:1,0:0,0:1,0 0,21,159:7:0:6,0:1,0:7,0 +17 183 . C <*> 0 . DP=15;ADF=13,0;ADR=1,0;AD=14,0;I16=13,1,0,0,483,17419,0,0,809,47641,0,0,235,5063,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,159:7:0:7,0:0,0:7,0 0,3,40:1:0:1,0:0,0:1,0 0,18,139:6:0:5,0:1,0:6,0 +17 184 . A <*> 0 . DP=15;ADF=14,0;ADR=1,0;AD=15,0;I16=14,1,0,0,535,19667,0,0,869,51241,0,0,262,5770,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,158:7:0:7,0:0,0:7,0 0,3,41:1:0:1,0:0,0:1,0 0,21,163:7:0:6,0:1,0:7,0 +17 185 . C <*> 0 . DP=15;ADF=13,0;ADR=1,0;AD=14,0;I16=13,1,0,0,487,17295,0,0,809,47641,0,0,238,5192,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,150:7:0:7,0:0,0:7,0 0,3,38:1:0:1,0:0,0:1,0 0,18,160:6:0:5,0:1,0:6,0 +17 186 . G <*> 0 . DP=15;ADF=12,0;ADR=1,0;AD=13,0;I16=12,1,0,0,381,11429,0,0,749,44041,0,0,239,5253,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,18,117:6:0:6,0:0,0:6,0 0,3,32:1:0:1,0:0,0:1,0 0,18,124:6:0:5,0:1,0:6,0 +17 187 . C <*> 0 . DP=14;ADF=13,0;ADR=1,0;AD=14,0;I16=13,1,0,0,511,18979,0,0,809,47641,0,0,266,5952,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,18,147:6:0:6,0:0,0:6,0 0,3,38:1:0:1,0:0,0:1,0 0,21,172:7:0:6,0:1,0:7,0 +17 188 . C <*> 0 . DP=14;ADF=13,0;ADR=1,0;AD=14,0;I16=13,1,0,0,496,18042,0,0,809,47641,0,0,267,5989,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,18,147:6:0:6,0:0,0:6,0 0,3,37:1:0:1,0:0,0:1,0 0,21,162:7:0:6,0:1,0:7,0 +17 189 . C <*> 0 . DP=15;ADF=13,0;ADR=2,0;AD=15,0;I16=13,2,0,0,552,20504,0,0,838,48482,0,0,268,6040,0,0;QS=3,0;MQSB=0;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,18,152:6:0:6,0:0,0:6,0 0,6,67:2:0:1,0:1,0:2,0 0,21,167:7:0:6,0:1,0:7,0 +17 190 . A <*> 0 . DP=15;ADF=12,0;ADR=2,0;AD=14,0;I16=12,2,0,0,500,18230,0,0,778,44882,0,0,243,5381,0,0;QS=3,0;MQSB=0;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,18,138:6:0:6,0:0,0:6,0 0,6,68:2:0:1,0:1,0:2,0 0,18,159:6:0:5,0:1,0:6,0 +17 191 . T <*> 0 . DP=15;ADF=13,0;ADR=2,0;AD=15,0;I16=13,2,0,0,534,19276,0,0,838,48482,0,0,267,5939,0,0;QS=3,0;MQSB=0;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,18,143:6:0:6,0:0,0:6,0 0,6,67:2:0:1,0:1,0:2,0 0,21,169:7:0:6,0:1,0:7,0 +17 192 . G <*> 0 . DP=15;ADF=13,0;ADR=2,0;AD=15,0;I16=13,2,0,0,499,17439,0,0,838,48482,0,0,266,5890,0,0;QS=3,0;MQSB=0;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,18,143:6:0:6,0:0,0:6,0 0,6,67:2:0:1,0:1,0:2,0 0,21,151:7:0:6,0:1,0:7,0 +17 193 . T <*> 0 . DP=15;ADF=13,0;ADR=2,0;AD=15,0;I16=13,2,0,0,505,17811,0,0,838,48482,0,0,265,5859,0,0;QS=3,0;MQSB=0;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,18,140:6:0:6,0:0,0:6,0 0,6,63:2:0:1,0:1,0:2,0 0,21,157:7:0:6,0:1,0:7,0 +17 194 . C <*> 0 . DP=14;ADF=12,0;ADR=2,0;AD=14,0;I16=12,2,0,0,467,16569,0,0,778,44882,0,0,265,5845,0,0;QS=3,0;MQSB=0;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,18,142:6:0:6,0:0,0:6,0 0,6,67:2:0:1,0:1,0:2,0 0,18,145:6:0:5,0:1,0:6,0 +17 195 . C <*> 0 . DP=14;ADF=11,0;ADR=3,0;AD=14,0;I16=11,3,0,0,503,18647,0,0,747,42123,0,0,266,5846,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,18,159:6:0:5,0:1,0:6,0 0,6,71:2:0:1,0:1,0:2,0 0,18,160:6:0:5,0:1,0:6,0 +17 196 . A <*> 0 . DP=14;ADF=11,0;ADR=3,0;AD=14,0;I16=11,3,0,0,482,17400,0,0,747,42123,0,0,268,5862,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,18,166:6:0:5,0:1,0:6,0 0,6,69:2:0:1,0:1,0:2,0 0,18,138:6:0:5,0:1,0:6,0 +17 197 . G <*> 0 . DP=14;ADF=11,0;ADR=3,0;AD=14,0;I16=11,3,0,0,481,17391,0,0,747,42123,0,0,270,5894,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,18,164:6:0:5,0:1,0:6,0 0,6,68:2:0:1,0:1,0:2,0 0,18,134:6:0:5,0:1,0:6,0 +17 198 . C <*> 0 . DP=14;ADF=11,0;ADR=3,0;AD=14,0;I16=11,3,0,0,539,20957,0,0,747,42123,0,0,271,5893,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,18,172:6:0:5,0:1,0:6,0 0,6,70:2:0:1,0:1,0:2,0 0,18,164:6:0:5,0:1,0:6,0 +17 199 . T <*> 0 . DP=14;ADF=11,0;ADR=3,0;AD=14,0;I16=11,3,0,0,505,19197,0,0,747,42123,0,0,271,5861,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,18,162:6:0:5,0:1,0:6,0 0,6,73:2:0:1,0:1,0:2,0 0,18,154:6:0:5,0:1,0:6,0 +17 200 . T <*> 0 . DP=15;ADF=11,0;ADR=4,0;AD=15,0;I16=11,4,0,0,544,19918,0,0,776,42964,0,0,270,5798,0,0;QS=3,0;MQSB=0.0161635;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,18,161:6:0:5,0:1,0:6,0 0,9,89:3:0:1,0:2,0:3,0 0,18,154:6:0:5,0:1,0:6,0 +17 201 . A <*> 0 . DP=16;ADF=12,0;ADR=4,0;AD=16,0;I16=12,4,0,0,568,20416,0,0,836,46564,0,0,269,5703,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,171:7:0:6,0:1,0:7,0 0,9,89:3:0:1,0:2,0:3,0 0,18,157:6:0:5,0:1,0:6,0 +17 202 . A <*> 0 . DP=16;ADF=12,0;ADR=4,0;AD=16,0;I16=12,4,0,0,566,20590,0,0,836,46564,0,0,269,5627,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,178:7:0:6,0:1,0:7,0 0,9,84:3:0:1,0:2,0:3,0 0,18,163:6:0:5,0:1,0:6,0 +17 203 . C <*> 0 . DP=16;ADF=12,0;ADR=4,0;AD=16,0;I16=12,4,0,0,557,20119,0,0,836,46564,0,0,269,5571,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,166:7:0:6,0:1,0:7,0 0,9,90:3:0:1,0:2,0:3,0 0,18,153:6:0:5,0:1,0:6,0 +17 204 . C <*> 0 . DP=16;ADF=12,0;ADR=4,0;AD=16,0;I16=12,4,0,0,591,22379,0,0,836,46564,0,0,269,5535,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,173:7:0:6,0:1,0:7,0 0,9,91:3:0:1,0:2,0:3,0 0,18,163:6:0:5,0:1,0:6,0 +17 205 . T <*> 0 . DP=16;ADF=12,0;ADR=4,0;AD=16,0;I16=12,4,0,0,635,25281,0,0,836,46564,0,0,269,5519,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,188:7:0:6,0:1,0:7,0 0,9,95:3:0:1,0:2,0:3,0 0,18,173:6:0:5,0:1,0:6,0 +17 206 . G <*> 0 . DP=16;ADF=12,0;ADR=4,0;AD=16,0;I16=12,4,0,0,577,21337,0,0,836,46564,0,0,269,5523,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,180:7:0:6,0:1,0:7,0 0,9,89:3:0:1,0:2,0:3,0 0,18,143:6:0:5,0:1,0:6,0 +17 207 . C <*> 0 . DP=16;ADF=12,0;ADR=4,0;AD=16,0;I16=12,4,0,0,574,21076,0,0,836,46564,0,0,269,5547,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,179:7:0:6,0:1,0:7,0 0,9,93:3:0:1,0:2,0:3,0 0,18,151:6:0:5,0:1,0:6,0 +17 208 . A <*> 0 . DP=16;ADF=12,0;ADR=4,0;AD=16,0;I16=12,4,0,0,576,21486,0,0,836,46564,0,0,268,5540,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,184:7:0:6,0:1,0:7,0 0,9,93:3:0:1,0:2,0:3,0 0,18,154:6:0:5,0:1,0:6,0 +17 209 . T <*> 0 . DP=16;ADF=12,0;ADR=4,0;AD=16,0;I16=12,4,0,0,567,20475,0,0,836,46564,0,0,267,5551,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,173:7:0:6,0:1,0:7,0 0,9,91:3:0:1,0:2,0:3,0 0,18,146:6:0:5,0:1,0:6,0 +17 210 . C <*> 0 . DP=16;ADF=12,0;ADR=4,0;AD=16,0;I16=12,4,0,0,577,21109,0,0,836,46564,0,0,266,5580,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,185:7:0:6,0:1,0:7,0 0,9,92:3:0:1,0:2,0:3,0 0,18,151:6:0:5,0:1,0:6,0 +17 211 . C <*> 0 . DP=16;ADF=12,0;ADR=4,0;AD=16,0;I16=12,4,0,0,563,20227,0,0,836,46564,0,0,265,5627,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,172:7:0:6,0:1,0:7,0 0,9,92:3:0:1,0:2,0:3,0 0,18,153:6:0:5,0:1,0:6,0 +17 212 . C <*> 0 . DP=16;ADF=12,0;ADR=4,0;AD=16,0;I16=12,4,0,0,589,22179,0,0,836,46564,0,0,263,5643,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,181:7:0:6,0:1,0:7,0 0,9,92:3:0:1,0:2,0:3,0 0,18,152:6:0:5,0:1,0:6,0 +17 213 . T <*> 0 . DP=16;ADF=12,0;ADR=4,0;AD=16,0;I16=12,4,0,0,598,22838,0,0,836,46564,0,0,262,5678,0,0;QS=3,0;MQSB=0.0144756;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,181:7:0:6,0:1,0:7,0 0,9,95:3:0:1,0:2,0:3,0 0,18,165:6:0:5,0:1,0:6,0 +17 214 . A <*> 0 . DP=16;ADF=11,0;ADR=4,0;AD=15,0;I16=11,4,0,0,529,19401,0,0,776,42964,0,0,240,5248,0,0;QS=3,0;MQSB=0.0161635;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,176:7:0:6,0:1,0:7,0 0,9,92:3:0:1,0:2,0:3,0 0,15,118:5:0:4,0:1,0:5,0 +17 215 . G <*> 0 . DP=15;ADF=12,0;ADR=3,0;AD=15,0;I16=12,3,0,0,521,19073,0,0,807,45723,0,0,262,5754,0,0;QS=3,0;MQSB=0.0342181;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,185:7:0:6,0:1,0:7,0 0,9,90:3:0:1,0:2,0:3,0 0,15,105:5:0:5,0:0,0:5,0 +17 216 . A <*> 0 . DP=14;ADF=10,0;ADR=3,0;AD=13,0;I16=10,3,0,0,464,16900,0,0,687,38523,0,0,238,5166,0,0;QS=3,0;MQSB=0.040184;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,173:7:0:6,0:1,0:7,0 0,9,92:3:0:1,0:2,0:3,0 0,9,81:3:0:3,0:0,0:3,0 +17 217 . A <*> 0 . DP=14;ADF=11,0;ADR=3,0;AD=14,0;I16=11,3,0,0,515,19433,0,0,747,42123,0,0,264,5842,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,181:7:0:6,0:1,0:7,0 0,9,90:3:0:1,0:2,0:3,0 0,12,97:4:0:4,0:0,0:4,0 +17 218 . G <*> 0 . DP=14;ADF=11,0;ADR=3,0;AD=14,0;I16=11,3,0,0,507,18957,0,0,747,42123,0,0,265,5907,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,178:7:0:6,0:1,0:7,0 0,9,90:3:0:1,0:2,0:3,0 0,12,110:4:0:4,0:0,0:4,0 +17 219 . T <*> 0 . DP=14;ADF=11,0;ADR=3,0;AD=14,0;I16=11,3,0,0,470,16286,0,0,747,42123,0,0,266,5986,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,173:7:0:6,0:1,0:7,0 0,9,88:3:0:1,0:2,0:3,0 0,12,89:4:0:4,0:0,0:4,0 +17 220 . G <*> 0 . DP=14;ADF=10,0;ADR=3,0;AD=13,0;I16=10,3,0,0,485,18307,0,0,687,38523,0,0,242,5454,0,0;QS=3,0;MQSB=0.040184;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,188:7:0:6,0:1,0:7,0 0,9,88:3:0:1,0:2,0:3,0 0,9,80:3:0:3,0:0,0:3,0 +17 221 . A <*> 0 . DP=14;ADF=11,0;ADR=3,0;AD=14,0;I16=11,3,0,0,487,17615,0,0,747,42123,0,0,267,6135,0,0;QS=3,0;MQSB=0.0368832;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,176:7:0:6,0:1,0:7,0 0,9,88:3:0:1,0:2,0:3,0 0,12,101:4:0:4,0:0,0:4,0 +17 222 . A <*> 0 . DP=14;ADF=10,0;ADR=3,0;AD=13,0;I16=10,3,0,0,465,17367,0,0,687,38523,0,0,242,5578,0,0;QS=3,0;MQSB=0.040184;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,186:7:0:6,0:1,0:7,0 0,9,85:3:0:1,0:2,0:3,0 0,9,69:3:0:3,0:0,0:3,0 +17 223 . G <*> 0 . DP=13;ADF=9,0;ADR=3,0;AD=12,0;I16=9,3,0,0,405,14327,0,0,627,34923,0,0,243,5657,0,0;QS=3,0;MQSB=0.0443614;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,18,168:6:0:5,0:1,0:6,0 0,6,53:2:0:0,0:2,0:2,0 0,12,81:4:0:4,0:0,0:4,0 +17 224 . G <*> 0 . DP=12;ADF=9,0;ADR=3,0;AD=12,0;I16=9,3,0,0,379,12759,0,0,627,34923,0,0,270,6370,0,0;QS=3,0;MQSB=0.0443614;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,18,168:6:0:5,0:1,0:6,0 0,6,50:2:0:0,0:2,0:2,0 0,12,70:4:0:4,0:0,0:4,0 +17 225 . C <*> 0 . DP=12;ADF=8,0;ADR=3,0;AD=11,0;I16=8,3,0,0,382,13896,0,0,567,31323,0,0,261,6345,0,0;QS=3,0;MQSB=0.0497871;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,18,165:6:0:5,0:1,0:6,0 0,6,48:2:0:0,0:2,0:2,0 0,9,83:3:0:3,0:0,0:3,0 +17 226 . A <*> 0 . DP=13;ADF=8,0;ADR=3,0;AD=11,0;I16=8,3,0,0,381,13669,0,0,567,31323,0,0,248,5894,0,0;QS=3,0;MQSB=0.0497871;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,18,166:6:0:5,0:1,0:6,0 0,6,53:2:0:0,0:2,0:2,0 0,9,84:3:0:3,0:0,0:3,0 +17 227 . C <*> 0 . DP=13;ADF=8,0;ADR=4,0;AD=12,0;I16=8,4,0,0,406,14306,0,0,596,32164,0,0,267,6253,0,0;QS=3,0;MQSB=0.0249144;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,190:7:0:5,0:2,0:7,0 0,6,53:2:0:0,0:2,0:2,0 0,9,73:3:0:3,0:0,0:3,0 +17 228 . C <*> 0 . DP=13;ADF=9,0;ADR=4,0;AD=13,0;I16=9,4,0,0,417,14381,0,0,656,35764,0,0,292,6884,0,0;QS=3,0;MQSB=0.0211283;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,187:7:0:5,0:2,0:7,0 0,6,45:2:0:0,0:2,0:2,0 0,12,96:4:0:4,0:0,0:4,0 +17 229 . G <*> 0 . DP=13;ADF=9,0;ADR=3,0;AD=12,0;I16=9,3,0,0,358,11424,0,0,627,34923,0,0,270,6414,0,0;QS=3,0;MQSB=0.0443614;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,18,136:6:0:5,0:1,0:6,0 0,6,53:2:0:0,0:2,0:2,0 0,12,70:4:0:4,0:0,0:4,0 +17 230 . C <*> 0 . DP=13;ADF=9,0;ADR=4,0;AD=13,0;I16=9,4,0,0,461,16861,0,0,656,35764,0,0,292,6920,0,0;QS=3,0;MQSB=0.0211283;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,186:7:0:5,0:2,0:7,0 0,6,53:2:0:0,0:2,0:2,0 0,12,100:4:0:4,0:0,0:4,0 +17 231 . C <*> 0 . DP=13;ADF=7,0;ADR=4,0;AD=11,0;I16=7,4,0,0,414,15832,0,0,536,28564,0,0,247,5925,0,0;QS=3,0;MQSB=0.0401934;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,18,184:6:0:4,0:2,0:6,0 0,6,53:2:0:0,0:2,0:2,0 0,9,82:3:0:3,0:0,0:3,0 +17 232 . C <*> 0 . DP=14;ADF=9,0;ADR=4,0;AD=13,0;I16=9,4,0,0,471,17371,0,0,656,35764,0,0,267,6363,0,0;QS=3,0;MQSB=0.0211283;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,198:7:0:5,0:2,0:7,0 0,6,53:2:0:0,0:2,0:2,0 0,12,101:4:0:4,0:0,0:4,0 +17 233 . A <*> 0 . DP=14;ADF=10,0;ADR=4,0;AD=14,0;I16=10,4,0,0,496,18142,0,0,716,39364,0,0,292,6984,0,0;QS=3,0;MQSB=0.0183156;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,192:7:0:5,0:2,0:7,0 0,6,53:2:0:0,0:2,0:2,0 0,15,119:5:0:5,0:0,0:5,0 +17 234 . A <*> 0 . DP=14;ADF=10,0;ADR=4,0;AD=14,0;I16=10,4,0,0,502,18390,0,0,716,39364,0,0,292,6988,0,0;QS=3,0;MQSB=0.0183156;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,185:7:0:5,0:2,0:7,0 0,6,53:2:0:0,0:2,0:2,0 0,15,123:5:0:5,0:0,0:5,0 +17 235 . A <*> 0 . DP=14;ADF=9,0;ADR=4,0;AD=13,0;I16=9,4,0,0,476,17652,0,0,656,35764,0,0,267,6375,0,0;QS=3,0;MQSB=0.0211283;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,21,186:7:0:5,0:2,0:7,0 0,6,53:2:0:0,0:2,0:2,0 0,12,111:4:0:4,0:0,0:4,0 +17 236 . G <*> 0 . DP=15;ADF=11,0;ADR=4,0;AD=15,0;I16=11,4,0,0,501,17481,0,0,776,42964,0,0,290,6924,0,0;QS=3,0;MQSB=0.0161635;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,24,206:8:0:6,0:2,0:8,0 0,6,53:2:0:0,0:2,0:2,0 0,15,103:5:0:5,0:0,0:5,0 +17 237 . A <*> 0 . DP=14;ADF=9,0;ADR=4,0;AD=13,0;I16=9,4,0,0,465,16877,0,0,656,35764,0,0,266,6282,0,0;QS=3,0;MQSB=0.0211283;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,24,206:8:0:6,0:2,0:8,0 0,6,53:2:0:0,0:2,0:2,0 0,9,92:3:0:3,0:0,0:3,0 +17 238 . C <*> 0 . DP=14;ADF=10,0;ADR=4,0;AD=14,0;I16=10,4,0,0,482,17238,0,0,716,39364,0,0,292,6900,0,0;QS=3,0;MQSB=0.0183156;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,24,211:8:0:6,0:2,0:8,0 0,6,53:2:0:0,0:2,0:2,0 0,12,82:4:0:4,0:0,0:4,0 +17 239 . A <*> 0 . DP=15;ADF=10,0;ADR=5,0;AD=15,0;I16=10,5,0,0,525,19155,0,0,776,42964,0,0,292,6852,0,0;QS=3,0;MQSB=0.0497871;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,27,223:9:0:6,0:3,0:9,0 0,6,50:2:0:0,0:2,0:2,0 0,12,108:4:0:4,0:0,0:4,0 +17 240 . C <*> 0 . DP=15;ADF=10,0;ADR=5,0;AD=15,0;I16=10,5,0,0,512,17930,0,0,776,42964,0,0,292,6764,0,0;QS=3,0;MQSB=0.0497871;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,27,220:9:0:6,0:3,0:9,0 0,6,53:2:0:0,0:2,0:2,0 0,12,106:4:0:4,0:0,0:4,0 +17 241 . G <*> 0 . DP=15;ADF=9,0;ADR=5,0;AD=14,0;I16=9,5,0,0,444,14636,0,0,716,39364,0,0,269,6159,0,0;QS=3,0;MQSB=0.0561348;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,27,203:9:0:6,0:3,0:9,0 0,6,53:2:0:0,0:2,0:2,0 0,9,59:3:0:3,0:0,0:3,0 +17 242 . C <*> 0 . DP=15;ADF=10,0;ADR=5,0;AD=15,0;I16=10,5,0,0,555,21177,0,0,776,42964,0,0,292,6624,0,0;QS=3,0;MQSB=0.0497871;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,27,242:9:0:6,0:3,0:9,0 0,6,53:2:0:0,0:2,0:2,0 0,12,94:4:0:4,0:0,0:4,0 +17 243 . C <*> 0 . DP=16;ADF=9,0;ADR=5,0;AD=14,0;I16=9,5,0,0,523,19737,0,0,716,39364,0,0,284,6508,0,0;QS=3,0;MQSB=0.0561348;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,24,220:8:0:5,0:3,0:8,0 0,6,53:2:0:0,0:2,0:2,0 0,12,104:4:0:4,0:0,0:4,0 +17 244 . C <*> 0 . DP=16;ADF=10,0;ADR=6,0;AD=16,0;I16=10,6,0,0,620,24272,0,0,805,43805,0,0,298,6568,0,0;QS=3,0;MQSB=0.0253122;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,27,245:9:0:6,0:3,0:9,0 0,9,72:3:0:0,0:3,0:3,0 0,12,106:4:0:4,0:0,0:4,0 +17 245 . A <*> 0 . DP=17;ADF=10,0;ADR=7,0;AD=17,0;I16=10,7,0,0,649,24843,0,0,865,47405,0,0,299,6553,0,0;QS=3,0;MQSB=0.0509867;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,27,236:9:0:6,0:3,0:9,0 0,12,93:4:0:0,0:4,0:4,0 0,12,115:4:0:4,0:0,0:4,0 +17 246 . T <*> 0 . DP=18;ADF=10,0;ADR=8,0;AD=18,0;I16=10,8,0,0,649,23833,0,0,894,48246,0,0,301,6553,0,0;QS=3,0;MQSB=0.0286491;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,30,247:10:0:6,0:4,0:10,0 0,12,94:4:0:0,0:4,0:4,0 0,12,98:4:0:4,0:0,0:4,0 +17 247 . G <*> 0 . DP=18;ADF=10,0;ADR=8,0;AD=18,0;I16=10,8,0,0,642,23610,0,0,894,48246,0,0,304,6570,0,0;QS=3,0;MQSB=0.0286491;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,30,252:10:0:6,0:4,0:10,0 0,12,83:4:0:0,0:4,0:4,0 0,12,103:4:0:4,0:0,0:4,0 +17 248 . T <*> 0 . DP=18;ADF=10,0;ADR=8,0;AD=18,0;I16=10,8,0,0,636,22944,0,0,894,48246,0,0,307,6605,0,0;QS=3,0;MQSB=0.0286491;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,30,234:10:0:6,0:4,0:10,0 0,12,86:4:0:0,0:4,0:4,0 0,12,114:4:0:4,0:0,0:4,0 +17 249 . C <*> 0 . DP=18;ADF=10,0;ADR=8,0;AD=18,0;I16=10,8,0,0,656,24846,0,0,894,48246,0,0,310,6658,0,0;QS=3,0;MQSB=0.0286491;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,30,253:10:0:6,0:4,0:10,0 0,12,79:4:0:0,0:4,0:4,0 0,12,112:4:0:4,0:0,0:4,0 +17 250 . C <*> 0 . DP=19;ADF=10,0;ADR=9,0;AD=19,0;I16=10,9,0,0,694,26160,0,0,923,49087,0,0,311,6631,0,0;QS=3,0;MQSB=0.0168512;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,30,248:10:0:6,0:4,0:10,0 0,12,89:4:0:0,0:4,0:4,0 0,15,142:5:0:4,0:1,0:5,0 +17 251 . A <*> 0 . DP=19;ADF=9,0;ADR=9,0;AD=18,0;I16=9,9,0,0,688,26506,0,0,863,45487,0,0,313,6627,0,0;QS=3,0;MQSB=0.0208913;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,27,233:9:0:5,0:4,0:9,0 0,12,97:4:0:0,0:4,0:4,0 0,15,148:5:0:4,0:1,0:5,0 +17 252 . G <*> 0 . DP=18;ADF=8,0;ADR=9,0;AD=17,0;I16=8,9,0,0,641,24631,0,0,803,41887,0,0,304,6502,0,0;QS=3,0;MQSB=0.026526;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,27,243:9:0:5,0:4,0:9,0 0,12,91:4:0:0,0:4,0:4,0 0,12,121:4:0:3,0:1,0:4,0 +17 253 . C <*> 0 . DP=19;ADF=9,0;ADR=10,0;AD=19,0;I16=9,10,0,0,705,26921,0,0,892,46328,0,0,319,6687,0,0;QS=3,0;MQSB=0.0132999;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,27,247:9:0:5,0:4,0:9,0 0,12,86:4:0:0,0:4,0:4,0 0,18,155:6:0:4,0:2,0:6,0 +17 254 . T <*> 0 . DP=20;ADF=10,0;ADR=9,0;AD=19,0;I16=10,9,0,0,719,27517,0,0,892,46328,0,0,314,6670,0,0;QS=3,0;MQSB=0.00482795;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,30,254:10:0:6,0:4,0:10,0 0,9,72:3:0:0,0:3,0:3,0 0,18,164:6:0:4,0:2,0:6,0 +17 255 . T <*> 0 . DP=21;ADF=11,0;ADR=10,0;AD=21,0;I16=11,10,0,0,750,27076,0,0,1012,53528,0,0,328,6840,0,0;QS=3,0;MQSB=0.00822975;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,241:11:0:7,0:4,0:11,0 0,12,95:4:0:0,0:4,0:4,0 0,18,161:6:0:4,0:2,0:6,0 +17 256 . A <*> 0 . DP=22;ADF=11,0;ADR=11,0;AD=22,0;I16=11,11,0,0,811,30063,0,0,1049,54897,0,0,334,6956,0,0;QS=3,0;MQSB=0.00507916;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:7,0:4,0:11,0 0,15,110:5:0:0,0:5,0:5,0 0,18,166:6:0:4,0:2,0:6,0 +17 257 . T <*> 0 . DP=22;ADF=11,0;ADR=11,0;AD=22,0;I16=11,11,0,0,814,30420,0,0,1049,54897,0,0,341,7101,0,0;QS=3,0;MQSB=0.00507916;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,247:11:0:7,0:4,0:11,0 0,15,113:5:0:0,0:5,0:5,0 0,18,168:6:0:4,0:2,0:6,0 +17 258 . T <*> 0 . DP=22;ADF=11,0;ADR=11,0;AD=22,0;I16=11,11,0,0,791,28943,0,0,1049,54897,0,0,347,7225,0,0;QS=3,0;MQSB=0.00507916;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,254:11:0:7,0:4,0:11,0 0,15,116:5:0:0,0:5,0:5,0 0,18,155:6:0:4,0:2,0:6,0 +17 259 . C <*> 0 . DP=22;ADF=11,0;ADR=10,0;AD=21,0;I16=11,10,0,0,785,29809,0,0,1020,54056,0,0,332,6936,0,0;QS=3,0;MQSB=0.00822975;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:7,0:4,0:11,0 0,12,90:4:0:0,0:4,0:4,0 0,18,170:6:0:4,0:2,0:6,0 +17 260 . T <*> 0 . DP=21;ADF=10,0;ADR=11,0;AD=21,0;I16=10,11,0,0,829,32899,0,0,989,51297,0,0,360,7556,0,0;QS=3,0;MQSB=0.00660016;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:7,0:4,0:11,0 0,15,118:5:0:0,0:5,0:5,0 0,15,156:5:0:3,0:2,0:5,0 +17 261 . G <*> 0 . DP=21;ADF=10,0;ADR=11,0;AD=21,0;I16=10,11,0,0,735,27379,0,0,989,51297,0,0,367,7761,0,0;QS=3,0;MQSB=0.00660016;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,254:11:0:7,0:4,0:11,0 0,15,111:5:0:0,0:5,0:5,0 0,15,122:5:0:3,0:2,0:5,0 +17 262 . C <*> 0 . DP=22;ADF=10,0;ADR=12,0;AD=22,0;I16=10,12,0,0,806,30278,0,0,1049,54897,0,0,373,7941,0,0;QS=3,0;MQSB=0.0122507;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:7,0:4,0:11,0 0,15,99:5:0:0,0:5,0:5,0 0,18,164:6:0:3,0:3,0:6,0 +17 263 . C <*> 0 . DP=22;ADF=10,0;ADR=12,0;AD=22,0;I16=10,12,0,0,799,29717,0,0,1049,54897,0,0,380,8146,0,0;QS=3,0;MQSB=0.0122507;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:7,0:4,0:11,0 0,15,98:5:0:0,0:5,0:5,0 0,18,168:6:0:3,0:3,0:6,0 +17 264 . C <*> 0 . DP=22;ADF=10,0;ADR=12,0;AD=22,0;I16=10,12,0,0,821,31325,0,0,1049,54897,0,0,386,8326,0,0;QS=3,0;MQSB=0.0122507;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:7,0:4,0:11,0 0,15,104:5:0:0,0:5,0:5,0 0,18,172:6:0:3,0:3,0:6,0 +17 265 . A <*> 0 . DP=21;ADF=9,0;ADR=12,0;AD=21,0;I16=9,12,0,0,800,31906,0,0,989,51297,0,0,390,8380,0,0;QS=3,0;MQSB=0.0158903;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:7,0:4,0:11,0 0,15,114:5:0:0,0:5,0:5,0 0,15,129:5:0:2,0:3,0:5,0 +17 266 . G <*> 0 . DP=21;ADF=9,0;ADR=11,0;AD=20,0;I16=9,11,0,0,747,28155,0,0,960,50456,0,0,369,7833,0,0;QS=3,0;MQSB=0.0237479;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:7,0:4,0:11,0 0,12,97:4:0:0,0:4,0:4,0 0,15,138:5:0:2,0:3,0:5,0 +17 267 . T <*> 0 . DP=21;ADF=9,0;ADR=11,0;AD=20,0;I16=9,11,0,0,739,27465,0,0,960,50456,0,0,373,7935,0,0;QS=3,0;MQSB=0.0237479;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,254:11:0:7,0:4,0:11,0 0,12,101:4:0:0,0:4,0:4,0 0,15,149:5:0:2,0:3,0:5,0 +17 268 . T <*> 0 . DP=21;ADF=9,0;ADR=12,0;AD=21,0;I16=9,12,0,0,748,27708,0,0,989,51297,0,0,402,8686,0,0;QS=3,0;MQSB=0.0158903;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,238:11:0:7,0:4,0:11,0 0,15,110:5:0:0,0:5,0:5,0 0,15,156:5:0:2,0:3,0:5,0 +17 269 . C <*> 0 . DP=22;ADF=9,0;ADR=12,0;AD=21,0;I16=9,12,0,0,764,28632,0,0,989,51297,0,0,381,8211,0,0;QS=3,0;MQSB=0.0158903;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,36,255:12:0:7,0:5,0:12,0 0,12,91:4:0:0,0:4,0:4,0 0,15,154:5:0:2,0:3,0:5,0 +17 270 . C <*> 0 . DP=22;ADF=9,0;ADR=12,0;AD=21,0;I16=9,12,0,0,758,28146,0,0,989,51297,0,0,385,8337,0,0;QS=3,0;MQSB=0.0158903;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,36,255:12:0:7,0:5,0:12,0 0,12,96:4:0:0,0:4,0:4,0 0,15,143:5:0:2,0:3,0:5,0 +17 271 . T <*> 0 . DP=22;ADF=9,0;ADR=13,0;AD=22,0;I16=9,13,0,0,847,32935,0,0,1018,52138,0,0,413,9065,0,0;QS=3,0;MQSB=0.0109431;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,36,255:12:0:7,0:5,0:12,0 0,15,113:5:0:0,0:5,0:5,0 0,15,152:5:0:2,0:3,0:5,0 +17 272 . C <*> 0 . DP=22;ADF=9,0;ADR=12,0;AD=21,0;I16=9,12,0,0,809,31413,0,0,989,51297,0,0,390,8518,0,0;QS=3,0;MQSB=0.0158903;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,36,255:12:0:7,0:5,0:12,0 0,12,96:4:0:0,0:4,0:4,0 0,15,149:5:0:2,0:3,0:5,0 +17 273 . T <*> 0 . DP=22;ADF=9,0;ADR=12,0;AD=21,0;I16=9,12,0,0,798,30664,0,0,989,51297,0,0,392,8620,0,0;QS=3,0;MQSB=0.0158903;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,36,255:12:0:7,0:5,0:12,0 0,12,95:4:0:0,0:4,0:4,0 0,15,161:5:0:2,0:3,0:5,0 +17 274 . C <*> 0 . DP=22;ADF=9,0;ADR=12,0;AD=21,0;I16=9,12,0,0,763,28177,0,0,989,51297,0,0,394,8746,0,0;QS=3,0;MQSB=0.0158903;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,36,255:12:0:7,0:5,0:12,0 0,12,101:4:0:0,0:4,0:4,0 0,15,144:5:0:2,0:3,0:5,0 +17 275 . C <*> 0 . DP=20;ADF=7,0;ADR=13,0;AD=20,0;I16=7,13,0,0,768,29994,0,0,898,44938,0,0,423,9519,0,0;QS=3,0;MQSB=0.0213617;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:6,0:5,0:11,0 0,15,114:5:0:0,0:5,0:5,0 0,12,122:4:0:1,0:3,0:4,0 +17 276 . A <*> 0 . DP=20;ADF=7,0;ADR=13,0;AD=20,0;I16=7,13,0,0,805,32931,0,0,898,44938,0,0,424,9538,0,0;QS=3,0;MQSB=0.0213617;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,253:11:0:6,0:5,0:11,0 0,15,122:5:0:0,0:5,0:5,0 0,12,124:4:0:1,0:3,0:4,0 +17 277 . G <*> 0 . DP=20;ADF=7,0;ADR=13,0;AD=20,0;I16=7,13,0,0,764,29732,0,0,898,44938,0,0,425,9579,0,0;QS=3,0;MQSB=0.0213617;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:6,0:5,0:11,0 0,15,114:5:0:0,0:5,0:5,0 0,12,121:4:0:1,0:3,0:4,0 +17 278 . A <*> 0 . DP=21;ADF=6,0;ADR=14,0;AD=20,0;I16=6,14,0,0,722,26452,0,0,867,42179,0,0,415,9521,0,0;QS=3,0;MQSB=0.0246228;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,30,238:10:0:5,0:5,0:10,0 0,18,123:6:0:0,0:6,0:6,0 0,12,121:4:0:1,0:3,0:4,0 +17 279 . A <*> 0 . DP=22;ADF=7,0;ADR=15,0;AD=22,0;I16=7,15,0,0,786,28694,0,0,956,46620,0,0,427,9677,0,0;QS=3,0;MQSB=0.0124927;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,36,255:12:0:6,0:6,0:12,0 0,18,123:6:0:0,0:6,0:6,0 0,12,122:4:0:1,0:3,0:4,0 +17 280 . A <*> 0 . DP=22;ADF=7,0;ADR=15,0;AD=22,0;I16=7,15,0,0,815,31561,0,0,956,46620,0,0,428,9684,0,0;QS=3,0;MQSB=0.0124927;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,36,253:12:0:6,0:6,0:12,0 0,18,130:6:0:0,0:6,0:6,0 0,12,129:4:0:1,0:3,0:4,0 +17 281 . G <*> 0 . DP=22;ADF=7,0;ADR=15,0;AD=22,0;I16=7,15,0,0,820,31416,0,0,956,46620,0,0,428,9662,0,0;QS=3,0;MQSB=0.0124927;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,36,255:12:0:6,0:6,0:12,0 0,18,122:6:0:0,0:6,0:6,0 0,12,123:4:0:1,0:3,0:4,0 +17 282 . G <*> 0 . DP=22;ADF=7,0;ADR=15,0;AD=22,0;I16=7,15,0,0,806,30420,0,0,956,46620,0,0,427,9609,0,0;QS=3,0;MQSB=0.0124927;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,36,253:12:0:6,0:6,0:12,0 0,18,124:6:0:0,0:6,0:6,0 0,12,119:4:0:1,0:3,0:4,0 +17 283 . C <*> 0 . DP=23;ADF=7,0;ADR=15,0;AD=22,0;I16=7,15,0,0,827,31785,0,0,956,46620,0,0,426,9574,0,0;QS=3,0;MQSB=0.0124927;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,36,255:12:0:6,0:6,0:12,0 0,18,125:6:0:0,0:6,0:6,0 0,12,122:4:0:1,0:3,0:4,0 +17 284 . T <*> 0 . DP=23;ADF=7,0;ADR=16,0;AD=23,0;I16=7,16,0,0,901,35479,0,0,1016,50220,0,0,431,9593,0,0;QS=3,0;MQSB=0.0194969;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,36,255:12:0:6,0:6,0:12,0 0,18,126:6:0:0,0:6,0:6,0 0,15,144:5:0:1,0:4,0:5,0 +17 285 . G <*> 0 . DP=23;ADF=7,0;ADR=16,0;AD=23,0;I16=7,16,0,0,860,32856,0,0,1016,50220,0,0,431,9607,0,0;QS=3,0;MQSB=0.0194969;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,36,255:12:0:6,0:6,0:12,0 0,18,119:6:0:0,0:6,0:6,0 0,15,132:5:0:1,0:4,0:5,0 +17 286 . C <*> 0 . DP=24;ADF=8,0;ADR=16,0;AD=24,0;I16=8,16,0,0,875,32883,0,0,1076,53820,0,0,431,9641,0,0;QS=3,0;MQSB=0.0132999;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,36,255:12:0:6,0:6,0:12,0 0,21,150:7:0:1,0:6,0:7,0 0,15,134:5:0:1,0:4,0:5,0 +17 287 . A <*> 0 . DP=25;ADF=9,0;ADR=16,0;AD=25,0;I16=9,16,0,0,895,32957,0,0,1136,57420,0,0,432,9696,0,0;QS=3,0;MQSB=0.00934348;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,36,255:12:0:6,0:6,0:12,0 0,24,178:8:0:2,0:6,0:8,0 0,15,133:5:0:1,0:4,0:5,0 +17 288 . T <*> 0 . DP=25;ADF=9,0;ADR=16,0;AD=25,0;I16=9,16,0,0,931,35011,0,0,1136,57420,0,0,432,9674,0,0;QS=3,0;MQSB=0.00934348;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,36,255:12:0:6,0:6,0:12,0 0,24,184:8:0:2,0:6,0:8,0 0,15,146:5:0:1,0:4,0:5,0 +17 289 . G <*> 0 . DP=25;ADF=9,0;ADR=16,0;AD=25,0;I16=9,16,0,0,939,36117,0,0,1136,57420,0,0,432,9676,0,0;QS=3,0;MQSB=0.00934348;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,36,255:12:0:6,0:6,0:12,0 0,24,185:8:0:2,0:6,0:8,0 0,15,136:5:0:1,0:4,0:5,0 +17 290 . G <*> 0 . DP=23;ADF=8,0;ADR=15,0;AD=23,0;I16=8,15,0,0,805,29157,0,0,1047,52979,0,0,433,9651,0,0;QS=3,0;MQSB=0.0177152;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,240:11:0:5,0:6,0:11,0 0,21,164:7:0:2,0:5,0:7,0 0,15,126:5:0:1,0:4,0:5,0 +17 291 . T <*> 0 . DP=24;ADF=8,0;ADR=15,0;AD=23,0;I16=8,15,0,0,840,31616,0,0,1047,52979,0,0,421,9479,0,0;QS=3,0;MQSB=0.0177152;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,244:11:0:5,0:6,0:11,0 0,21,168:7:0:2,0:5,0:7,0 0,15,136:5:0:1,0:4,0:5,0 +17 292 . T <*> 0 . DP=25;ADF=9,0;ADR=16,0;AD=25,0;I16=9,16,0,0,888,32274,0,0,1167,60179,0,0,436,9668,0,0;QS=3,0;MQSB=0.0197089;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,253:11:0:5,0:6,0:11,0 0,24,181:8:0:3,0:5,0:8,0 0,18,156:6:0:1,0:5,0:6,0 +17 293 . G <*> 0 . DP=26;ADF=10,0;ADR=15,0;AD=25,0;I16=10,15,0,0,934,35232,0,0,1167,60179,0,0,424,9488,0,0;QS=3,0;MQSB=0.0095249;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,36,255:12:0:6,0:6,0:12,0 0,24,196:8:0:3,0:5,0:8,0 0,15,145:5:0:1,0:4,0:5,0 +17 294 . A <*> 0 . DP=26;ADF=10,0;ADR=16,0;AD=26,0;I16=10,16,0,0,931,33937,0,0,1227,63779,0,0,443,9785,0,0;QS=3,0;MQSB=0.0149748;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,36,252:12:0:6,0:6,0:12,0 0,24,201:8:0:3,0:5,0:8,0 0,18,161:6:0:1,0:5,0:6,0 +17 295 . C <*> 0 . DP=25;ADF=10,0;ADR=14,0;AD=24,0;I16=10,14,0,0,897,33973,0,0,1169,62097,0,0,430,9544,0,0;QS=3,0;MQSB=0.0310726;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:6,0:5,0:11,0 0,21,180:7:0:3,0:4,0:7,0 0,18,159:6:0:1,0:5,0:6,0 +17 296 . A <*> 0 . DP=25;ADF=10,0;ADR=15,0;AD=25,0;I16=10,15,0,0,874,31846,0,0,1198,62938,0,0,451,9905,0,0;QS=3,0;MQSB=0.0213617;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:6,0:5,0:11,0 0,24,169:8:0:3,0:5,0:8,0 0,18,169:6:0:1,0:5,0:6,0 +17 297 . C <*> 0 . DP=25;ADF=9,0;ADR=15,0;AD=24,0;I16=9,15,0,0,901,34305,0,0,1138,59338,0,0,445,9901,0,0;QS=3,0;MQSB=0.0273237;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:6,0:5,0:11,0 0,21,174:7:0:2,0:5,0:7,0 0,18,161:6:0:1,0:5,0:6,0 +17 298 . A <*> 0 . DP=26;ADF=11,0;ADR=15,0;AD=26,0;I16=11,15,0,0,936,34652,0,0,1258,66538,0,0,459,10121,0,0;QS=3,0;MQSB=0.017008;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:6,0:5,0:11,0 0,24,184:8:0:3,0:5,0:8,0 0,21,191:7:0:2,0:5,0:7,0 +17 299 . C <*> 0 . DP=27;ADF=11,0;ADR=15,0;AD=26,0;I16=11,15,0,0,971,36863,0,0,1258,66538,0,0,464,10266,0,0;QS=3,0;MQSB=0.017008;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:6,0:5,0:11,0 0,24,193:8:0:3,0:5,0:8,0 0,21,189:7:0:2,0:5,0:7,0 +17 300 . A <*> 0 . DP=27;ADF=11,0;ADR=15,0;AD=26,0;I16=11,15,0,0,1001,39455,0,0,1258,66538,0,0,469,10437,0,0;QS=3,0;MQSB=0.017008;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:6,0:5,0:11,0 0,24,204:8:0:3,0:5,0:8,0 0,21,210:7:0:2,0:5,0:7,0 +17 301 . G <*> 0 . DP=25;ADF=10,0;ADR=14,0;AD=24,0;I16=10,14,0,0,928,36116,0,0,1169,62097,0,0,476,10632,0,0;QS=3,0;MQSB=0.0310726;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,30,255:10:0:5,0:5,0:10,0 0,21,195:7:0:3,0:4,0:7,0 0,21,196:7:0:2,0:5,0:7,0 +17 302 . T <*> 0 . DP=25;ADF=10,0;ADR=14,0;AD=24,0;I16=10,14,0,0,879,32885,0,0,1169,62097,0,0,483,10849,0,0;QS=3,0;MQSB=0.0310726;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,30,231:10:0:5,0:5,0:10,0 0,21,172:7:0:3,0:4,0:7,0 0,21,202:7:0:2,0:5,0:7,0 +17 302 . T TA 0 . INDEL;IDV=7;IMF=1;DP=25;ADF=2,8;ADR=4,11;AD=6,19;I16=2,4,8,11,214,7674,793,33369,236,10564,993,55133,109,2229,377,8629;QS=0.511212,2.48879;VDB=0.27613;SGB=-4.22417;MQSB=0.0443614;MQ0F=0 PL:DP:SP:ADF:ADR:AD 167,0,96:11:6:1,4:4,2:5,6 157,0,9:7:0:1,2:0,4:1,6 201,21,0:7:0:0,2:0,5:0,7 +17 303 . G <*> 0 . DP=25;ADF=10,0;ADR=15,0;AD=25,0;I16=10,15,0,0,976,38516,0,0,1229,65697,0,0,497,11181,0,0;QS=3,0;MQSB=0.0443614;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:5,0:6,0:11,0 0,21,197:7:0:3,0:4,0:7,0 0,21,195:7:0:2,0:5,0:7,0 +17 304 . C <*> 0 . DP=27;ADF=11,0;ADR=16,0;AD=27,0;I16=11,16,0,0,991,37005,0,0,1318,70138,0,0,503,11359,0,0;QS=3,0;MQSB=0.129164;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:5,0:6,0:11,0 0,24,206:8:0:4,0:4,0:8,0 0,24,200:8:0:2,0:6,0:8,0 +17 305 . C <*> 0 . DP=27;ADF=11,0;ADR=16,0;AD=27,0;I16=11,16,0,0,1057,41761,0,0,1318,70138,0,0,510,11508,0,0;QS=3,0;MQSB=0.129164;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:5,0:6,0:11,0 0,24,213:8:0:4,0:4,0:8,0 0,24,211:8:0:2,0:6,0:8,0 +17 306 . T <*> 0 . DP=27;ADF=11,0;ADR=16,0;AD=27,0;I16=11,16,0,0,1033,40253,0,0,1318,70138,0,0,517,11679,0,0;QS=3,0;MQSB=0.129164;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:5,0:6,0:11,0 0,24,207:8:0:4,0:4,0:8,0 0,24,217:8:0:2,0:6,0:8,0 +17 307 . G <*> 0 . DP=27;ADF=11,0;ADR=15,0;AD=26,0;I16=11,15,0,0,984,37886,0,0,1289,69297,0,0,498,11198,0,0;QS=3,0;MQSB=0.174566;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:5,0:6,0:11,0 0,21,189:7:0:4,0:3,0:7,0 0,24,203:8:0:2,0:6,0:8,0 +17 308 . C <*> 0 . DP=27;ADF=11,0;ADR=16,0;AD=27,0;I16=11,16,0,0,892,30810,0,0,1318,70138,0,0,529,11991,0,0;QS=3,0;MQSB=0.129164;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:5,0:6,0:11,0 0,24,178:8:0:4,0:4,0:8,0 0,24,185:8:0:2,0:6,0:8,0 +17 309 . G <*> 0 . DP=27;ADF=11,0;ADR=16,0;AD=27,0;I16=11,16,0,0,951,34599,0,0,1318,70138,0,0,535,12183,0,0;QS=3,0;MQSB=0.129164;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,243:11:0:5,0:6,0:11,0 0,24,183:8:0:4,0:4,0:8,0 0,24,205:8:0:2,0:6,0:8,0 +17 310 . A <*> 0 . DP=27;ADF=11,0;ADR=16,0;AD=27,0;I16=11,16,0,0,1001,38063,0,0,1318,70138,0,0,540,12350,0,0;QS=3,0;MQSB=0.129164;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:5,0:6,0:11,0 0,24,200:8:0:4,0:4,0:8,0 0,24,217:8:0:2,0:6,0:8,0 +17 311 . C <*> 0 . DP=27;ADF=11,0;ADR=16,0;AD=27,0;I16=11,16,0,0,1037,40263,0,0,1318,70138,0,0,544,12492,0,0;QS=3,0;MQSB=0.129164;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:5,0:6,0:11,0 0,24,215:8:0:4,0:4,0:8,0 0,24,210:8:0:2,0:6,0:8,0 +17 312 . A <*> 0 . DP=26;ADF=10,0;ADR=16,0;AD=26,0;I16=10,16,0,0,985,38043,0,0,1258,66538,0,0,549,12657,0,0;QS=3,0;MQSB=0.157183;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,30,237:10:0:4,0:6,0:10,0 0,24,215:8:0:4,0:4,0:8,0 0,24,218:8:0:2,0:6,0:8,0 +17 313 . A <*> 0 . DP=26;ADF=10,0;ADR=16,0;AD=26,0;I16=10,16,0,0,983,37969,0,0,1258,66538,0,0,551,12695,0,0;QS=3,0;MQSB=0.157183;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,30,235:10:0:4,0:6,0:10,0 0,24,219:8:0:4,0:4,0:8,0 0,24,215:8:0:2,0:6,0:8,0 +17 314 . A <*> 0 . DP=27;ADF=10,0;ADR=17,0;AD=27,0;I16=10,17,0,0,1050,41798,0,0,1318,70138,0,0,553,12757,0,0;QS=3,0;MQSB=0.195223;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,250:11:0:4,0:7,0:11,0 0,24,217:8:0:4,0:4,0:8,0 0,24,227:8:0:2,0:6,0:8,0 +17 315 . G <*> 0 . DP=26;ADF=10,0;ADR=16,0;AD=26,0;I16=10,16,0,0,1025,40941,0,0,1289,69297,0,0,557,12843,0,0;QS=3,0;MQSB=0.252051;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,30,252:10:0:4,0:6,0:10,0 0,24,216:8:0:4,0:4,0:8,0 0,24,225:8:0:2,0:6,0:8,0 +17 316 . C <*> 0 . DP=27;ADF=10,0;ADR=15,0;AD=25,0;I16=10,15,0,0,983,39393,0,0,1252,67928,0,0,535,12277,0,0;QS=3,0;MQSB=0.312403;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,30,255:10:0:4,0:6,0:10,0 0,21,183:7:0:4,0:3,0:7,0 0,24,224:8:0:2,0:6,0:8,0 +17 317 . T <*> 0 . DP=27;ADF=10,0;ADR=16,0;AD=26,0;I16=10,16,0,0,1028,41392,0,0,1320,72056,0,0,547,12557,0,0;QS=3,0;MQSB=0.377061;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,30,255:10:0:4,0:6,0:10,0 0,24,230:8:0:4,0:4,0:8,0 0,24,206:8:0:2,0:6,0:8,0 +17 318 . G <*> 0 . DP=27;ADF=10,0;ADR=17,0;AD=27,0;I16=10,17,0,0,1038,40546,0,0,1349,72897,0,0,570,13018,0,0;QS=3,0;MQSB=0.297797;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,30,249:10:0:4,0:6,0:10,0 0,27,235:9:0:4,0:5,0:9,0 0,24,208:8:0:2,0:6,0:8,0 +17 319 . A <*> 0 . DP=27;ADF=9,0;ADR=17,0;AD=26,0;I16=9,17,0,0,994,38654,0,0,1289,69297,0,0,560,12906,0,0;QS=3,0;MQSB=0.346864;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,30,249:10:0:4,0:6,0:10,0 0,27,228:9:0:4,0:5,0:9,0 0,21,185:7:0:1,0:6,0:7,0 +17 320 . A <*> 0 . DP=27;ADF=10,0;ADR=17,0;AD=27,0;I16=10,17,0,0,1022,39418,0,0,1349,72897,0,0,573,13053,0,0;QS=3,0;MQSB=0.297797;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,30,247:10:0:4,0:6,0:10,0 0,27,230:9:0:4,0:5,0:9,0 0,24,211:8:0:2,0:6,0:8,0 +17 321 . T <*> 0 . DP=27;ADF=10,0;ADR=17,0;AD=27,0;I16=10,17,0,0,1026,39772,0,0,1349,72897,0,0,573,13029,0,0;QS=3,0;MQSB=0.297797;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,30,253:10:0:4,0:6,0:10,0 0,27,214:9:0:4,0:5,0:9,0 0,24,218:8:0:2,0:6,0:8,0 +17 322 . G <*> 0 . DP=28;ADF=10,0;ADR=18,0;AD=28,0;I16=10,18,0,0,1091,43151,0,0,1409,76497,0,0,573,13029,0,0;QS=3,0;MQSB=0.343265;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,30,255:10:0:4,0:6,0:10,0 0,27,226:9:0:4,0:5,0:9,0 0,27,223:9:0:2,0:7,0:9,0 +17 323 . C <*> 0 . DP=28;ADF=9,0;ADR=18,0;AD=27,0;I16=9,18,0,0,1067,42619,0,0,1349,72897,0,0,565,12939,0,0;QS=3,0;MQSB=0.394987;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,30,255:10:0:4,0:6,0:10,0 0,27,225:9:0:4,0:5,0:9,0 0,24,198:8:0:1,0:7,0:8,0 +17 324 . T <*> 0 . DP=30;ADF=12,0;ADR=18,0;AD=30,0;I16=12,18,0,0,1145,44221,0,0,1529,83697,0,0,573,13001,0,0;QS=3,0;MQSB=0.264959;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,30,253:10:0:4,0:6,0:10,0 0,27,237:9:0:4,0:5,0:9,0 0,33,255:11:0:4,0:7,0:11,0 +17 325 . A <*> 0 . DP=31;ADF=13,0;ADR=18,0;AD=31,0;I16=13,18,0,0,1132,42058,0,0,1589,87297,0,0,573,12925,0,0;QS=3,0;MQSB=0.235201;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:5,0:6,0:11,0 0,27,208:9:0:4,0:5,0:9,0 0,33,255:11:0:4,0:7,0:11,0 +17 326 . T <*> 0 . DP=31;ADF=13,0;ADR=18,0;AD=31,0;I16=13,18,0,0,1157,44193,0,0,1589,87297,0,0,574,12878,0,0;QS=3,0;MQSB=0.235201;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:5,0:6,0:11,0 0,27,216:9:0:4,0:5,0:9,0 0,33,255:11:0:4,0:7,0:11,0 +17 327 . C <*> 0 . DP=31;ADF=13,0;ADR=18,0;AD=31,0;I16=13,18,0,0,1147,43895,0,0,1589,87297,0,0,575,12861,0,0;QS=3,0;MQSB=0.235201;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:5,0:6,0:11,0 0,27,198:9:0:4,0:5,0:9,0 0,33,255:11:0:4,0:7,0:11,0 +17 328 . A <*> 0 . DP=31;ADF=13,0;ADR=18,0;AD=31,0;I16=13,18,0,0,1167,44531,0,0,1589,87297,0,0,574,12776,0,0;QS=3,0;MQSB=0.235201;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:5,0:6,0:11,0 0,27,226:9:0:4,0:5,0:9,0 0,33,255:11:0:4,0:7,0:11,0 +17 329 . T <*> 0 . DP=31;ADF=13,0;ADR=18,0;AD=31,0;I16=13,18,0,0,1210,47742,0,0,1589,87297,0,0,572,12676,0,0;QS=3,0;MQSB=0.235201;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:5,0:6,0:11,0 0,27,237:9:0:4,0:5,0:9,0 0,33,255:11:0:4,0:7,0:11,0 +17 330 . T <*> 0 . DP=31;ADF=13,0;ADR=18,0;AD=31,0;I16=13,18,0,0,1185,45839,0,0,1589,87297,0,0,568,12510,0,0;QS=3,0;MQSB=0.235201;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,254:11:0:5,0:6,0:11,0 0,27,231:9:0:4,0:5,0:9,0 0,33,255:11:0:4,0:7,0:11,0 +17 331 . T <*> 0 . DP=32;ADF=14,0;ADR=18,0;AD=32,0;I16=14,18,0,0,1154,42510,0,0,1649,90897,0,0,563,12327,0,0;QS=3,0;MQSB=0.210122;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:5,0:6,0:11,0 0,27,222:9:0:4,0:5,0:9,0 0,36,255:12:0:5,0:7,0:12,0 +17 332 . A <*> 0 . DP=32;ADF=14,0;ADR=18,0;AD=32,0;I16=14,18,0,0,1156,42666,0,0,1649,90897,0,0,560,12178,0,0;QS=3,0;MQSB=0.210122;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,36,255:12:0:6,0:6,0:12,0 0,27,214:9:0:4,0:5,0:9,0 0,33,255:11:0:4,0:7,0:11,0 +17 333 . A <*> 0 . DP=32;ADF=14,0;ADR=18,0;AD=32,0;I16=14,18,0,0,1141,41987,0,0,1649,90897,0,0,558,12064,0,0;QS=3,0;MQSB=0.210122;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,36,255:12:0:6,0:6,0:12,0 0,27,223:9:0:4,0:5,0:9,0 0,33,255:11:0:4,0:7,0:11,0 +17 334 . A <*> 0 . DP=32;ADF=14,0;ADR=18,0;AD=32,0;I16=14,18,0,0,1162,43328,0,0,1649,90897,0,0,556,11986,0,0;QS=3,0;MQSB=0.210122;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,36,255:12:0:6,0:6,0:12,0 0,27,221:9:0:4,0:5,0:9,0 0,33,255:11:0:4,0:7,0:11,0 +17 335 . A <*> 0 . DP=32;ADF=12,0;ADR=18,0;AD=30,0;I16=12,18,0,0,1077,40287,0,0,1529,83697,0,0,552,11934,0,0;QS=3,0;MQSB=0.264959;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,30,250:10:0:4,0:6,0:10,0 0,27,219:9:0:4,0:5,0:9,0 0,33,251:11:0:4,0:7,0:11,0 +17 336 . A <*> 0 . DP=32;ADF=14,0;ADR=17,0;AD=31,0;I16=14,17,0,0,1088,39758,0,0,1612,89528,0,0,536,11574,0,0;QS=3,0;MQSB=0.274662;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:5,0:6,0:11,0 0,24,211:8:0:4,0:4,0:8,0 0,36,255:12:0:5,0:7,0:12,0 +17 337 . C <*> 0 . DP=32;ADF=13,0;ADR=17,0;AD=30,0;I16=13,17,0,0,1115,42381,0,0,1552,85928,0,0,531,11565,0,0;QS=3,0;MQSB=0.301511;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,30,255:10:0:4,0:6,0:10,0 0,24,202:8:0:4,0:4,0:8,0 0,36,255:12:0:5,0:7,0:12,0 +17 338 . T <*> 0 . DP=30;ADF=14,0;ADR=16,0;AD=30,0;I16=14,16,0,0,1191,47979,0,0,1560,86456,0,0,554,11878,0,0;QS=3,0;MQSB=0.242376;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,30,255:10:0:5,0:5,0:10,0 0,24,226:8:0:4,0:4,0:8,0 0,36,255:12:0:5,0:7,0:12,0 +17 339 . C <*> 0 . DP=31;ADF=14,0;ADR=17,0;AD=31,0;I16=14,17,0,0,1130,43210,0,0,1589,87297,0,0,554,11874,0,0;QS=3,0;MQSB=0.175471;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:5,0:6,0:11,0 0,24,185:8:0:4,0:4,0:8,0 0,36,255:12:0:5,0:7,0:12,0 +17 340 . C <*> 0 . DP=31;ADF=14,0;ADR=17,0;AD=31,0;I16=14,17,0,0,1196,47044,0,0,1589,87297,0,0,554,11852,0,0;QS=3,0;MQSB=0.175471;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:5,0:6,0:11,0 0,24,221:8:0:4,0:4,0:8,0 0,36,255:12:0:5,0:7,0:12,0 +17 341 . T <*> 0 . DP=31;ADF=14,0;ADR=17,0;AD=31,0;I16=14,17,0,0,1227,48995,0,0,1589,87297,0,0,554,11862,0,0;QS=3,0;MQSB=0.175471;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:5,0:6,0:11,0 0,24,216:8:0:4,0:4,0:8,0 0,36,255:12:0:5,0:7,0:12,0 +17 342 . T <*> 0 . DP=31;ADF=14,0;ADR=17,0;AD=31,0;I16=14,17,0,0,1162,43942,0,0,1589,87297,0,0,554,11904,0,0;QS=3,0;MQSB=0.175471;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:5,0:6,0:11,0 0,24,210:8:0:4,0:4,0:8,0 0,36,255:12:0:5,0:7,0:12,0 +17 343 . G <*> 0 . DP=32;ADF=14,0;ADR=17,0;AD=31,0;I16=14,17,0,0,1150,43702,0,0,1620,90056,0,0,550,11962,0,0;QS=3,0;MQSB=0.283511;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,30,249:10:0:5,0:5,0:10,0 0,27,218:9:0:4,0:5,0:9,0 0,36,255:12:0:5,0:7,0:12,0 +17 344 . C <*> 0 . DP=32;ADF=14,0;ADR=18,0;AD=32,0;I16=14,18,0,0,1181,45169,0,0,1649,90897,0,0,554,12036,0,0;QS=3,0;MQSB=0.210122;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:5,0:6,0:11,0 0,27,217:9:0:4,0:5,0:9,0 0,36,255:12:0:5,0:7,0:12,0 +17 345 . T <*> 0 . DP=31;ADF=14,0;ADR=17,0;AD=31,0;I16=14,17,0,0,1205,47259,0,0,1589,87297,0,0,555,12129,0,0;QS=3,0;MQSB=0.175471;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:5,0:6,0:11,0 0,24,221:8:0:4,0:4,0:8,0 0,36,255:12:0:5,0:7,0:12,0 +17 346 . G <*> 0 . DP=31;ADF=15,0;ADR=16,0;AD=31,0;I16=15,16,0,0,1147,43597,0,0,1620,90056,0,0,557,12255,0,0;QS=3,0;MQSB=0.220358;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:6,0:5,0:11,0 0,24,212:8:0:4,0:4,0:8,0 0,36,255:12:0:5,0:7,0:12,0 +17 347 . G <*> 0 . DP=31;ADF=14,0;ADR=16,0;AD=30,0;I16=14,16,0,0,1119,42227,0,0,1560,86456,0,0,545,12189,0,0;QS=3,0;MQSB=0.242376;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,30,251:10:0:5,0:5,0:10,0 0,24,207:8:0:4,0:4,0:8,0 0,36,255:12:0:5,0:7,0:12,0 +17 348 . T <*> 0 . DP=32;ADF=15,0;ADR=16,0;AD=31,0;I16=15,16,0,0,1145,43007,0,0,1620,90056,0,0,546,12300,0,0;QS=3,0;MQSB=0.220358;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,30,243:10:0:5,0:5,0:10,0 0,27,228:9:0:5,0:4,0:9,0 0,36,255:12:0:5,0:7,0:12,0 +17 349 . T <*> 0 . DP=32;ADF=16,0;ADR=16,0;AD=32,0;I16=16,16,0,0,1194,45350,0,0,1680,93656,0,0,565,12731,0,0;QS=3,0;MQSB=0.201402;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,246:11:0:6,0:5,0:11,0 0,27,230:9:0:5,0:4,0:9,0 0,36,255:12:0:5,0:7,0:12,0 +17 350 . T <*> 0 . DP=31;ADF=16,0;ADR=15,0;AD=31,0;I16=16,15,0,0,1142,43072,0,0,1651,92815,0,0,567,12837,0,0;QS=3,0;MQSB=0.286505;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,249:11:0:6,0:5,0:11,0 0,27,230:9:0:5,0:4,0:9,0 0,33,255:11:0:5,0:6,0:11,0 +17 351 . G <*> 0 . DP=31;ADF=16,0;ADR=15,0;AD=31,0;I16=16,15,0,0,1146,43750,0,0,1651,92815,0,0,568,12920,0,0;QS=3,0;MQSB=0.286505;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:6,0:5,0:11,0 0,27,212:9:0:5,0:4,0:9,0 0,33,255:11:0:5,0:6,0:11,0 +17 352 . A <*> 0 . DP=31;ADF=16,0;ADR=14,0;AD=30,0;I16=16,14,0,0,1150,45520,0,0,1591,89215,0,0,544,12404,0,0;QS=3,0;MQSB=0.242376;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:6,0:5,0:11,0 0,24,224:8:0:5,0:3,0:8,0 0,33,255:11:0:5,0:6,0:11,0 +17 353 . G <*> 0 . DP=29;ADF=15,0;ADR=14,0;AD=29,0;I16=15,14,0,0,1109,43095,0,0,1562,88374,0,0,570,13064,0,0;QS=3,0;MQSB=0.424373;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,30,255:10:0:5,0:5,0:10,0 0,27,231:9:0:5,0:4,0:9,0 0,30,255:10:0:5,0:5,0:10,0 +17 354 . A <*> 0 . DP=28;ADF=14,0;ADR=14,0;AD=28,0;I16=14,14,0,0,1078,42938,0,0,1502,84774,0,0,571,13075,0,0;QS=3,0;MQSB=0.450096;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,27,225:9:0:4,0:5,0:9,0 0,27,244:9:0:5,0:4,0:9,0 0,30,255:10:0:5,0:5,0:10,0 +17 355 . G T,<*> 0 . DP=28;ADF=14,0,0;ADR=13,1,0;AD=27,1,0;I16=14,13,0,1,1001,37907,41,1681,1442,81174,60,3600,547,12487,25,625;QS=2.875,0.125,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.450096;BQB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 14,0,200,38,203,231:9:0:4,0,0:4,1,0:8,1,0 0,27,222,27,222,222:9:0:5,0,0:4,0,0:9,0,0 0,30,255,30,255,255:10:0:5,0,0:5,0,0:10,0,0 +17 356 . G <*> 0 . DP=27;ADF=14,0;ADR=13,0;AD=27,0;I16=14,13,0,0,993,37481,0,0,1465,83405,0,0,574,13174,0,0;QS=3,0;MQSB=0.580277;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,27,228:9:0:4,0:5,0:9,0 0,24,201:8:0:5,0:3,0:8,0 0,30,255:10:0:5,0:5,0:10,0 +17 357 . C <*> 0 . DP=28;ADF=14,0;ADR=13,0;AD=27,0;I16=14,13,0,0,1021,39471,0,0,1465,83405,0,0,550,12584,0,0;QS=3,0;MQSB=0.580277;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,30,255:10:0:5,0:5,0:10,0 0,24,205:8:0:5,0:3,0:8,0 0,27,251:9:0:4,0:5,0:9,0 +17 358 . A <*> 0 . DP=28;ADF=15,0;ADR=13,0;AD=28,0;I16=15,13,0,0,1050,40518,0,0,1525,87005,0,0,576,13216,0,0;QS=3,0;MQSB=0.556581;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,30,254:10:0:5,0:5,0:10,0 0,24,197:8:0:5,0:3,0:8,0 0,30,255:10:0:5,0:5,0:10,0 +17 359 . G <*> 0 . DP=29;ADF=15,0;ADR=13,0;AD=28,0;I16=15,13,0,0,1085,42761,0,0,1525,87005,0,0,552,12620,0,0;QS=3,0;MQSB=0.556581;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,30,255:10:0:5,0:5,0:10,0 0,21,187:7:0:5,0:2,0:7,0 0,33,255:11:0:5,0:6,0:11,0 +17 360 . A <*> 0 . DP=29;ADF=15,0;ADR=14,0;AD=29,0;I16=15,14,0,0,1111,43259,0,0,1585,90605,0,0,579,13297,0,0;QS=3,0;MQSB=0.604224;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,30,252:10:0:5,0:5,0:10,0 0,24,220:8:0:5,0:3,0:8,0 0,33,255:11:0:5,0:6,0:11,0 +17 361 . A <*> 0 . DP=29;ADF=15,0;ADR=14,0;AD=29,0;I16=15,14,0,0,1116,43442,0,0,1585,90605,0,0,579,13273,0,0;QS=3,0;MQSB=0.604224;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,30,252:10:0:5,0:5,0:10,0 0,24,219:8:0:5,0:3,0:8,0 0,33,255:11:0:5,0:6,0:11,0 +17 362 . A <*> 0 . DP=29;ADF=16,0;ADR=13,0;AD=29,0;I16=16,13,0,0,1104,42700,0,0,1585,90605,0,0,580,13272,0,0;QS=3,0;MQSB=0.535133;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:6,0:5,0:11,0 0,24,218:8:0:5,0:3,0:8,0 0,30,255:10:0:5,0:5,0:10,0 +17 363 . A <*> 0 . DP=29;ADF=16,0;ADR=13,0;AD=29,0;I16=16,13,0,0,1087,41437,0,0,1585,90605,0,0,581,13245,0,0;QS=3,0;MQSB=0.535133;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:6,0:5,0:11,0 0,24,213:8:0:5,0:3,0:8,0 0,30,255:10:0:5,0:5,0:10,0 +17 364 . T <*> 0 . DP=29;ADF=16,0;ADR=13,0;AD=29,0;I16=16,13,0,0,1032,37960,0,0,1585,90605,0,0,582,13244,0,0;QS=3,0;MQSB=0.535133;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,250:11:0:6,0:5,0:11,0 0,24,205:8:0:5,0:3,0:8,0 0,30,255:10:0:5,0:5,0:10,0 +17 365 . G <*> 0 . DP=29;ADF=16,0;ADR=13,0;AD=29,0;I16=16,13,0,0,1105,43079,0,0,1585,90605,0,0,582,13218,0,0;QS=3,0;MQSB=0.535133;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:6,0:5,0:11,0 0,24,211:8:0:5,0:3,0:8,0 0,30,255:10:0:5,0:5,0:10,0 +17 366 . A <*> 0 . DP=29;ADF=16,0;ADR=13,0;AD=29,0;I16=16,13,0,0,1090,41562,0,0,1585,90605,0,0,581,13167,0,0;QS=3,0;MQSB=0.535133;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:6,0:5,0:11,0 0,24,211:8:0:5,0:3,0:8,0 0,30,255:10:0:5,0:5,0:10,0 +17 367 . T <*> 0 . DP=29;ADF=16,0;ADR=13,0;AD=29,0;I16=16,13,0,0,1055,39149,0,0,1585,90605,0,0,579,13093,0,0;QS=3,0;MQSB=0.535133;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:6,0:5,0:11,0 0,24,204:8:0:5,0:3,0:8,0 0,30,255:10:0:5,0:5,0:10,0 +17 368 . A <*> 0 . DP=29;ADF=16,0;ADR=13,0;AD=29,0;I16=16,13,0,0,1054,39632,0,0,1585,90605,0,0,576,12998,0,0;QS=3,0;MQSB=0.535133;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:6,0:5,0:11,0 0,24,208:8:0:5,0:3,0:8,0 0,30,255:10:0:5,0:5,0:10,0 +17 369 . T <*> 0 . DP=28;ADF=16,0;ADR=11,0;AD=27,0;I16=16,11,0,0,1037,40275,0,0,1496,86164,0,0,548,12256,0,0;QS=3,0;MQSB=0.659218;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,30,250:10:0:6,0:4,0:10,0 0,21,196:7:0:5,0:2,0:7,0 0,30,255:10:0:5,0:5,0:10,0 +17 370 . C <*> 0 . DP=28;ADF=16,0;ADR=12,0;AD=28,0;I16=16,12,0,0,1045,40219,0,0,1556,89764,0,0,570,12790,0,0;QS=3,0;MQSB=0.705296;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,30,255:10:0:6,0:4,0:10,0 0,24,201:8:0:5,0:3,0:8,0 0,30,255:10:0:5,0:5,0:10,0 +17 371 . T <*> 0 . DP=29;ADF=16,0;ADR=13,0;AD=29,0;I16=16,13,0,0,1155,46591,0,0,1616,93364,0,0,567,12725,0,0;QS=3,0;MQSB=0.744925;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,30,255:10:0:6,0:4,0:10,0 0,24,227:8:0:5,0:3,0:8,0 0,33,255:11:0:5,0:6,0:11,0 +17 372 . C <*> 0 . DP=30;ADF=16,0;ADR=14,0;AD=30,0;I16=16,14,0,0,1139,44019,0,0,1676,96964,0,0,564,12636,0,0;QS=3,0;MQSB=0.779025;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:6,0:5,0:11,0 0,24,215:8:0:5,0:3,0:8,0 0,33,255:11:0:5,0:6,0:11,0 +17 373 . A <*> 0 . DP=30;ADF=16,0;ADR=14,0;AD=30,0;I16=16,14,0,0,1142,44118,0,0,1676,96964,0,0,561,12525,0,0;QS=3,0;MQSB=0.779025;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:6,0:5,0:11,0 0,24,220:8:0:5,0:3,0:8,0 0,33,255:11:0:5,0:6,0:11,0 +17 374 . T <*> 0 . DP=30;ADF=16,0;ADR=14,0;AD=30,0;I16=16,14,0,0,1098,41180,0,0,1676,96964,0,0,556,12344,0,0;QS=3,0;MQSB=0.779025;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:6,0:5,0:11,0 0,24,221:8:0:5,0:3,0:8,0 0,33,255:11:0:5,0:6,0:11,0 +17 375 . A T,<*> 0 . DP=31;ADF=17,0,0;ADR=13,1,0;AD=30,1,0;I16=17,13,0,1,1138,43798,14,196,1676,96964,60,3600,547,12177,4,16;QS=2.9661,0.0338983,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.763662;BQB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,36,255,36,255,255:12:0:7,0,0:5,0,0:12,0,0 0,24,218,24,218,218:8:0:5,0,0:3,0,0:8,0,0 0,18,255,30,255,255:11:0:5,0,0:5,1,0:10,1,0 +17 376 . G <*> 0 . DP=31;ADF=17,0;ADR=14,0;AD=31,0;I16=17,14,0,0,1131,42581,0,0,1736,100564,0,0,547,12073,0,0;QS=3,0;MQSB=0.763662;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,36,255:12:0:7,0:5,0:12,0 0,24,220:8:0:5,0:3,0:8,0 0,33,255:11:0:5,0:6,0:11,0 +17 377 . T <*> 0 . DP=31;ADF=16,0;ADR=14,0;AD=30,0;I16=16,14,0,0,1105,41629,0,0,1676,96964,0,0,518,11360,0,0;QS=3,0;MQSB=0.779025;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:6,0:5,0:11,0 0,24,211:8:0:5,0:3,0:8,0 0,33,255:11:0:5,0:6,0:11,0 +17 378 . T <*> 0 . DP=30;ADF=18,0;ADR=12,0;AD=30,0;I16=18,12,0,0,1098,41066,0,0,1707,99723,0,0,541,11927,0,0;QS=3,0;MQSB=0.878946;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,39,255:13:0:8,0:5,0:13,0 0,21,186:7:0:5,0:2,0:7,0 0,30,255:10:0:5,0:5,0:10,0 +17 379 . G <*> 0 . DP=29;ADF=18,0;ADR=10,0;AD=28,0;I16=18,10,0,0,1053,40181,0,0,1618,95282,0,0,534,11848,0,0;QS=3,0;MQSB=0.981777;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:8,0:3,0:11,0 0,21,187:7:0:5,0:2,0:7,0 0,30,255:10:0:5,0:5,0:10,0 +17 380 . C <*> 0 . DP=29;ADF=18,0;ADR=10,0;AD=28,0;I16=18,10,0,0,1087,42743,0,0,1618,95282,0,0,514,11172,0,0;QS=3,0;MQSB=0.981777;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,36,255:12:0:8,0:4,0:12,0 0,18,177:6:0:5,0:1,0:6,0 0,30,255:10:0:5,0:5,0:10,0 +17 381 . T <*> 0 . DP=29;ADF=18,0;ADR=11,0;AD=29,0;I16=18,11,0,0,1168,47412,0,0,1678,98882,0,0,537,11729,0,0;QS=3,0;MQSB=0.987702;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,36,255:12:0:8,0:4,0:12,0 0,21,212:7:0:5,0:2,0:7,0 0,30,255:10:0:5,0:5,0:10,0 +17 382 . T <*> 0 . DP=29;ADF=17,0;ADR=11,0;AD=28,0;I16=17,11,0,0,1054,40450,0,0,1618,95282,0,0,510,11068,0,0;QS=3,0;MQSB=0.990092;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,33,255:11:0:7,0:4,0:11,0 0,21,182:7:0:5,0:2,0:7,0 0,30,255:10:0:5,0:5,0:10,0 +17 383 . T <*> 0 . DP=29;ADF=18,0;ADR=10,0;AD=28,0;I16=18,10,0,0,1052,39798,0,0,1618,95282,0,0,507,11013,0,0;QS=3,0;MQSB=0.981777;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,36,255:12:0:8,0:4,0:12,0 0,18,165:6:0:5,0:1,0:6,0 0,30,255:10:0:5,0:5,0:10,0 +17 384 . A <*> 0 . DP=31;ADF=19,0;ADR=11,0;AD=30,0;I16=19,11,0,0,1077,39885,0,0,1738,102482,0,0,504,10988,0,0;QS=3,0;MQSB=0.985292;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,39,255:13:0:8,0:5,0:13,0 0,21,176:7:0:6,0:1,0:7,0 0,30,255:10:0:5,0:5,0:10,0 +17 385 . C <*> 0 . DP=31;ADF=19,0;ADR=12,0;AD=31,0;I16=19,12,0,0,1118,41180,0,0,1798,106082,0,0,527,11569,0,0;QS=3,0;MQSB=0.989977;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,39,255:13:0:8,0:5,0:13,0 0,24,186:8:0:6,0:2,0:8,0 0,30,255:10:0:5,0:5,0:10,0 +17 386 . T <*> 0 . DP=30;ADF=18,0;ADR=12,0;AD=30,0;I16=18,12,0,0,1158,45592,0,0,1738,102482,0,0,526,11556,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,39,255:13:0:8,0:5,0:13,0 0,21,191:7:0:5,0:2,0:7,0 0,30,255:10:0:5,0:5,0:10,0 +17 387 . T <*> 0 . DP=30;ADF=18,0;ADR=12,0;AD=30,0;I16=18,12,0,0,1105,41821,0,0,1738,102482,0,0,525,11573,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,39,255:13:0:8,0:5,0:13,0 0,21,187:7:0:5,0:2,0:7,0 0,30,255:10:0:5,0:5,0:10,0 +17 388 . T <*> 0 . DP=29;ADF=17,0;ADR=12,0;AD=29,0;I16=17,12,0,0,1089,41577,0,0,1678,98882,0,0,523,11519,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,39,255:13:0:8,0:5,0:13,0 0,18,180:6:0:4,0:2,0:6,0 0,30,255:10:0:5,0:5,0:10,0 +17 389 . G <*> 0 . DP=29;ADF=17,0;ADR=12,0;AD=29,0;I16=17,12,0,0,1067,40095,0,0,1678,98882,0,0,520,11444,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,39,255:13:0:8,0:5,0:13,0 0,18,171:6:0:4,0:2,0:6,0 0,30,255:10:0:5,0:5,0:10,0 +17 390 . C <*> 0 . DP=29;ADF=17,0;ADR=12,0;AD=29,0;I16=17,12,0,0,1071,40423,0,0,1678,98882,0,0,517,11399,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,39,255:13:0:8,0:5,0:13,0 0,18,162:6:0:4,0:2,0:6,0 0,30,255:10:0:5,0:5,0:10,0 +17 391 . A <*> 0 . DP=29;ADF=18,0;ADR=11,0;AD=29,0;I16=18,11,0,0,1091,41603,0,0,1647,96123,0,0,515,11383,0,0;QS=3,0;MQSB=0.995968;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,39,255:13:0:8,0:5,0:13,0 0,18,163:6:0:4,0:2,0:6,0 0,30,255:10:0:6,0:4,0:10,0 +17 392 . T <*> 0 . DP=29;ADF=18,0;ADR=11,0;AD=29,0;I16=18,11,0,0,1046,38838,0,0,1647,96123,0,0,515,11395,0,0;QS=3,0;MQSB=0.995968;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,39,255:13:0:8,0:5,0:13,0 0,15,153:5:0:3,0:2,0:5,0 0,33,255:11:0:7,0:4,0:11,0 +17 393 . A <*> 0 . DP=28;ADF=17,0;ADR=11,0;AD=28,0;I16=17,11,0,0,1014,37582,0,0,1587,92523,0,0,517,11435,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,36,255:12:0:7,0:5,0:12,0 0,15,133:5:0:3,0:2,0:5,0 0,33,255:11:0:7,0:4,0:11,0 +17 394 . T <*> 0 . DP=28;ADF=17,0;ADR=11,0;AD=28,0;I16=17,11,0,0,1022,38342,0,0,1587,92523,0,0,519,11503,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,36,255:12:0:7,0:5,0:12,0 0,15,141:5:0:3,0:2,0:5,0 0,33,255:11:0:7,0:4,0:11,0 +17 395 . T <*> 0 . DP=28;ADF=17,0;ADR=11,0;AD=28,0;I16=17,11,0,0,1060,40596,0,0,1587,92523,0,0,521,11599,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,36,255:12:0:7,0:5,0:12,0 0,15,164:5:0:3,0:2,0:5,0 0,33,255:11:0:7,0:4,0:11,0 +17 396 . T <*> 0 . DP=28;ADF=17,0;ADR=11,0;AD=28,0;I16=17,11,0,0,1032,39228,0,0,1587,92523,0,0,523,11723,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,36,255:12:0:7,0:5,0:12,0 0,15,158:5:0:3,0:2,0:5,0 0,33,255:11:0:7,0:4,0:11,0 +17 397 . T <*> 0 . DP=28;ADF=17,0;ADR=11,0;AD=28,0;I16=17,11,0,0,1046,39510,0,0,1587,92523,0,0,524,11824,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,36,255:12:0:7,0:5,0:12,0 0,15,149:5:0:3,0:2,0:5,0 0,33,255:11:0:7,0:4,0:11,0 +17 398 . A <*> 0 . DP=28;ADF=17,0;ADR=11,0;AD=28,0;I16=17,11,0,0,1021,38105,0,0,1587,92523,0,0,524,11850,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,39,255:13:0:8,0:5,0:13,0 0,15,144:5:0:3,0:2,0:5,0 0,30,255:10:0:6,0:4,0:10,0 +17 399 . A <*> 0 . DP=28;ADF=17,0;ADR=11,0;AD=28,0;I16=17,11,0,0,1015,38469,0,0,1587,92523,0,0,526,11900,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,39,255:13:0:8,0:5,0:13,0 0,15,140:5:0:3,0:2,0:5,0 0,30,255:10:0:6,0:4,0:10,0 +17 400 . A <*> 0 . DP=29;ADF=17,0;ADR=12,0;AD=29,0;I16=17,12,0,0,1056,39702,0,0,1647,96123,0,0,526,11828,0,0;QS=3,0;MQSB=0.988062;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,39,255:13:0:8,0:5,0:13,0 0,15,159:5:0:3,0:2,0:5,0 0,33,255:11:0:6,0:5,0:11,0 +17 401 . A <*> 0 . DP=29;ADF=17,0;ADR=11,0;AD=28,0;I16=17,11,0,0,1052,40302,0,0,1587,92523,0,0,501,11113,0,0;QS=3,0;MQSB=0.993109;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,39,255:13:0:8,0:5,0:13,0 0,15,160:5:0:3,0:2,0:5,0 0,30,255:10:0:6,0:4,0:10,0 +17 402 . T <*> 0 . DP=29;ADF=17,0;ADR=12,0;AD=29,0;I16=17,12,0,0,1082,41232,0,0,1647,96123,0,0,526,11680,0,0;QS=3,0;MQSB=0.988062;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,39,255:13:0:8,0:5,0:13,0 0,15,149:5:0:3,0:2,0:5,0 0,33,255:11:0:6,0:5,0:11,0 +17 403 . T <*> 0 . DP=29;ADF=17,0;ADR=12,0;AD=29,0;I16=17,12,0,0,1085,40985,0,0,1647,96123,0,0,526,11654,0,0;QS=3,0;MQSB=0.988062;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,39,255:13:0:8,0:5,0:13,0 0,15,148:5:0:3,0:2,0:5,0 0,33,255:11:0:6,0:5,0:11,0 +17 404 . G <*> 0 . DP=29;ADF=17,0;ADR=12,0;AD=29,0;I16=17,12,0,0,1074,40524,0,0,1647,96123,0,0,525,11609,0,0;QS=3,0;MQSB=0.988062;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,39,255:13:0:8,0:5,0:13,0 0,15,131:5:0:3,0:2,0:5,0 0,33,255:11:0:6,0:5,0:11,0 +17 405 . T <*> 0 . DP=27;ADF=16,0;ADR=10,0;AD=26,0;I16=16,10,0,0,988,37870,0,0,1498,88082,0,0,519,11543,0,0;QS=3,0;MQSB=0.987578;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,39,255:13:0:8,0:5,0:13,0 0,9,103:3:0:2,0:1,0:3,0 0,30,255:10:0:6,0:4,0:10,0 +17 406 . G <*> 0 . DP=27;ADF=16,0;ADR=11,0;AD=27,0;I16=16,11,0,0,976,36752,0,0,1558,91682,0,0,527,11601,0,0;QS=3,0;MQSB=0.992419;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,39,255:13:0:8,0:5,0:13,0 0,12,125:4:0:2,0:2,0:4,0 0,30,247:10:0:6,0:4,0:10,0 +17 407 . A <*> 0 . DP=27;ADF=16,0;ADR=11,0;AD=27,0;I16=16,11,0,0,1007,38355,0,0,1558,91682,0,0,526,11538,0,0;QS=3,0;MQSB=0.992419;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,39,255:13:0:8,0:5,0:13,0 0,12,125:4:0:2,0:2,0:4,0 0,30,255:10:0:6,0:4,0:10,0 +17 408 . C <*> 0 . DP=28;ADF=16,0;ADR=11,0;AD=27,0;I16=16,11,0,0,1006,38136,0,0,1558,91682,0,0,521,11489,0,0;QS=3,0;MQSB=0.992419;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,42,255:14:0:8,0:6,0:14,0 0,9,110:3:0:2,0:1,0:3,0 0,30,244:10:0:6,0:4,0:10,0 +17 409 . T <*> 0 . DP=29;ADF=17,0;ADR=12,0;AD=29,0;I16=17,12,0,0,1100,42734,0,0,1678,98882,0,0,525,11503,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,42,255:14:0:8,0:6,0:14,0 0,12,131:4:0:2,0:2,0:4,0 0,33,255:11:0:7,0:4,0:11,0 +17 410 . T <*> 0 . DP=29;ADF=17,0;ADR=12,0;AD=29,0;I16=17,12,0,0,1035,38325,0,0,1678,98882,0,0,524,11432,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,42,255:14:0:8,0:6,0:14,0 0,12,125:4:0:2,0:2,0:4,0 0,33,255:11:0:7,0:4,0:11,0 +17 411 . T <*> 0 . DP=29;ADF=17,0;ADR=10,0;AD=27,0;I16=17,10,0,0,1003,37747,0,0,1558,91682,0,0,496,10716,0,0;QS=3,0;MQSB=0.984677;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,42,255:14:0:8,0:6,0:14,0 0,9,104:3:0:2,0:1,0:3,0 0,30,255:10:0:7,0:3,0:10,0 +17 412 . C T,<*> 0 . DP=30;ADF=17,1,0;ADR=12,0,0;AD=29,1,0;I16=17,12,1,0,1094,42458,14,196,1678,98882,60,3600,495,10659,25,625;QS=2.97455,0.0254545,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.991968;BQB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,30,255,42,255,255:15:0:8,1,0:6,0,0:14,1,0 0,12,124,12,124,124:4:0:2,0,0:2,0,0:4,0,0 0,33,255,33,255,255:11:0:7,0,0:4,0,0:11,0,0 +17 413 . A <*> 0 . DP=31;ADF=18,0;ADR=13,0;AD=31,0;I16=18,13,0,0,1189,45985,0,0,1798,106082,0,0,520,11258,0,0;QS=3,0;MQSB=0.995005;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,51,255:17:0:9,0:8,0:17,0 0,9,102:3:0:2,0:1,0:3,0 0,33,255:11:0:7,0:4,0:11,0 +17 414 . T <*> 0 . DP=30;ADF=18,0;ADR=12,0;AD=30,0;I16=18,12,0,0,1151,44355,0,0,1738,102482,0,0,523,11265,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,48,255:16:0:9,0:7,0:16,0 0,9,109:3:0:2,0:1,0:3,0 0,33,255:11:0:7,0:4,0:11,0 +17 415 . G <*> 0 . DP=30;ADF=18,0;ADR=12,0;AD=30,0;I16=18,12,0,0,1131,43175,0,0,1738,102482,0,0,526,11306,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,48,255:16:0:9,0:7,0:16,0 0,9,110:3:0:2,0:1,0:3,0 0,33,255:11:0:7,0:4,0:11,0 +17 416 . G <*> 0 . DP=30;ADF=17,0;ADR=12,0;AD=29,0;I16=17,12,0,0,1083,41273,0,0,1678,98882,0,0,514,11156,0,0;QS=3,0;MQSB=0.993891;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,48,255:16:0:9,0:7,0:16,0 0,9,114:3:0:2,0:1,0:3,0 0,30,253:10:0:6,0:4,0:10,0 +17 417 . C <*> 0 . DP=30;ADF=18,0;ADR=12,0;AD=30,0;I16=18,12,0,0,1114,42244,0,0,1738,102482,0,0,531,11439,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,48,255:16:0:9,0:7,0:16,0 0,9,108:3:0:2,0:1,0:3,0 0,33,255:11:0:7,0:4,0:11,0 +17 418 . A <*> 0 . DP=30;ADF=18,0;ADR=12,0;AD=30,0;I16=18,12,0,0,1146,44248,0,0,1738,102482,0,0,532,11478,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,48,255:16:0:9,0:7,0:16,0 0,9,111:3:0:2,0:1,0:3,0 0,33,255:11:0:7,0:4,0:11,0 +17 419 . T <*> 0 . DP=30;ADF=18,0;ADR=12,0;AD=30,0;I16=18,12,0,0,1117,42327,0,0,1738,102482,0,0,532,11498,0,0;QS=3,0;MQSB=0.991968;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,48,255:16:0:9,0:7,0:16,0 0,9,112:3:0:2,0:1,0:3,0 0,33,255:11:0:7,0:4,0:11,0 +17 420 . A <*> 0 . DP=31;ADF=18,0;ADR=13,0;AD=31,0;I16=18,13,0,0,1117,41011,0,0,1798,106082,0,0,532,11550,0,0;QS=3,0;MQSB=0.995005;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,48,255:16:0:9,0:7,0:16,0 0,9,108:3:0:2,0:1,0:3,0 0,36,255:12:0:7,0:5,0:12,0 +17 421 . A <*> 0 . DP=33;ADF=19,0;ADR=14,0;AD=33,0;I16=19,14,0,0,1208,45398,0,0,1887,110523,0,0,533,11635,0,0;QS=3,0;MQSB=0.986656;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,48,255:16:0:9,0:7,0:16,0 0,9,113:3:0:2,0:1,0:3,0 0,42,255:14:0:8,0:6,0:14,0 +17 422 . A <*> 0 . DP=33;ADF=19,0;ADR=13,0;AD=32,0;I16=19,13,0,0,1205,46441,0,0,1827,106923,0,0,510,11082,0,0;QS=3,0;MQSB=0.991023;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,48,255:16:0:9,0:7,0:16,0 0,9,116:3:0:2,0:1,0:3,0 0,39,255:13:0:8,0:5,0:13,0 +17 423 . T <*> 0 . DP=32;ADF=19,0;ADR=13,0;AD=32,0;I16=19,13,0,0,1202,45416,0,0,1827,106923,0,0,538,11818,0,0;QS=3,0;MQSB=0.991023;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,48,255:16:0:9,0:7,0:16,0 0,9,110:3:0:2,0:1,0:3,0 0,39,255:13:0:8,0:5,0:13,0 +17 424 . A <*> 0 . DP=32;ADF=19,0;ADR=13,0;AD=32,0;I16=19,13,0,0,1147,41685,0,0,1827,106923,0,0,539,11867,0,0;QS=3,0;MQSB=0.991023;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,48,255:16:0:9,0:7,0:16,0 0,9,106:3:0:2,0:1,0:3,0 0,39,255:13:0:8,0:5,0:13,0 +17 425 . A <*> 0 . DP=29;ADF=16,0;ADR=13,0;AD=29,0;I16=16,13,0,0,1070,40616,0,0,1647,96123,0,0,542,11900,0,0;QS=3,0;MQSB=0.976248;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,45,255:15:0:8,0:7,0:15,0 0,9,111:3:0:2,0:1,0:3,0 0,33,249:11:0:6,0:5,0:11,0 +17 426 . T <*> 0 . DP=29;ADF=16,0;ADR=12,0;AD=28,0;I16=16,12,0,0,997,36561,0,0,1587,92523,0,0,519,11287,0,0;QS=3,0;MQSB=0.982906;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,45,255:15:0:8,0:7,0:15,0 0,9,105:3:0:2,0:1,0:3,0 0,30,225:10:0:6,0:4,0:10,0 +17 427 . A <*> 0 . DP=29;ADF=16,0;ADR=13,0;AD=29,0;I16=16,13,0,0,1024,37266,0,0,1647,96123,0,0,546,11952,0,0;QS=3,0;MQSB=0.976248;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,45,255:15:0:8,0:7,0:15,0 0,9,111:3:0:2,0:1,0:3,0 0,33,242:11:0:6,0:5,0:11,0 +17 428 . C <*> 0 . DP=29;ADF=16,0;ADR=13,0;AD=29,0;I16=16,13,0,0,1064,39706,0,0,1647,96123,0,0,548,12020,0,0;QS=3,0;MQSB=0.976248;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,45,255:15:0:8,0:7,0:15,0 0,9,111:3:0:2,0:1,0:3,0 0,33,254:11:0:6,0:5,0:11,0 +17 429 . T <*> 0 . DP=30;ADF=16,0;ADR=14,0;AD=30,0;I16=16,14,0,0,1150,44918,0,0,1707,99723,0,0,549,12067,0,0;QS=3,0;MQSB=0.969373;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,48,255:16:0:8,0:8,0:16,0 0,9,115:3:0:2,0:1,0:3,0 0,33,255:11:0:6,0:5,0:11,0 +17 430 . G <*> 0 . DP=30;ADF=16,0;ADR=14,0;AD=30,0;I16=16,14,0,0,1113,42443,0,0,1707,99723,0,0,551,12145,0,0;QS=3,0;MQSB=0.969373;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,48,255:16:0:8,0:8,0:16,0 0,9,112:3:0:2,0:1,0:3,0 0,33,246:11:0:6,0:5,0:11,0 +17 431 . G <*> 0 . DP=30;ADF=14,0;ADR=14,0;AD=28,0;I16=14,14,0,0,1003,36953,0,0,1587,92523,0,0,553,12255,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,45,255:15:0:7,0:8,0:15,0 0,9,101:3:0:2,0:1,0:3,0 0,30,225:10:0:5,0:5,0:10,0 +17 432 . T <*> 0 . DP=28;ADF=14,0;ADR=14,0;AD=28,0;I16=14,14,0,0,1049,39621,0,0,1587,92523,0,0,556,12346,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,45,255:15:0:7,0:8,0:15,0 0,9,114:3:0:2,0:1,0:3,0 0,30,255:10:0:5,0:5,0:10,0 +17 433 . T <*> 0 . DP=28;ADF=14,0;ADR=12,0;AD=26,0;I16=14,12,0,0,949,35443,0,0,1467,85323,0,0,509,11217,0,0;QS=3,0;MQSB=0.967472;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,42,255:14:0:7,0:7,0:14,0 0,9,112:3:0:2,0:1,0:3,0 0,27,227:9:0:5,0:4,0:9,0 +17 434 . T <*> 0 . DP=29;ADF=15,0;ADR=14,0;AD=29,0;I16=15,14,0,0,1036,37654,0,0,1647,96123,0,0,561,12567,0,0;QS=3,0;MQSB=0.960561;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,48,255:16:0:8,0:8,0:16,0 0,9,98:3:0:2,0:1,0:3,0 0,30,243:10:0:5,0:5,0:10,0 +17 435 . A <*> 0 . DP=29;ADF=15,0;ADR=13,0;AD=28,0;I16=15,13,0,0,1024,37970,0,0,1587,92523,0,0,556,12560,0,0;QS=3,0;MQSB=0.968414;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,45,255:15:0:8,0:7,0:15,0 0,9,103:3:0:2,0:1,0:3,0 0,30,237:10:0:5,0:5,0:10,0 +17 436 . T <*> 0 . DP=28;ADF=14,0;ADR=14,0;AD=28,0;I16=14,14,0,0,998,36220,0,0,1587,92523,0,0,564,12654,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,48,255:16:0:8,0:8,0:16,0 0,9,110:3:0:2,0:1,0:3,0 0,27,223:9:0:4,0:5,0:9,0 +17 437 . T <*> 0 . DP=28;ADF=13,0;ADR=14,0;AD=27,0;I16=13,14,0,0,990,36832,0,0,1558,91682,0,0,549,12435,0,0;QS=3,0;MQSB=0.999706;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,48,255:16:0:8,0:8,0:16,0 0,9,109:3:0:2,0:1,0:3,0 0,24,207:8:0:3,0:5,0:8,0 +17 438 . A <*> 0 . DP=28;ADF=14,0;ADR=13,0;AD=27,0;I16=14,13,0,0,972,35640,0,0,1527,88923,0,0,540,12082,0,0;QS=3,0;MQSB=0.9585;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,48,255:16:0:8,0:8,0:16,0 0,9,107:3:0:2,0:1,0:3,0 0,24,216:8:0:4,0:4,0:8,0 +17 439 . C <*> 0 . DP=28;ADF=14,0;ADR=14,0;AD=28,0;I16=14,14,0,0,1055,40273,0,0,1587,92523,0,0,563,12649,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,48,255:16:0:8,0:8,0:16,0 0,9,107:3:0:2,0:1,0:3,0 0,27,224:9:0:4,0:5,0:9,0 +17 440 . A <*> 0 . DP=28;ADF=14,0;ADR=14,0;AD=28,0;I16=14,14,0,0,1095,43251,0,0,1587,92523,0,0,561,12615,0,0;QS=3,0;MQSB=0.949591;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,48,255:16:0:8,0:8,0:16,0 0,9,115:3:0:2,0:1,0:3,0 0,27,247:9:0:4,0:5,0:9,0 +17 441 . G <*> 0 . DP=29;ADF=15,0;ADR=14,0;AD=29,0;I16=15,14,0,0,1068,40344,0,0,1647,96123,0,0,559,12605,0,0;QS=3,0;MQSB=0.960561;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,51,255:17:0:9,0:8,0:17,0 0,9,104:3:0:2,0:1,0:3,0 0,27,198:9:0:4,0:5,0:9,0 +17 442 . A <*> 0 . DP=29;ADF=15,0;ADR=14,0;AD=29,0;I16=15,14,0,0,1091,41507,0,0,1647,96123,0,0,558,12620,0,0;QS=3,0;MQSB=0.960561;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,51,255:17:0:9,0:8,0:17,0 0,9,112:3:0:2,0:1,0:3,0 0,27,233:9:0:4,0:5,0:9,0 +17 443 . A <*> 0 . DP=30;ADF=15,0;ADR=14,0;AD=29,0;I16=15,14,0,0,1173,49439,0,0,1647,96123,0,0,557,12661,0,0;QS=3,0;MQSB=0.960561;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,51,255:17:0:9,0:8,0:17,0 0,9,129:3:0:2,0:1,0:3,0 0,27,246:9:0:4,0:5,0:9,0 +17 444 . G <*> 0 . DP=29;ADF=15,0;ADR=13,0;AD=28,0;I16=15,13,0,0,1095,44661,0,0,1587,92523,0,0,557,12727,0,0;QS=3,0;MQSB=0.968414;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,51,255:17:0:9,0:8,0:17,0 0,6,91:2:0:2,0:0,0:2,0 0,27,227:9:0:4,0:5,0:9,0 +17 445 . C <*> 0 . DP=30;ADF=16,0;ADR=13,0;AD=29,0;I16=16,13,0,0,1100,43706,0,0,1647,96123,0,0,557,12817,0,0;QS=3,0;MQSB=0.976248;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,51,255:17:0:9,0:8,0:17,0 0,9,111:3:0:3,0:0,0:3,0 0,27,219:9:0:4,0:5,0:9,0 +17 446 . A <*> 0 . DP=30;ADF=16,0;ADR=13,0;AD=29,0;I16=16,13,0,0,1107,44265,0,0,1647,96123,0,0,557,12881,0,0;QS=3,0;MQSB=0.976248;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,51,255:17:0:9,0:8,0:17,0 0,9,115:3:0:3,0:0,0:3,0 0,27,232:9:0:4,0:5,0:9,0 +17 447 . C <*> 0 . DP=29;ADF=16,0;ADR=12,0;AD=28,0;I16=16,12,0,0,1108,45364,0,0,1618,95282,0,0,555,12817,0,0;QS=3,0;MQSB=0.856268;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,48,255:16:0:9,0:7,0:16,0 0,9,114:3:0:3,0:0,0:3,0 0,27,235:9:0:4,0:5,0:9,0 +17 448 . T <*> 0 . DP=29;ADF=16,0;ADR=12,0;AD=28,0;I16=16,12,0,0,1125,47237,0,0,1618,95282,0,0,553,12773,0,0;QS=3,0;MQSB=0.856268;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,48,255:16:0:9,0:7,0:16,0 0,9,118:3:0:3,0:0,0:3,0 0,27,240:9:0:4,0:5,0:9,0 +17 449 . A <*> 0 . DP=28;ADF=15,0;ADR=12,0;AD=27,0;I16=15,12,0,0,1091,45981,0,0,1558,91682,0,0,552,12748,0,0;QS=3,0;MQSB=0.84246;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,48,255:16:0:9,0:7,0:16,0 0,6,90:2:0:2,0:0,0:2,0 0,27,245:9:0:4,0:5,0:9,0 +17 450 . G <*> 0 . DP=28;ADF=15,0;ADR=12,0;AD=27,0;I16=15,12,0,0,1069,44603,0,0,1558,91682,0,0,551,12741,0,0;QS=3,0;MQSB=0.84246;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,48,255:16:0:9,0:7,0:16,0 0,6,91:2:0:2,0:0,0:2,0 0,27,233:9:0:4,0:5,0:9,0 +17 451 . A <*> 0 . DP=28;ADF=15,0;ADR=12,0;AD=27,0;I16=15,12,0,0,1021,41371,0,0,1558,91682,0,0,550,12752,0,0;QS=3,0;MQSB=0.84246;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,48,255:16:0:9,0:7,0:16,0 0,6,93:2:0:2,0:0,0:2,0 0,27,244:9:0:4,0:5,0:9,0 +17 452 . A <*> 0 . DP=31;ADF=18,0;ADR=11,0;AD=29,0;I16=18,11,0,0,1079,43353,0,0,1678,98882,0,0,530,12420,0,0;QS=3,0;MQSB=0.884952;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,54,255:18:0:11,0:7,0:18,0 0,9,110:3:0:3,0:0,0:3,0 0,24,225:8:0:4,0:4,0:8,0 +17 453 . A <*> 0 . DP=31;ADF=17,0;ADR=11,0;AD=28,0;I16=17,11,0,0,1037,41069,0,0,1649,98041,0,0,508,11882,0,0;QS=3,0;MQSB=0.967085;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,54,255:18:0:11,0:7,0:18,0 0,9,111:3:0:3,0:0,0:3,0 0,21,221:7:0:3,0:4,0:7,0 +17 454 . A <*> 0 . DP=31;ADF=18,0;ADR=12,0;AD=30,0;I16=18,12,0,0,1158,47028,0,0,1738,102482,0,0,554,12904,0,0;QS=3,0;MQSB=0.878946;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,51,255:17:0:10,0:7,0:17,0 0,9,113:3:0:3,0:0,0:3,0 0,30,255:10:0:5,0:5,0:10,0 +17 455 . T <*> 0 . DP=32;ADF=17,0;ADR=13,0;AD=30,0;I16=17,13,0,0,1148,46574,0,0,1715,100251,0,0,550,12864,0,0;QS=3,0;MQSB=0.973855;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,48,255:16:0:9,0:7,0:16,0 0,9,113:3:0:3,0:0,0:3,0 0,33,255:11:0:5,0:6,0:11,0 +17 456 . G <*> 0 . DP=32;ADF=17,0;ADR=13,0;AD=30,0;I16=17,13,0,0,1161,47287,0,0,1746,103010,0,0,534,12296,0,0;QS=3,0;MQSB=0.998031;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,51,255:17:0:10,0:7,0:17,0 0,9,116:3:0:3,0:0,0:3,0 0,30,245:10:0:4,0:6,0:10,0 +17 457 . C <*> 0 . DP=33;ADF=19,0;ADR=13,0;AD=32,0;I16=19,13,0,0,1218,48642,0,0,1835,107451,0,0,563,12967,0,0;QS=3,0;MQSB=0.985204;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,54,255:18:0:11,0:7,0:18,0 0,9,118:3:0:3,0:0,0:3,0 0,33,255:11:0:5,0:6,0:11,0 +17 458 . A <*> 0 . DP=33;ADF=19,0;ADR=13,0;AD=32,0;I16=19,13,0,0,1226,49034,0,0,1835,107451,0,0,568,12990,0,0;QS=3,0;MQSB=0.985204;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,54,255:18:0:11,0:7,0:18,0 0,9,111:3:0:3,0:0,0:3,0 0,33,255:11:0:5,0:6,0:11,0 +17 459 . T <*> 0 . DP=33;ADF=18,0;ADR=13,0;AD=31,0;I16=18,13,0,0,1167,46981,0,0,1775,103851,0,0,565,12945,0,0;QS=3,0;MQSB=0.980167;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,54,255:18:0:11,0:7,0:18,0 0,6,92:2:0:2,0:0,0:2,0 0,33,255:11:0:5,0:6,0:11,0 +17 460 . G <*> 0 . DP=32;ADF=19,0;ADR=12,0;AD=31,0;I16=19,12,0,0,1219,50105,0,0,1775,103851,0,0,575,12929,0,0;QS=3,0;MQSB=0.989977;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,54,255:18:0:11,0:7,0:18,0 0,9,116:3:0:3,0:0,0:3,0 0,30,255:10:0:5,0:5,0:10,0 +17 461 . T <*> 0 . DP=32;ADF=19,0;ADR=12,0;AD=31,0;I16=19,12,0,0,1213,49819,0,0,1775,103851,0,0,577,12845,0,0;QS=3,0;MQSB=0.989977;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,54,255:18:0:11,0:7,0:18,0 0,9,115:3:0:3,0:0,0:3,0 0,30,255:10:0:5,0:5,0:10,0 +17 462 . G <*> 0 . DP=32;ADF=19,0;ADR=12,0;AD=31,0;I16=19,12,0,0,1190,48962,0,0,1775,103851,0,0,580,12792,0,0;QS=3,0;MQSB=0.989977;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,51,255:17:0:10,0:7,0:17,0 0,12,119:4:0:4,0:0,0:4,0 0,30,241:10:0:5,0:5,0:10,0 +17 463 . G <*> 0 . DP=32;ADF=19,0;ADR=12,0;AD=31,0;I16=19,12,0,0,1114,44214,0,0,1775,103851,0,0,584,12770,0,0;QS=3,0;MQSB=0.989977;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,51,255:17:0:10,0:7,0:17,0 0,12,114:4:0:4,0:0,0:4,0 0,30,221:10:0:5,0:5,0:10,0 +17 464 . A <*> 0 . DP=32;ADF=18,0;ADR=11,0;AD=29,0;I16=18,11,0,0,1100,43908,0,0,1686,99410,0,0,556,12106,0,0;QS=3,0;MQSB=0.99095;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,51,255:17:0:10,0:7,0:17,0 0,12,133:4:0:4,0:0,0:4,0 0,24,213:8:0:4,0:4,0:8,0 +17 465 . C <*> 0 . DP=33;ADF=20,0;ADR=11,0;AD=31,0;I16=20,11,0,0,1191,48085,0,0,1775,103851,0,0,586,12786,0,0;QS=3,0;MQSB=0.996597;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,51,255:17:0:10,0:7,0:17,0 0,15,140:5:0:5,0:0,0:5,0 0,27,231:9:0:5,0:4,0:9,0 +17 466 . A <*> 0 . DP=34;ADF=21,0;ADR=12,0;AD=33,0;I16=21,12,0,0,1293,53311,0,0,1895,111051,0,0,597,12897,0,0;QS=3,0;MQSB=0.995633;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,54,255:18:0:11,0:7,0:18,0 0,15,154:5:0:5,0:0,0:5,0 0,30,255:10:0:5,0:5,0:10,0 +17 467 . A <*> 0 . DP=34;ADF=21,0;ADR=11,0;AD=32,0;I16=21,11,0,0,1256,51450,0,0,1835,107451,0,0,597,12891,0,0;QS=3,0;MQSB=0.998231;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,54,255:18:0:11,0:7,0:18,0 0,15,157:5:0:5,0:0,0:5,0 0,27,248:9:0:5,0:4,0:9,0 +17 468 . A <*> 0 . DP=35;ADF=22,0;ADR=12,0;AD=34,0;I16=22,12,0,0,1274,51268,0,0,1955,114651,0,0,604,12904,0,0;QS=3,0;MQSB=0.997406;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,57,255:19:0:12,0:7,0:19,0 0,15,154:5:0:5,0:0,0:5,0 0,30,251:10:0:5,0:5,0:10,0 +17 469 . A <*> 0 . DP=35;ADF=22,0;ADR=12,0;AD=34,0;I16=22,12,0,0,1285,52989,0,0,1955,114651,0,0,608,12940,0,0;QS=3,0;MQSB=0.997406;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,57,255:19:0:12,0:7,0:19,0 0,15,146:5:0:5,0:0,0:5,0 0,30,255:10:0:5,0:5,0:10,0 +17 470 . G <*> 0 . DP=35;ADF=22,0;ADR=12,0;AD=34,0;I16=22,12,0,0,1281,51055,0,0,1955,114651,0,0,612,13016,0,0;QS=3,0;MQSB=0.997406;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,57,255:19:0:12,0:7,0:19,0 0,15,148:5:0:5,0:0,0:5,0 0,30,238:10:0:5,0:5,0:10,0 +17 471 . T <*> 0 . DP=36;ADF=22,0;ADR=11,0;AD=33,0;I16=22,11,0,0,1239,49021,0,0,1918,113282,0,0,599,12825,0,0;QS=3,0;MQSB=0.915545;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,57,255:19:0:12,0:7,0:19,0 0,15,150:5:0:5,0:0,0:5,0 0,27,232:9:0:5,0:4,0:9,0 +17 472 . T <*> 0 . DP=35;ADF=21,0;ADR=12,0;AD=33,0;I16=21,12,0,0,1245,48915,0,0,1926,113810,0,0,595,12559,0,0;QS=3,0;MQSB=0.988858;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,57,255:19:0:12,0:7,0:19,0 0,15,153:5:0:5,0:0,0:5,0 0,27,237:9:0:4,0:5,0:9,0 +17 473 . G <*> 0 . DP=35;ADF=21,0;ADR=12,0;AD=33,0;I16=21,12,0,0,1307,53473,0,0,1926,113810,0,0,599,12651,0,0;QS=3,0;MQSB=0.988858;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,57,255:19:0:12,0:7,0:19,0 0,15,141:5:0:5,0:0,0:5,0 0,27,249:9:0:4,0:5,0:9,0 +17 474 . G <*> 0 . DP=36;ADF=22,0;ADR=12,0;AD=34,0;I16=22,12,0,0,1284,51708,0,0,1986,117410,0,0,602,12734,0,0;QS=3,0;MQSB=0.986937;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,57,255:19:0:12,0:7,0:19,0 0,15,131:5:0:5,0:0,0:5,0 0,30,255:10:0:5,0:5,0:10,0 +17 475 . G <*> 0 . DP=36;ADF=23,0;ADR=12,0;AD=35,0;I16=23,12,0,0,1311,51609,0,0,2015,118251,0,0,631,13485,0,0;QS=3,0;MQSB=0.998642;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,57,255:19:0:12,0:7,0:19,0 0,15,141:5:0:5,0:0,0:5,0 0,33,252:11:0:6,0:5,0:11,0 +17 476 . A <*> 0 . DP=36;ADF=23,0;ADR=12,0;AD=35,0;I16=23,12,0,0,1312,52078,0,0,2015,118251,0,0,634,13606,0,0;QS=3,0;MQSB=0.998642;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,57,255:19:0:12,0:7,0:19,0 0,15,157:5:0:5,0:0,0:5,0 0,33,255:11:0:6,0:5,0:11,0 +17 477 . T <*> 0 . DP=36;ADF=23,0;ADR=12,0;AD=35,0;I16=23,12,0,0,1318,52668,0,0,2015,118251,0,0,637,13773,0,0;QS=3,0;MQSB=0.998642;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,57,255:19:0:12,0:7,0:19,0 0,15,148:5:0:5,0:0,0:5,0 0,33,255:11:0:6,0:5,0:11,0 +17 478 . T <*> 0 . DP=38;ADF=25,0;ADR=12,0;AD=37,0;I16=25,12,0,0,1338,51774,0,0,2135,125451,0,0,637,13833,0,0;QS=3,0;MQSB=0.999868;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,60,255:20:0:13,0:7,0:20,0 0,18,154:6:0:6,0:0,0:6,0 0,33,255:11:0:6,0:5,0:11,0 +17 479 . A <*> 0 . DP=38;ADF=25,0;ADR=12,0;AD=37,0;I16=25,12,0,0,1420,57788,0,0,2135,125451,0,0,639,13935,0,0;QS=3,0;MQSB=0.999868;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,60,255:20:0:13,0:7,0:20,0 0,18,163:6:0:6,0:0,0:6,0 0,33,255:11:0:6,0:5,0:11,0 +17 480 . G <*> 0 . DP=37;ADF=25,0;ADR=11,0;AD=36,0;I16=25,11,0,0,1438,60172,0,0,2075,121851,0,0,641,14029,0,0;QS=3,0;MQSB=0.999853;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,57,255:19:0:13,0:6,0:19,0 0,18,165:6:0:6,0:0,0:6,0 0,33,255:11:0:6,0:5,0:11,0 +17 481 . G <*> 0 . DP=37;ADF=25,0;ADR=11,0;AD=36,0;I16=25,11,0,0,1392,55824,0,0,2075,121851,0,0,642,14112,0,0;QS=3,0;MQSB=0.999853;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,57,255:19:0:13,0:6,0:19,0 0,18,165:6:0:6,0:0,0:6,0 0,33,255:11:0:6,0:5,0:11,0 +17 482 . A <*> 0 . DP=37;ADF=24,0;ADR=11,0;AD=35,0;I16=24,11,0,0,1352,55134,0,0,2015,118251,0,0,618,13608,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,57,255:19:0:13,0:6,0:19,0 0,15,143:5:0:5,0:0,0:5,0 0,33,255:11:0:6,0:5,0:11,0 +17 483 . G <*> 0 . DP=37;ADF=24,0;ADR=12,0;AD=36,0;I16=24,12,0,0,1417,57747,0,0,2075,121851,0,0,642,14240,0,0;QS=3,0;MQSB=0.999437;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,57,255:19:0:12,0:7,0:19,0 0,18,165:6:0:6,0:0,0:6,0 0,33,255:11:0:6,0:5,0:11,0 +17 484 . A <*> 0 . DP=36;ADF=24,0;ADR=11,0;AD=35,0;I16=24,11,0,0,1340,53992,0,0,2015,118251,0,0,643,14281,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,54,255:18:0:12,0:6,0:18,0 0,18,168:6:0:6,0:0,0:6,0 0,33,255:11:0:6,0:5,0:11,0 +17 485 . G <*> 0 . DP=35;ADF=23,0;ADR=12,0;AD=35,0;I16=23,12,0,0,1329,51411,0,0,2015,118251,0,0,669,14931,0,0;QS=3,0;MQSB=0.998642;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,54,255:18:0:12,0:6,0:18,0 0,18,160:6:0:5,0:1,0:6,0 0,33,255:11:0:6,0:5,0:11,0 +17 486 . A <*> 0 . DP=34;ADF=22,0;ADR=12,0;AD=34,0;I16=22,12,0,0,1311,51523,0,0,1955,114651,0,0,671,14989,0,0;QS=3,0;MQSB=0.997406;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,51,255:17:0:11,0:6,0:17,0 0,18,173:6:0:5,0:1,0:6,0 0,33,255:11:0:6,0:5,0:11,0 +17 487 . G <*> 0 . DP=34;ADF=22,0;ADR=12,0;AD=34,0;I16=22,12,0,0,1306,50760,0,0,1955,114651,0,0,672,15030,0,0;QS=3,0;MQSB=0.997406;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,51,255:17:0:11,0:6,0:17,0 0,18,169:6:0:5,0:1,0:6,0 0,33,255:11:0:6,0:5,0:11,0 +17 488 . A <*> 0 . DP=35;ADF=22,0;ADR=12,0;AD=34,0;I16=22,12,0,0,1274,48140,0,0,1986,117410,0,0,646,14380,0,0;QS=3,0;MQSB=0.986937;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,54,255:18:0:12,0:6,0:18,0 0,18,177:6:0:5,0:1,0:6,0 0,30,255:10:0:5,0:5,0:10,0 +17 489 . A <*> 0 . DP=35;ADF=23,0;ADR=12,0;AD=35,0;I16=23,12,0,0,1264,46916,0,0,2015,118251,0,0,671,15015,0,0;QS=3,0;MQSB=0.998642;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,54,255:18:0:12,0:6,0:18,0 0,18,175:6:0:5,0:1,0:6,0 0,33,255:11:0:6,0:5,0:11,0 +17 490 . A <*> 0 . DP=36;ADF=24,0;ADR=12,0;AD=36,0;I16=24,12,0,0,1332,50280,0,0,2075,121851,0,0,671,15061,0,0;QS=3,0;MQSB=0.999437;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,54,255:18:0:12,0:6,0:18,0 0,21,188:7:0:6,0:1,0:7,0 0,33,255:11:0:6,0:5,0:11,0 +17 491 . T <*> 0 . DP=36;ADF=24,0;ADR=12,0;AD=36,0;I16=24,12,0,0,1284,46802,0,0,2075,121851,0,0,671,15093,0,0;QS=3,0;MQSB=0.999437;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,54,255:18:0:12,0:6,0:18,0 0,21,178:7:0:6,0:1,0:7,0 0,33,255:11:0:6,0:5,0:11,0 +17 492 . G <*> 0 . DP=35;ADF=21,0;ADR=12,0;AD=33,0;I16=21,12,0,0,1252,48326,0,0,1926,113810,0,0,621,13859,0,0;QS=3,0;MQSB=0.988858;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,51,255:17:0:11,0:6,0:17,0 0,18,172:6:0:5,0:1,0:6,0 0,30,251:10:0:5,0:5,0:10,0 +17 493 . A <*> 0 . DP=34;ADF=22,0;ADR=11,0;AD=33,0;I16=22,11,0,0,1273,49481,0,0,1926,113810,0,0,650,14672,0,0;QS=3,0;MQSB=0.981935;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,54,255:18:0:12,0:6,0:18,0 0,21,186:7:0:6,0:1,0:7,0 0,24,240:8:0:4,0:4,0:8,0 +17 494 . A <*> 0 . DP=34;ADF=22,0;ADR=12,0;AD=34,0;I16=22,12,0,0,1326,52604,0,0,1986,117410,0,0,672,15182,0,0;QS=3,0;MQSB=0.986937;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,54,255:18:0:12,0:6,0:18,0 0,21,196:7:0:6,0:1,0:7,0 0,27,255:9:0:4,0:5,0:9,0 +17 495 . G <*> 0 . DP=34;ADF=21,0;ADR=12,0;AD=33,0;I16=21,12,0,0,1255,48577,0,0,1926,113810,0,0,647,14611,0,0;QS=3,0;MQSB=0.988858;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,54,255:18:0:12,0:6,0:18,0 0,18,168:6:0:5,0:1,0:6,0 0,27,244:9:0:4,0:5,0:9,0 +17 496 . A <*> 0 . DP=34;ADF=22,0;ADR=12,0;AD=34,0;I16=22,12,0,0,1250,46926,0,0,1986,117410,0,0,670,15220,0,0;QS=3,0;MQSB=0.986937;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,54,255:18:0:12,0:6,0:18,0 0,21,186:7:0:6,0:1,0:7,0 0,27,249:9:0:4,0:5,0:9,0 +17 497 . C <*> 0 . DP=34;ADF=22,0;ADR=12,0;AD=34,0;I16=22,12,0,0,1250,47006,0,0,1986,117410,0,0,665,15087,0,0;QS=3,0;MQSB=0.986937;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,54,255:18:0:12,0:6,0:18,0 0,21,164:7:0:6,0:1,0:7,0 0,27,239:9:0:4,0:5,0:9,0 +17 498 . A <*> 0 . DP=34;ADF=22,0;ADR=12,0;AD=34,0;I16=22,12,0,0,1286,49158,0,0,1986,117410,0,0,661,14987,0,0;QS=3,0;MQSB=0.986937;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,54,255:18:0:12,0:6,0:18,0 0,21,185:7:0:6,0:1,0:7,0 0,27,252:9:0:4,0:5,0:9,0 +17 499 . T <*> 0 . DP=34;ADF=23,0;ADR=11,0;AD=34,0;I16=23,11,0,0,1224,45284,0,0,1986,117410,0,0,659,14919,0,0;QS=3,0;MQSB=0.979712;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,51,255:17:0:12,0:5,0:17,0 0,21,183:7:0:6,0:1,0:7,0 0,30,255:10:0:5,0:5,0:10,0 +17 500 . A <*> 0 . DP=34;ADF=23,0;ADR=11,0;AD=34,0;I16=23,11,0,0,1230,45152,0,0,1986,117410,0,0,657,14833,0,0;QS=3,0;MQSB=0.979712;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,51,255:17:0:12,0:5,0:17,0 0,21,179:7:0:6,0:1,0:7,0 0,30,255:10:0:5,0:5,0:10,0 +17 501 . T <*> 0 . DP=33;ADF=23,0;ADR=10,0;AD=33,0;I16=23,10,0,0,1241,47167,0,0,1926,113810,0,0,656,14778,0,0;QS=3,0;MQSB=0.972757;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,51,255:17:0:12,0:5,0:17,0 0,21,186:7:0:6,0:1,0:7,0 0,27,241:9:0:5,0:4,0:9,0 +17 502 . G <*> 0 . DP=33;ADF=23,0;ADR=10,0;AD=33,0;I16=23,10,0,0,1215,45829,0,0,1926,113810,0,0,655,14753,0,0;QS=3,0;MQSB=0.972757;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,51,255:17:0:12,0:5,0:17,0 0,21,183:7:0:6,0:1,0:7,0 0,27,235:9:0:5,0:4,0:9,0 +17 503 . T <*> 0 . DP=34;ADF=23,0;ADR=11,0;AD=34,0;I16=23,11,0,0,1194,43366,0,0,1986,117410,0,0,654,14758,0,0;QS=3,0;MQSB=0.979712;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,54,255:18:0:12,0:6,0:18,0 0,21,177:7:0:6,0:1,0:7,0 0,27,234:9:0:5,0:4,0:9,0 +17 504 . C <*> 0 . DP=34;ADF=23,0;ADR=11,0;AD=34,0;I16=23,11,0,0,1218,45552,0,0,1986,117410,0,0,651,14643,0,0;QS=3,0;MQSB=0.979712;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,54,255:18:0:12,0:6,0:18,0 0,21,183:7:0:6,0:1,0:7,0 0,27,219:9:0:5,0:4,0:9,0 +17 505 . C <*> 0 . DP=35;ADF=23,0;ADR=11,0;AD=34,0;I16=23,11,0,0,1207,44321,0,0,1986,117410,0,0,641,14509,0,0;QS=3,0;MQSB=0.979712;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,54,255:18:0:12,0:6,0:18,0 0,21,189:7:0:6,0:1,0:7,0 0,27,221:9:0:5,0:4,0:9,0 +17 506 . A <*> 0 . DP=35;ADF=24,0;ADR=11,0;AD=35,0;I16=24,11,0,0,1266,46776,0,0,2046,121010,0,0,646,14504,0,0;QS=3,0;MQSB=0.977529;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,57,255:19:0:13,0:6,0:19,0 0,21,188:7:0:6,0:1,0:7,0 0,27,231:9:0:5,0:4,0:9,0 +17 507 . C <*> 0 . DP=35;ADF=23,0;ADR=11,0;AD=34,0;I16=23,11,0,0,1220,45016,0,0,1986,117410,0,0,635,14401,0,0;QS=3,0;MQSB=0.979712;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,54,255:18:0:12,0:6,0:18,0 0,21,183:7:0:6,0:1,0:7,0 0,27,226:9:0:5,0:4,0:9,0 +17 508 . A <*> 0 . DP=34;ADF=24,0;ADR=10,0;AD=34,0;I16=24,10,0,0,1204,44542,0,0,1986,117410,0,0,643,14491,0,0;QS=3,0;MQSB=0.970272;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,54,255:18:0:13,0:5,0:18,0 0,21,189:7:0:6,0:1,0:7,0 0,27,220:9:0:5,0:4,0:9,0 +17 509 . C <*> 0 . DP=34;ADF=24,0;ADR=10,0;AD=34,0;I16=24,10,0,0,1272,48272,0,0,1986,117410,0,0,640,14430,0,0;QS=3,0;MQSB=0.970272;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,54,255:18:0:13,0:5,0:18,0 0,21,186:7:0:6,0:1,0:7,0 0,27,241:9:0:5,0:4,0:9,0 +17 510 . A <*> 0 . DP=34;ADF=22,0;ADR=11,0;AD=33,0;I16=22,11,0,0,1194,44196,0,0,1926,113810,0,0,613,13773,0,0;QS=3,0;MQSB=0.981935;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,54,255:18:0:12,0:6,0:18,0 0,21,187:7:0:6,0:1,0:7,0 0,24,221:8:0:4,0:4,0:8,0 +17 511 . A <*> 0 . DP=34;ADF=23,0;ADR=11,0;AD=34,0;I16=23,11,0,0,1222,45562,0,0,1986,117410,0,0,637,14395,0,0;QS=3,0;MQSB=0.979712;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,57,255:19:0:13,0:6,0:19,0 0,21,195:7:0:6,0:1,0:7,0 0,24,233:8:0:4,0:4,0:8,0 +17 512 . A C,<*> 0 . DP=33;ADF=22,0,0;ADR=10,1,0;AD=32,1,0;I16=22,10,0,1,1121,40793,13,169,1866,110210,60,3600,628,14340,9,81;QS=2.97719,0.022807,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.981935;BQB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,39,255,51,255,255:18:0:12,0,0:5,1,0:17,1,0 0,21,183,21,183,183:7:0:6,0,0:1,0,0:7,0,0 0,24,231,24,231,231:8:0:4,0,0:4,0,0:8,0,0 +17 513 . A <*> 0 . DP=32;ADF=20,0;ADR=10,0;AD=30,0;I16=20,10,0,0,1115,42183,0,0,1746,103010,0,0,598,13624,0,0;QS=3,0;MQSB=0.980594;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,48,255:16:0:11,0:5,0:16,0 0,18,175:6:0:5,0:1,0:6,0 0,24,233:8:0:4,0:4,0:8,0 +17 514 . A T,<*> 0 . DP=32;ADF=20,0,0;ADR=9,1,0;AD=29,1,0;I16=20,9,0,1,1066,40004,16,256,1686,99410,60,3600,586,13500,11,121;QS=2.97075,0.0292505,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.980594;BQB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,31,255,45,255,255:16:0:11,0,0:4,1,0:15,1,0 0,18,171,18,171,171:6:0:5,0,0:1,0,0:6,0,0 0,24,235,24,235,235:8:0:4,0,0:4,0,0:8,0,0 +17 515 . C <*> 0 . DP=32;ADF=18,0;ADR=10,0;AD=28,0;I16=18,10,0,0,1010,37294,0,0,1626,95810,0,0,561,12915,0,0;QS=3,0;MQSB=0.986018;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,42,255:14:0:9,0:5,0:14,0 0,18,167:6:0:5,0:1,0:6,0 0,24,211:8:0:4,0:4,0:8,0 +17 516 . C <*> 0 . DP=32;ADF=21,0;ADR=10,0;AD=31,0;I16=21,10,0,0,1100,40570,0,0,1806,106610,0,0,612,13954,0,0;QS=3,0;MQSB=0.977926;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,48,255:16:0:11,0:5,0:16,0 0,21,187:7:0:6,0:1,0:7,0 0,24,215:8:0:4,0:4,0:8,0 +17 517 . T <*> 0 . DP=33;ADF=23,0;ADR=10,0;AD=33,0;I16=23,10,0,0,1269,49995,0,0,1926,113810,0,0,636,14626,0,0;QS=3,0;MQSB=0.972757;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,54,255:18:0:13,0:5,0:18,0 0,21,201:7:0:6,0:1,0:7,0 0,24,242:8:0:4,0:4,0:8,0 +17 518 . G <*> 0 . DP=34;ADF=24,0;ADR=10,0;AD=34,0;I16=24,10,0,0,1247,46839,0,0,1986,117410,0,0,636,14696,0,0;QS=3,0;MQSB=0.970272;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,57,255:19:0:14,0:5,0:19,0 0,21,182:7:0:6,0:1,0:7,0 0,24,220:8:0:4,0:4,0:8,0 +17 519 . T <*> 0 . DP=36;ADF=25,0;ADR=11,0;AD=36,0;I16=25,11,0,0,1283,46693,0,0,2106,124610,0,0,636,14742,0,0;QS=3,0;MQSB=0.975394;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,63,255:21:0:15,0:6,0:21,0 0,21,177:7:0:6,0:1,0:7,0 0,24,224:8:0:4,0:4,0:8,0 +17 520 . T <*> 0 . DP=36;ADF=24,0;ADR=11,0;AD=35,0;I16=24,11,0,0,1238,44894,0,0,2046,121010,0,0,613,14193,0,0;QS=3,0;MQSB=0.977529;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,60,255:20:0:14,0:6,0:20,0 0,21,180:7:0:6,0:1,0:7,0 0,24,223:8:0:4,0:4,0:8,0 +17 521 . C <*> 0 . DP=34;ADF=25,0;ADR=9,0;AD=34,0;I16=25,9,0,0,1280,49454,0,0,1986,117410,0,0,641,14875,0,0;QS=3,0;MQSB=0.958048;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,60,255:20:0:15,0:5,0:20,0 0,21,191:7:0:6,0:1,0:7,0 0,21,204:7:0:4,0:3,0:7,0 +17 522 . A <*> 0 . DP=32;ADF=24,0;ADR=8,0;AD=32,0;I16=24,8,0,0,1158,43228,0,0,1897,112969,0,0,646,14960,0,0;QS=3,0;MQSB=0.872525;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,60,255:20:0:15,0:5,0:20,0 0,21,185:7:0:6,0:1,0:7,0 0,15,170:5:0:3,0:2,0:5,0 +17 523 . T G,<*> 0 . DP=32;ADF=23,1,0;ADR=8,0,0;AD=31,1,0;I16=23,8,1,0,1184,45708,15,225,1837,109369,60,3600,626,14446,25,625;QS=2.9794,0.0206044,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.872525;BQB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,44,255,57,255,255:20:0:14,1,0:5,0,0:19,1,0 0,21,191,21,191,191:7:0:6,0,0:1,0,0:7,0,0 0,15,166,15,166,166:5:0:3,0,0:2,0,0:5,0,0 +17 524 . T <*> 0 . DP=32;ADF=24,0;ADR=7,0;AD=31,0;I16=24,7,0,0,1084,39474,0,0,1837,109369,0,0,629,14483,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,60,255:20:0:15,0:5,0:20,0 0,21,194:7:0:6,0:1,0:7,0 0,12,140:4:0:3,0:1,0:4,0 +17 525 . G <*> 0 . DP=32;ADF=24,0;ADR=7,0;AD=31,0;I16=24,7,0,0,1181,45669,0,0,1837,109369,0,0,631,14495,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,60,255:20:0:15,0:5,0:20,0 0,21,188:7:0:6,0:1,0:7,0 0,12,129:4:0:3,0:1,0:4,0 +17 526 . C <*> 0 . DP=32;ADF=24,0;ADR=7,0;AD=31,0;I16=24,7,0,0,1146,43950,0,0,1860,111600,0,0,633,14531,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,60,255:20:0:15,0:5,0:20,0 0,21,185:7:0:6,0:1,0:7,0 0,12,131:4:0:3,0:1,0:4,0 +17 527 . A <*> 0 . DP=33;ADF=24,0;ADR=8,0;AD=32,0;I16=24,8,0,0,1209,46265,0,0,1897,112969,0,0,636,14634,0,0;QS=3,0;MQSB=0.872525;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,57,255:19:0:14,0:5,0:19,0 0,21,194:7:0:6,0:1,0:7,0 0,18,181:6:0:4,0:2,0:6,0 +17 528 . G <*> 0 . DP=33;ADF=24,0;ADR=8,0;AD=32,0;I16=24,8,0,0,1256,49824,0,0,1897,112969,0,0,634,14484,0,0;QS=3,0;MQSB=0.872525;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,60,255:20:0:15,0:5,0:20,0 0,18,169:6:0:5,0:1,0:6,0 0,18,193:6:0:4,0:2,0:6,0 +17 529 . C <*> 0 . DP=32;ADF=24,0;ADR=7,0;AD=31,0;I16=24,7,0,0,1148,44362,0,0,1837,109369,0,0,633,14357,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,54,255:18:0:14,0:4,0:18,0 0,21,187:7:0:6,0:1,0:7,0 0,18,184:6:0:4,0:2,0:6,0 +17 530 . T <*> 0 . DP=32;ADF=25,0;ADR=7,0;AD=32,0;I16=25,7,0,0,1244,49168,0,0,1897,112969,0,0,657,14883,0,0;QS=3,0;MQSB=0.850154;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,57,255:19:0:15,0:4,0:19,0 0,21,196:7:0:6,0:1,0:7,0 0,18,202:6:0:4,0:2,0:6,0 +17 531 . T <*> 0 . DP=32;ADF=25,0;ADR=7,0;AD=32,0;I16=25,7,0,0,1177,44171,0,0,1897,112969,0,0,654,14714,0,0;QS=3,0;MQSB=0.850154;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,57,255:19:0:15,0:4,0:19,0 0,21,181:7:0:6,0:1,0:7,0 0,18,193:6:0:4,0:2,0:6,0 +17 532 . T <*> 0 . DP=32;ADF=24,0;ADR=7,0;AD=31,0;I16=24,7,0,0,1153,43543,0,0,1837,109369,0,0,630,14116,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,54,255:18:0:14,0:4,0:18,0 0,21,181:7:0:6,0:1,0:7,0 0,18,192:6:0:4,0:2,0:6,0 +17 533 . C <*> 0 . DP=32;ADF=24,0;ADR=7,0;AD=31,0;I16=24,7,0,0,1142,43940,0,0,1837,109369,0,0,619,13649,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,54,255:18:0:14,0:4,0:18,0 0,21,178:7:0:6,0:1,0:7,0 0,18,180:6:0:4,0:2,0:6,0 +17 534 . T <*> 0 . DP=31;ADF=24,0;ADR=6,0;AD=30,0;I16=24,6,0,0,1212,49426,0,0,1777,105769,0,0,615,13479,0,0;QS=3,0;MQSB=0.82403;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,51,255:17:0:14,0:3,0:17,0 0,21,205:7:0:6,0:1,0:7,0 0,18,205:6:0:4,0:2,0:6,0 +17 535 . A <*> 0 . DP=31;ADF=24,0;ADR=6,0;AD=30,0;I16=24,6,0,0,1080,39870,0,0,1777,105769,0,0,611,13341,0,0;QS=3,0;MQSB=0.82403;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,51,255:17:0:14,0:3,0:17,0 0,21,194:7:0:6,0:1,0:7,0 0,18,189:6:0:4,0:2,0:6,0 +17 536 . C <*> 0 . DP=31;ADF=24,0;ADR=7,0;AD=31,0;I16=24,7,0,0,1097,40707,0,0,1837,109369,0,0,631,13809,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,54,255:18:0:14,0:4,0:18,0 0,21,184:7:0:6,0:1,0:7,0 0,18,157:6:0:4,0:2,0:6,0 +17 537 . C <*> 0 . DP=31;ADF=22,0;ADR=7,0;AD=29,0;I16=22,7,0,0,1034,38564,0,0,1717,102169,0,0,587,12861,0,0;QS=3,0;MQSB=0.854582;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,48,255:16:0:12,0:4,0:16,0 0,21,172:7:0:6,0:1,0:7,0 0,18,183:6:0:4,0:2,0:6,0 +17 538 . A <*> 0 . DP=31;ADF=24,0;ADR=7,0;AD=31,0;I16=24,7,0,0,1138,42478,0,0,1837,109369,0,0,620,13536,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,54,255:18:0:14,0:4,0:18,0 0,21,189:7:0:6,0:1,0:7,0 0,18,181:6:0:4,0:2,0:6,0 +17 539 . T <*> 0 . DP=31;ADF=24,0;ADR=7,0;AD=31,0;I16=24,7,0,0,1134,42070,0,0,1837,109369,0,0,614,13422,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,54,255:18:0:14,0:4,0:18,0 0,21,178:7:0:6,0:1,0:7,0 0,18,181:6:0:4,0:2,0:6,0 +17 540 . C <*> 0 . DP=31;ADF=24,0;ADR=7,0;AD=31,0;I16=24,7,0,0,1148,43768,0,0,1837,109369,0,0,608,13340,0,0;QS=3,0;MQSB=0.851535;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,54,255:18:0:14,0:4,0:18,0 0,21,177:7:0:6,0:1,0:7,0 0,18,178:6:0:4,0:2,0:6,0 +17 541 . A <*> 0 . DP=32;ADF=24,0;ADR=6,0;AD=30,0;I16=24,6,0,0,1083,40483,0,0,1777,105769,0,0,551,11991,0,0;QS=3,0;MQSB=0.82403;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,51,255:17:0:13,0:4,0:17,0 0,24,180:8:0:7,0:1,0:8,0 0,15,150:5:0:4,0:1,0:5,0 +17 542 . C <*> 0 . DP=33;ADF=25,0;ADR=6,0;AD=31,0;I16=25,6,0,0,1123,41759,0,0,1837,109369,0,0,570,12552,0,0;QS=3,0;MQSB=0.822578;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,51,255:17:0:14,0:3,0:17,0 0,24,172:8:0:7,0:1,0:8,0 0,18,174:6:0:4,0:2,0:6,0 +17 543 . C <*> 0 . DP=34;ADF=25,0;ADR=9,0;AD=34,0;I16=25,9,0,0,1219,45959,0,0,1986,117410,0,0,601,13245,0,0;QS=3,0;MQSB=0.621145;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,57,255:19:0:14,0:5,0:19,0 0,27,194:9:0:7,0:2,0:9,0 0,18,188:6:0:4,0:2,0:6,0 +17 544 . A <*> 0 . DP=33;ADF=24,0;ADR=8,0;AD=32,0;I16=24,8,0,0,1170,43898,0,0,1866,110210,0,0,570,12506,0,0;QS=3,0;MQSB=0.579578;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,54,255:18:0:13,0:5,0:18,0 0,24,192:8:0:7,0:1,0:8,0 0,18,180:6:0:4,0:2,0:6,0 +17 545 . A <*> 0 . DP=33;ADF=25,0;ADR=8,0;AD=33,0;I16=25,8,0,0,1174,43602,0,0,1926,113810,0,0,587,12951,0,0;QS=3,0;MQSB=0.576102;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,57,255:19:0:14,0:5,0:19,0 0,24,190:8:0:7,0:1,0:8,0 0,18,184:6:0:4,0:2,0:6,0 +17 546 . A <*> 0 . DP=32;ADF=24,0;ADR=8,0;AD=32,0;I16=24,8,0,0,1126,41444,0,0,1866,110210,0,0,580,12802,0,0;QS=3,0;MQSB=0.579578;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,57,255:19:0:14,0:5,0:19,0 0,21,166:7:0:6,0:1,0:7,0 0,18,193:6:0:4,0:2,0:6,0 +17 547 . A <*> 0 . DP=32;ADF=24,0;ADR=7,0;AD=31,0;I16=24,7,0,0,1129,42381,0,0,1806,106610,0,0,547,12009,0,0;QS=3,0;MQSB=0.525788;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,54,255:18:0:14,0:4,0:18,0 0,21,180:7:0:6,0:1,0:7,0 0,18,195:6:0:4,0:2,0:6,0 +17 548 . A <*> 0 . DP=33;ADF=23,0;ADR=9,0;AD=32,0;I16=23,9,0,0,1153,42673,0,0,1866,110210,0,0,561,12489,0,0;QS=3,0;MQSB=0.628357;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,54,255:18:0:13,0:5,0:18,0 0,21,181:7:0:6,0:1,0:7,0 0,21,211:7:0:4,0:3,0:7,0 +17 549 . T G,<*> 0 . DP=32;ADF=22,0,0;ADR=8,1,0;AD=30,1,0;I16=22,8,0,1,1101,40987,20,400,1746,103010,60,3600,530,11716,25,625;QS=2.96748,0.0325203,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.632337;BQB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,31,255,48,255,255:17:0:12,0,0:4,1,0:16,1,0 0,21,168,21,168,168:7:0:6,0,0:1,0,0:7,0,0 0,21,208,21,208,208:7:0:4,0,0:3,0,0:7,0,0 +17 550 . T <*> 0 . DP=32;ADF=22,0;ADR=9,0;AD=31,0;I16=22,9,0,0,1052,37298,0,0,1806,106610,0,0,548,12176,0,0;QS=3,0;MQSB=0.632337;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,51,255:17:0:12,0:5,0:17,0 0,21,150:7:0:6,0:1,0:7,0 0,21,220:7:0:4,0:3,0:7,0 +17 551 . G <*> 0 . DP=31;ADF=22,0;ADR=9,0;AD=31,0;I16=22,9,0,0,1121,41639,0,0,1806,106610,0,0,541,12045,0,0;QS=3,0;MQSB=0.632337;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,51,255:17:0:12,0:5,0:17,0 0,21,172:7:0:6,0:1,0:7,0 0,21,208:7:0:4,0:3,0:7,0 +17 552 . C <*> 0 . DP=30;ADF=21,0;ADR=9,0;AD=30,0;I16=21,9,0,0,1093,41365,0,0,1746,103010,0,0,535,11947,0,0;QS=3,0;MQSB=0.636601;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,48,255:16:0:11,0:5,0:16,0 0,21,167:7:0:6,0:1,0:7,0 0,21,208:7:0:4,0:3,0:7,0 +17 553 . A <*> 0 . DP=30;ADF=20,0;ADR=8,0;AD=28,0;I16=20,8,0,0,981,35387,0,0,1626,95810,0,0,485,10831,0,0;QS=3,0;MQSB=0.596163;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,45,255:15:0:10,0:5,0:15,0 0,18,150:6:0:5,0:1,0:6,0 0,21,194:7:0:5,0:2,0:7,0 +17 554 . A <*> 0 . DP=30;ADF=19,0;ADR=9,0;AD=28,0;I16=19,9,0,0,975,35601,0,0,1626,95810,0,0,488,10906,0,0;QS=3,0;MQSB=0.646113;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,45,255:15:0:10,0:5,0:15,0 0,15,139:5:0:4,0:1,0:5,0 0,24,211:8:0:5,0:3,0:8,0 +17 555 . A <*> 0 . DP=30;ADF=20,0;ADR=10,0;AD=30,0;I16=20,10,0,0,1024,36526,0,0,1746,103010,0,0,514,11392,0,0;QS=3,0;MQSB=0.679025;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,51,255:17:0:11,0:6,0:17,0 0,18,150:6:0:5,0:1,0:6,0 0,21,211:7:0:4,0:3,0:7,0 +17 556 . C <*> 0 . DP=29;ADF=20,0;ADR=9,0;AD=29,0;I16=20,9,0,0,1055,39195,0,0,1709,101641,0,0,509,11219,0,0;QS=3,0;MQSB=0.894839;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,51,255:17:0:11,0:6,0:17,0 0,18,158:6:0:5,0:1,0:6,0 0,18,186:6:0:4,0:2,0:6,0 +17 557 . A <*> 0 . DP=27;ADF=18,0;ADR=9,0;AD=27,0;I16=18,9,0,0,987,36749,0,0,1589,94441,0,0,506,11074,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,45,255:15:0:9,0:6,0:15,0 0,18,157:6:0:5,0:1,0:6,0 0,18,186:6:0:4,0:2,0:6,0 +17 558 . A <*> 0 . DP=27;ADF=18,0;ADR=8,0;AD=26,0;I16=18,8,0,0,948,35808,0,0,1560,93600,0,0,477,10281,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,45,255:15:0:9,0:6,0:15,0 0,15,143:5:0:5,0:0,0:5,0 0,18,177:6:0:4,0:2,0:6,0 +17 559 . C A,<*> 0 . DP=27;ADF=17,0,0;ADR=8,1,0;AD=25,1,0;I16=17,8,0,1,908,33726,14,196,1500,90000,29,841,448,9516,25,625;QS=2.92708,0.0729167,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.90038;BQB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,42,255,42,255,255:14:0:8,0,0:6,0,0:14,0,0 0,4,116,15,119,123:6:0:5,0,0:0,1,0:5,1,0 0,18,169,18,169,169:6:0:4,0,0:2,0,0:6,0,0 +17 560 . C <*> 0 . DP=28;ADF=19,0;ADR=9,0;AD=28,0;I16=19,9,0,0,992,36552,0,0,1649,98041,0,0,494,10654,0,0;QS=3,0;MQSB=0.896555;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,45,255:15:0:9,0:6,0:15,0 0,18,160:6:0:5,0:1,0:6,0 0,21,181:7:0:5,0:2,0:7,0 +17 561 . A <*> 0 . DP=28;ADF=18,0;ADR=9,0;AD=27,0;I16=18,9,0,0,963,35455,0,0,1589,94441,0,0,466,9946,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,42,255:14:0:8,0:6,0:14,0 0,18,158:6:0:5,0:1,0:6,0 0,21,194:7:0:5,0:2,0:7,0 +17 562 . C <*> 0 . DP=28;ADF=18,0;ADR=9,0;AD=27,0;I16=18,9,0,0,1006,38392,0,0,1589,94441,0,0,463,9893,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,42,255:14:0:8,0:6,0:14,0 0,18,153:6:0:5,0:1,0:6,0 0,21,187:7:0:5,0:2,0:7,0 +17 563 . A <*> 0 . DP=27;ADF=17,0;ADR=9,0;AD=26,0;I16=17,9,0,0,893,32413,0,0,1529,90841,0,0,460,9820,0,0;QS=3,0;MQSB=0.90038;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,42,255:14:0:8,0:6,0:14,0 0,15,149:5:0:4,0:1,0:5,0 0,21,179:7:0:5,0:2,0:7,0 +17 564 . C <*> 0 . DP=27;ADF=18,0;ADR=9,0;AD=27,0;I16=18,9,0,0,859,28747,0,0,1589,94441,0,0,482,10402,0,0;QS=3,0;MQSB=0.898397;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,45,255:15:0:9,0:6,0:15,0 0,15,121:5:0:4,0:1,0:5,0 0,21,182:7:0:5,0:2,0:7,0 +17 565 . G <*> 0 . DP=30;ADF=17,0;ADR=9,0;AD=26,0;I16=17,9,0,0,818,26928,0,0,1560,93600,0,0,454,9764,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,45,255:15:0:9,0:6,0:15,0 0,12,96:4:0:3,0:1,0:4,0 0,21,154:7:0:5,0:2,0:7,0 +17 566 . C <*> 0 . DP=29;ADF=15,0;ADR=11,0;AD=26,0;I16=15,11,0,0,903,33405,0,0,1529,90841,0,0,424,9084,0,0;QS=3,0;MQSB=0.927041;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,45,255:15:0:7,0:8,0:15,0 0,15,155:5:0:3,0:2,0:5,0 0,18,167:6:0:5,0:1,0:6,0 +17 567 . C <*> 0 . DP=30;ADF=15,0;ADR=12,0;AD=27,0;I16=15,12,0,0,932,33774,0,0,1589,94441,0,0,462,10178,0,0;QS=3,0;MQSB=0.935229;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,45,255:15:0:7,0:8,0:15,0 0,15,155:5:0:3,0:2,0:5,0 0,21,196:7:0:5,0:2,0:7,0 +17 568 . C <*> 0 . DP=29;ADF=15,0;ADR=13,0;AD=28,0;I16=15,13,0,0,1057,40817,0,0,1649,98041,0,0,482,10438,0,0;QS=3,0;MQSB=0.942064;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,48,255:16:0:8,0:8,0:16,0 0,18,183:6:0:3,0:3,0:6,0 0,18,189:6:0:4,0:2,0:6,0 +17 569 . T <*> 0 . DP=30;ADF=16,0;ADR=12,0;AD=28,0;I16=16,12,0,0,1056,41296,0,0,1649,98041,0,0,493,10655,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,45,255:15:0:8,0:7,0:15,0 0,18,190:6:0:3,0:3,0:6,0 0,21,213:7:0:5,0:2,0:7,0 +17 570 . T <*> 0 . DP=30;ADF=16,0;ADR=12,0;AD=28,0;I16=16,12,0,0,954,34972,0,0,1680,100800,0,0,472,10086,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,48,255:16:0:8,0:8,0:16,0 0,15,157:5:0:3,0:2,0:5,0 0,21,195:7:0:5,0:2,0:7,0 +17 571 . C <*> 0 . DP=31;ADF=17,0;ADR=12,0;AD=29,0;I16=17,12,0,0,1061,40675,0,0,1740,104400,0,0,472,10158,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,51,255:17:0:9,0:8,0:17,0 0,15,155:5:0:3,0:2,0:5,0 0,21,193:7:0:5,0:2,0:7,0 +17 572 . A <*> 0 . DP=31;ADF=18,0;ADR=12,0;AD=30,0;I16=18,12,0,0,1102,42642,0,0,1769,105241,0,0,499,10887,0,0;QS=3,0;MQSB=0.929991;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,51,255:17:0:9,0:8,0:17,0 0,21,203:7:0:4,0:3,0:7,0 0,18,175:6:0:5,0:1,0:6,0 +17 573 . A <*> 0 . DP=31;ADF=18,0;ADR=12,0;AD=30,0;I16=18,12,0,0,1057,38473,0,0,1769,105241,0,0,501,10975,0,0;QS=3,0;MQSB=0.929991;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,51,255:17:0:9,0:8,0:17,0 0,21,199:7:0:4,0:3,0:7,0 0,18,178:6:0:5,0:1,0:6,0 +17 574 . C A,<*> 0 . DP=31;ADF=18,0,0;ADR=11,1,0;AD=29,1,0;I16=18,11,0,1,1088,41328,15,225,1740,104400,29,841,478,10422,25,625;QS=2.94071,0.0592885,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.929991;BQB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,48,255,48,255,255:16:0:8,0,0:8,0,0:16,0,0 0,9,170,21,173,177:8:0:5,0,0:2,1,0:7,1,0 0,18,173,18,173,173:6:0:5,0,0:1,0,0:6,0,0 +17 575 . T <*> 0 . DP=30;ADF=16,0;ADR=10,0;AD=26,0;I16=16,10,0,0,1024,41260,0,0,1560,93600,0,0,448,9842,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,42,255:14:0:7,0:7,0:14,0 0,21,209:7:0:5,0:2,0:7,0 0,15,163:5:0:4,0:1,0:5,0 +17 576 . G <*> 0 . DP=30;ADF=17,0;ADR=12,0;AD=29,0;I16=17,12,0,0,1047,40077,0,0,1709,101641,0,0,507,11087,0,0;QS=3,0;MQSB=0.931617;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,48,255:16:0:8,0:8,0:16,0 0,24,208:8:0:5,0:3,0:8,0 0,15,151:5:0:4,0:1,0:5,0 +17 577 . G <*> 0 . DP=30;ADF=16,0;ADR=12,0;AD=28,0;I16=16,12,0,0,999,37747,0,0,1649,98041,0,0,489,10755,0,0;QS=3,0;MQSB=0.933359;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,45,255:15:0:7,0:8,0:15,0 0,24,204:8:0:5,0:3,0:8,0 0,15,146:5:0:4,0:1,0:5,0 +17 578 . G <*> 0 . DP=29;ADF=16,0;ADR=13,0;AD=29,0;I16=16,13,0,0,975,34803,0,0,1709,101641,0,0,520,11286,0,0;QS=3,0;MQSB=0.940317;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,48,255:16:0:7,0:9,0:16,0 0,24,198:8:0:5,0:3,0:8,0 0,15,151:5:0:4,0:1,0:5,0 +17 579 . G <*> 0 . DP=30;ADF=15,0;ADR=13,0;AD=28,0;I16=15,13,0,0,1028,38752,0,0,1649,98041,0,0,484,10514,0,0;QS=3,0;MQSB=0.942064;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,48,255:16:0:8,0:8,0:16,0 0,24,224:8:0:4,0:4,0:8,0 0,12,145:4:0:3,0:1,0:4,0 +17 580 . A C,<*> 0 . DP=30;ADF=15,1,0;ADR=14,0,0;AD=29,1,0;I16=15,14,1,0,1060,39178,16,256,1709,101641,60,3600,510,11078,17,289;QS=2.97338,0.0266223,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.946202;BQB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,34,255,48,255,255:17:0:7,1,0:9,0,0:16,1,0 0,24,221,24,221,221:8:0:4,0,0:4,0,0:8,0,0 0,15,155,15,155,155:5:0:4,0,0:1,0,0:5,0,0 +17 581 . A <*> 0 . DP=31;ADF=16,0;ADR=15,0;AD=31,0;I16=16,15,0,0,1083,39215,0,0,1829,108841,0,0,530,11384,0,0;QS=3,0;MQSB=0.951229;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,54,255:18:0:8,0:10,0:18,0 0,24,223:8:0:4,0:4,0:8,0 0,15,153:5:0:4,0:1,0:5,0 +17 582 . C <*> 0 . DP=31;ADF=15,0;ADR=15,0;AD=30,0;I16=15,15,0,0,1080,39870,0,0,1769,105241,0,0,519,11211,0,0;QS=3,0;MQSB=0.952765;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,51,255:17:0:7,0:10,0:17,0 0,24,207:8:0:4,0:4,0:8,0 0,15,151:5:0:4,0:1,0:5,0 +17 583 . T <*> 0 . DP=30;ADF=16,0;ADR=14,0;AD=30,0;I16=16,14,0,0,1136,43996,0,0,1769,105241,0,0,539,11523,0,0;QS=3,0;MQSB=0.946202;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,51,255:17:0:8,0:9,0:17,0 0,24,238:8:0:4,0:4,0:8,0 0,15,163:5:0:4,0:1,0:5,0 +17 584 . C <*> 0 . DP=31;ADF=16,0;ADR=13,0;AD=29,0;I16=16,13,0,0,1051,39351,0,0,1709,101641,0,0,499,10619,0,0;QS=3,0;MQSB=0.960189;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,51,255:17:0:8,0:9,0:17,0 0,21,207:7:0:4,0:3,0:7,0 0,15,157:5:0:4,0:1,0:5,0 +17 585 . A <*> 0 . DP=31;ADF=17,0;ADR=14,0;AD=31,0;I16=17,14,0,0,1096,39866,0,0,1798,106082,0,0,549,11751,0,0;QS=3,0;MQSB=0.998229;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,54,255:18:0:9,0:9,0:18,0 0,24,211:8:0:4,0:4,0:8,0 0,15,157:5:0:4,0:1,0:5,0 +17 586 . T <*> 0 . DP=31;ADF=16,0;ADR=14,0;AD=30,0;I16=16,14,0,0,1081,39839,0,0,1738,102482,0,0,546,11796,0,0;QS=3,0;MQSB=0.999136;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,51,255:17:0:8,0:9,0:17,0 0,24,212:8:0:4,0:4,0:8,0 0,15,156:5:0:4,0:1,0:5,0 +17 587 . C <*> 0 . DP=31;ADF=17,0;ADR=13,0;AD=30,0;I16=17,13,0,0,1070,39402,0,0,1769,105241,0,0,532,11350,0,0;QS=3,0;MQSB=0.963674;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,54,255:18:0:9,0:9,0:18,0 0,21,201:7:0:4,0:3,0:7,0 0,15,155:5:0:4,0:1,0:5,0 +17 588 . A <*> 0 . DP=31;ADF=17,0;ADR=14,0;AD=31,0;I16=17,14,0,0,1126,41642,0,0,1798,106082,0,0,562,12140,0,0;QS=3,0;MQSB=0.998229;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,54,255:18:0:9,0:9,0:18,0 0,24,222:8:0:4,0:4,0:8,0 0,15,164:5:0:4,0:1,0:5,0 +17 589 . A <*> 0 . DP=31;ADF=17,0;ADR=14,0;AD=31,0;I16=17,14,0,0,1157,43973,0,0,1798,106082,0,0,568,12340,0,0;QS=3,0;MQSB=0.998229;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,54,255:18:0:9,0:9,0:18,0 0,24,236:8:0:4,0:4,0:8,0 0,15,165:5:0:4,0:1,0:5,0 +17 590 . C <*> 0 . DP=32;ADF=16,0;ADR=14,0;AD=30,0;I16=16,14,0,0,1094,41302,0,0,1769,105241,0,0,549,11951,0,0;QS=3,0;MQSB=0.958545;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,54,255:18:0:9,0:9,0:18,0 0,18,192:6:0:3,0:3,0:6,0 0,18,175:6:0:4,0:2,0:6,0 +17 591 . A <*> 0 . DP=31;ADF=16,0;ADR=15,0;AD=31,0;I16=16,15,0,0,1165,44163,0,0,1798,106082,0,0,579,12695,0,0;QS=3,0;MQSB=0.999805;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,54,255:18:0:9,0:9,0:18,0 0,21,209:7:0:3,0:4,0:7,0 0,18,188:6:0:4,0:2,0:6,0 +17 592 . A <*> 0 . DP=31;ADF=15,0;ADR=15,0;AD=30,0;I16=15,15,0,0,1114,42144,0,0,1738,102482,0,0,571,12651,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,51,255:17:0:8,0:9,0:17,0 0,21,215:7:0:3,0:4,0:7,0 0,18,182:6:0:4,0:2,0:6,0 +17 593 . C <*> 0 . DP=31;ADF=15,0;ADR=14,0;AD=29,0;I16=15,14,0,0,1065,39889,0,0,1709,101641,0,0,550,12132,0,0;QS=3,0;MQSB=0.954405;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,51,255:17:0:8,0:9,0:17,0 0,18,191:6:0:3,0:3,0:6,0 0,18,174:6:0:4,0:2,0:6,0 +17 594 . A <*> 0 . DP=33;ADF=16,0;ADR=16,0;AD=32,0;I16=16,16,0,0,1163,42917,0,0,1858,109682,0,0,572,12672,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,51,255:17:0:8,0:9,0:17,0 0,21,205:7:0:3,0:4,0:7,0 0,24,212:8:0:5,0:3,0:8,0 +17 595 . A <*> 0 . DP=33;ADF=17,0;ADR=16,0;AD=33,0;I16=17,16,0,0,1130,39996,0,0,1918,113282,0,0,589,12905,0,0;QS=3,0;MQSB=0.999838;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,54,255:18:0:9,0:9,0:18,0 0,21,198:7:0:3,0:4,0:7,0 0,24,213:8:0:5,0:3,0:8,0 +17 596 . A <*> 0 . DP=33;ADF=16,0;ADR=16,0;AD=32,0;I16=16,16,0,0,1059,37039,0,0,1858,109682,0,0,590,12952,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,51,255:17:0:8,0:9,0:17,0 0,21,169:7:0:3,0:4,0:7,0 0,24,230:8:0:5,0:3,0:8,0 +17 597 . C <*> 0 . DP=33;ADF=17,0;ADR=16,0;AD=33,0;I16=17,16,0,0,1196,44890,0,0,1918,113282,0,0,592,12990,0,0;QS=3,0;MQSB=0.999838;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,54,255:18:0:9,0:9,0:18,0 0,21,204:7:0:3,0:4,0:7,0 0,24,220:8:0:5,0:3,0:8,0 +17 598 . T <*> 0 . DP=33;ADF=16,0;ADR=16,0;AD=32,0;I16=16,16,0,0,1214,47104,0,0,1858,109682,0,0,593,13013,0,0;QS=3,0;MQSB=1;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,51,255:17:0:8,0:9,0:17,0 0,21,217:7:0:3,0:4,0:7,0 0,24,239:8:0:5,0:3,0:8,0 +17 599 . T <*> 0 . DP=33;ADF=16,0;ADR=17,0;AD=33,0;I16=16,17,0,0,1183,43669,0,0,1918,113282,0,0,599,13095,0,0;QS=3,0;MQSB=0.999838;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,51,255:17:0:8,0:9,0:17,0 0,21,197:7:0:3,0:4,0:7,0 0,27,247:9:0:5,0:4,0:9,0 +17 600 . G <*> 0 . DP=32;ADF=15,0;ADR=17,0;AD=32,0;I16=15,17,0,0,1174,44066,0,0,1858,109682,0,0,601,13145,0,0;QS=3,0;MQSB=0.999287;MQ0F=0 PL:DP:SP:ADF:ADR:AD 0,51,255:17:0:8,0:9,0:17,0 0,21,194:7:0:3,0:4,0:7,0 0,24,232:8:0:4,0:4,0:8,0 diff --git a/test/mpileup/mpileup.ref.fa b/test/mpileup/mpileup.ref.fa new file mode 100644 index 000000000..7c2ec2a88 --- /dev/null +++ b/test/mpileup/mpileup.ref.fa @@ -0,0 +1,71 @@ +>17 17:1-4200 +AAGCTTCTCACCCTGTTCCTGCATAGATAATTGCATGACAATTGCCTTGTCCCTGCTGAA +TGTGCTCTGGGGTCTCTGGGGTCTCACCCACGACCAACTCCCTGGGCCTGGCACCAGGGA +GCTTAACAAACATCTGTCCAGCGAATACCTGCATCCCTAGAAGTGAAGCCACCGCCCAAA +GACACGCCCATGTCCAGCTTAACCTGCATCCCTAGAAGTGAAGGCACCGCCCAAAGACAC +GCCCATGTCCAGCTTATTCTGCCCAGTTCCTCTCCAGAAAGGCTGCATGGTTGACACACA +GTGCCTGCGACAAAGCTGAATGCTATCATTTAAAAACTCCTTGCTGGTTTGAGAGGCAGA +AAATGATATCTCATAGTTGCTTTACTTTGCATATTTTAAAATTGTGACTTTCATGGCATA +AATAATACTGGTTTATTACAGAAGCACTAGAAAATGCATGTGGACAAAAGTTGGGATTAG +GAGAGAGAAATGAAGACATATGTCCACACAAAAACCTGTTCATTGCAGCTTTCTACCATC +ACCAAAAATTGCAAACAACCACACGCCCTTCAACTGGGGAACTCATCAACAACAAACTTG +TGGTTTACCCACACAATGGAAGACCACTTAGCAACAAAAAGGACCAAACTCCTGGTACAT +GCAACTGACAGATGAATCTCAAACGCATTCCTCCGTGTGAAAGAAGCCGGACTCACAGGG +CAACACACTATCTGACTGTTTCATGGGAAAGTCTGGAAACGGCAACACCATTGAGACAGA +AAACAGGTGAGTGGTTGCCTGGGGCCAGGGAACTTTCTGGGGTCATATTCTCTGTGTTGA +TTCTGGTGGTGGAAACAAGACTGTCCCAGCCTGGGTGATACAGCGAGACCCCATCTCTAC +CAAAAAATTAAAAATTAGCTGGGCATGGTGGTGCATGCCTGTAGTCCCAGCTATTCACAG +TGCTGAGGTGGGAAGATGCTTGAGCCCAGGAGTTCAAGGCTGCAATGAGCTATGATTGCG +CCACTGCACTTTGGCCTGGACAACAGAGCAAAACCCTGTCTCTAAAAAAAGAAAAGAAAA +GAAAAACTCACTGGATATGAATGATACAGGTTGAGGATCCATTATCTGAAATGCTTGGAC +CAGATGTTTTGAATTTTGGATTTTTTCATATTTTGTAATCTTTGCAGTATATTTACCAGT +TCAGCATCCCTAACTCAAAAATTCAAAAATCTGAAATCCCAAACGCGCCAATAAGCATTC +CCTTTGAGCGTCATGTCGGTGCTTGGAATGTTTGGGGTTTTGGATTTACAGCTTTGGGAC +GCTCAACCTGTACCTCAATAAACCTGATTTTAAAAAAGTTTGGGGGGATTCCCCTAAGCC +CGCCACCCGGAGACAGCGGATTTCCTTAGTTACTTACTATGCTCCTTGGCCATTTCTCTA +GGTATTGGTATATTGTGTCTGCTGTGAACTGTCCTTGGCCTGTTTGGTGACGGGTGAGGA +GCAGGGACAGAAGGGTCCTGCGTGCCCTGCCTTCACAAGCCCCTGGAAGGAAAGTTGTTT +TGGGATCTCTGCACCCTCAGCCTGGACAACTTGTGCCCATCTGGTGACCCCTCACTCAGC +CACCAGACTTCCACGACAGGCTCCAGCCTCGGCACCTTCAGCCATGGACAGTTCCGCCAG +CGTTGCCCTCTGTTCTGCTGTTTTCTCTACCAGAAGTGCCCTTCCCTCCTCACCTGACCA +CTCTGGGGAAATCCCTCAGCACCCTCCCTGAGCATACCCTACTCTGGCACAAGCCCACCC +TGCAAAGCCCCTGAGGCCCGCCCTGTGGCGTCTCTCCCTCCCTTGCTGTCAGGACAGTGG +TCCTGGCCACCGGGGCTCACGGAGCCGCCCTGTGCCGTGTACCTCTGAGCCCTCTGCACA +GTGCCTTCTGCTTGCCTGTGGCTTTGAGAAGAAACCCCTTCTGGTTATACATAAGACAGC +CAGAGAAGGGAGTTGCCCAGGGTGGCACAGCACGTTGCTGCCAGTTACTGCCATTTTCAC +GGGCATGAAATGGAGATAACAACAGGAGCGACCGCACAGGCTGCTGAGCGCGTCACACGC +AGCCATCGCGCAGCTCAGGGATATTACGTGTAACTCGACATGTCAGCGATTGTCACAGGC +ACTGCTACTCCTGGGGTTTTCCATCAAACCCTCAAGAGCTGGGCCTGGGGTCAACTTCCG +GCCTGGGGAAACTGGGGCAAGTATCACCAGAGATGAGCTTTATAAAAATAATGGTGCTAG +CTGGGCATGGTGGCTTGCACCTGTAATCCCAGCACTTTGGGAGGCCGAGCTAGGAGGATC +GTTTGAGTCCAGCAGTTTGAGACCAGCCTGGCCAATACGGCAAAACCCAGTCTCTACAAA +AAATACAAAAAACAACTAGCCAGGCGTGGTGGTGCACACCTGTAGTCCCAGCTACTCAGG +AGGCTGAGGGGGAAGGACTGCTTGAGCCCAGGAGTTTGAGGCTGCTGTGAGCTGTGATCG +CATCACTGCATTCCAGCCCGGTGACAGAGTGAGTCACTGTCTCAAAAAAGAAAGGAAGAA +ATAAAGAAAACAAATAAAAATAATAGTGCAGACAAAAGGCCTTGACCCATCTAGCTTTGG +CCCTCAGCATCAACCGCTAGATACGTCCCTCCCTTTCTTCTGGGGCACAGGTCACACTCT +CTTCCAGGTCTAGGATGCAGCTGAGGGGTGCCCCTCTTACCATCTAATCTGTGCCCTTAT +TTCCTCTGCTTTAGTGAGGAAGAGGCCCCTGGTCCATGAAGGGGCCTTTCAGAGACGGGG +ACCCCTGAGGAGCCCCGAGCAGCAGCCGTCGTGTCTCACCCAGGGTGTCTGAAACAGATG +TGGAGGTCTCGGGTGAGGCGTGGCTCAGATACAGGGAGTGGCCCACAGCTCGGCCTGTCT +TTGAAAGGCCACGTGACCTGGCCCACGGCTGGCAGGTGGGACCCAGCTGCAGGGGTCCAG +CAGCACCCACAGCAGCCACCTGTGGCAGGGAGGAGCTTGTGGTACAGTGGACAGGCCCTG +CCCAGATGGCCCCCCGCCTGCCTGTGGAAGTTGACCAGACCATCTGTCACAGCAGGTAAG +ACTCTGCTTTCTGGGCAACCCAGCAGGTGACCCTGGAATTCCTGTCCATCTGGCAGGTGG +GCATTGAAACTGGTTTAAAAATGTCACACCATAGGCCGGGCACAGTGGCTCACGCCTGTA +ATCCCAGCCCTTTGGGAGGCCAGGGTGGGTGGATCACTTGAGGTCAGGAGTTCAAGACCA +GCCTGGCCAACATGGTGAAACCCCGTCTACTAAAAATACAAAAATTAGCCTGGCGTGGTG +GCGCATGCCTGTAATCCCAGCTACTTGGGAAGCTGAGGGATGAGAACTGCTTGAACCTGG +GAGGCAGACGTTGCAGTGAGCTGAGATCACGCCACTGCACTCCAGCCTGGGCAACAGAGT +AAGACTCTGTCTCAAAAAAAAAAAAATCACACCATTTTGGCTTCAGATTGCATATCCTCC +TGCAAGGATATATACGCGTGAAATTCAAGTCAATGACAAATCAGAAGAAAAAACATATAT +ATACGCAAACCAGTATCCTACTGTGTGTGTCGTTTGTTGTGTTTTCGACAGCTGTCCGTG +TTATAATAATTCCTCTAGTTCAAATTTATTCATTTTTAACTTCATAGTACCACATTCTAC +ACACTGCCCATGTCCCCTCAAGCTTCCCCTGGCTCCTGCAACCACAAATCTACTCTCTGC +CTCTGTGGGTTGACCTATTCTGGACACGTCATAGAAATAGAGTCCTGCAACACGTGGCCG +TCTGTGTCTGGCTTCTCTCGCTTAGCATCTTGTTTCCAAGGTCCTCCCACAGTGTAGCAT +GCACCTGCTACACTCCTTCTTAGGGCTGATATTCCACGCACCTGCTACACTCCTTCTTAT +GGCTGATATTCCACGCACCTGCTACACTCCTTCTTAGGGCTGATATTCCACACACCCGCT +ACACTCCTTCTTAGGGCTGATATTCCACGCACCCGCTACACTCCTTCTTAGGGCTGATAT +TCCACGCACCTGCTACACTCCTTCTTAGGGCTGATATTCCACGCACCTGCTACACTCCTT +CTTAGGGCTGATATTCCACGCACCTGCTACACTCCTTCTTAGGGCTGATATTCCACGCAC diff --git a/test/mpileup/mpileup.ref.fa.fai b/test/mpileup/mpileup.ref.fa.fai new file mode 100644 index 000000000..c2112667e --- /dev/null +++ b/test/mpileup/mpileup.ref.fa.fai @@ -0,0 +1 @@ +17 4200 14 60 61 diff --git a/test/test.pl b/test/test.pl index 981cc0b56..466ef0e07 100755 --- a/test/test.pl +++ b/test/test.pl @@ -249,6 +249,11 @@ test_vcf_consensus($opts,in=>'consensus2',out=>'consensus2.1.out',fa=>'consensus2.fa',args=>'-H 1'); test_vcf_consensus($opts,in=>'consensus2',out=>'consensus2.2.out',fa=>'consensus2.fa',args=>'-H 2'); test_vcf_consensus($opts,in=>'empty',out=>'consensus.5.out',fa=>'consensus.fa',args=>''); +test_mpileup($opts,in=>[qw(1 2 3)],out=>'mpileup/mpileup.1.out',args=>q[-r17:100-150]); +test_mpileup($opts,in=>[qw(1 2 3)],out=>'mpileup/mpileup.2.out',args=>q[-t DP,DV -r17:100-600]); # test files from samtools mpileup test suite +test_mpileup($opts,in=>[qw(1)],out=>'mpileup/mpileup.3.out',args=>q[-B --ff 0x14 -r17:1050-1060]); # test file converted to vcf from samtools mpileup test suite +test_mpileup($opts,in=>[qw(1 2 3)],out=>'mpileup/mpileup.4.out',args=>q[-t DP,DPR,DV,DP4,INFO/DPR,SP -r17:100-600]); #test files from samtools mpileup test suite +test_mpileup($opts,in=>[qw(1 2 3)],out=>'mpileup/mpileup.5.out',args=>q[-t DP,AD,ADF,ADR,SP,INFO/AD,INFO/ADF,INFO/ADR -r17:100-600]); print "\nNumber of tests:\n"; printf " total .. %d\n", $$opts{nok}+$$opts{nfailed}; @@ -922,3 +927,17 @@ sub test_naive_concat test_cmd($opts,exp=>$exp,out=>"concat.naive.vcf.out",cmd=>"$$opts{bin}/bcftools concat --naive $vcfs | $$opts{bin}/bcftools view -H"); } +sub test_mpileup +{ + my ($opts,%args) = @_; + + for my $fmt ('bam','cram') + { + my @files = (); + for my $file (@{$args{in}}) { push @files, "$$opts{path}/mpileup/mpileup.$file.$fmt"; } + my $files = join(' ',@files); + my $grep_hdr = "grep -v ^##bcftools | grep -v ^##reference"; + test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools mpileup $args{args} -f $$opts{path}/mpileup/mpileup.ref.fa $files 2>/dev/null | $grep_hdr"); + test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools mpileup $args{args} -f $$opts{path}/mpileup/mpileup.ref.fa -Ob $files 2>/dev/null | $$opts{bin}/bcftools view | $grep_hdr"); + } +} From b20d1e7441d09238c1126b8a48f677ffb3170aed Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Tue, 26 Apr 2016 21:06:44 +0100 Subject: [PATCH 194/211] bring over mpileup documentation --- doc/bcftools.1 | 415 +++++++++++++++++++++++++++++++++++++++++++++- doc/bcftools.html | 219 +++++++++++++++++++++++- doc/bcftools.txt | 193 +++++++++++++++++++++ 3 files changed, 818 insertions(+), 9 deletions(-) diff --git a/doc/bcftools.1 b/doc/bcftools.1 index a85c9a1b1..16552f4b5 100644 --- a/doc/bcftools.1 +++ b/doc/bcftools.1 @@ -2,12 +2,12 @@ .\" Title: bcftools .\" Author: [see the "AUTHORS" section] .\" Generator: DocBook XSL Stylesheets v1.76.1 -.\" Date: 2016-04-18 14:18 BST +.\" Date: 2016-04-26 21:06 BST .\" Manual: \ \& .\" Source: \ \& .\" Language: English .\" -.TH "BCFTOOLS" "1" "2016\-04\-18 14:18 BST" "\ \&" "\ \&" +.TH "BCFTOOLS" "1" "2016\-04\-26 21:06 BST" "\ \&" "\ \&" .\" ----------------------------------------------------------------- .\" * Define some portability stuff .\" ----------------------------------------------------------------- @@ -41,7 +41,7 @@ Most commands accept VCF, bgzipped VCF and BCF with filetype detected automatica BCFtools is designed to work on a stream\&. It regards an input file "\-" as the standard input (stdin) and outputs to the standard output (stdout)\&. Several commands can thus be combined with Unix pipes\&. .SS "VERSION" .sp -This manual page was last updated \fB2016\-04\-18 14:18 BST\fR and refers to bcftools git version \fB1\&.3\-36\-g47e811c+\fR\&. +This manual page was last updated \fB2016\-04\-26 21:06 BST\fR and refers to bcftools git version \fB1\&.3\&.1\-6\-g0848b12+\fR\&. .SS "BCF1" .sp The BCF1 format output by versions of samtools <= 0\&.1\&.19 is \fBnot\fR compatible with this version of bcftools\&. To read BCF1 files one can use the view command from old versions of bcftools packaged with samtools versions <= 0\&.1\&.19 to convert to VCF, which can then be read by this version of bcftools\&. @@ -214,6 +214,19 @@ For a full list of available commands, run \fBbcftools\fR without arguments\&. F .IP \(bu 2.3 .\} +\fBmpileup\fR +\&.\&. multi\-way pileup producing genotype likelihoods +.RE +.sp +.RS 4 +.ie n \{\ +\h'-04'\(bu\h'+03'\c +.\} +.el \{\ +.sp -1 +.IP \(bu 2.3 +.\} + \fBnorm\fR \&.\&. normalize indels .RE @@ -2147,6 +2160,402 @@ see see \fBCommon Options\fR .RE +.SS "bcftools mpileup [\fIOPTIONS\fR] \-f \fIref\&.fa\fR \fIin\&.bam\fR [\fIin2\&.bam\fR [\&...]]" +.sp +Generate VCF or BCF containing genotype likelihoods for one or multiple alignment (BAM or CRAM) files\&. This is based on the original \fBsamtools mpileup\fR command (with the \fB\-v\fR or \fB\-g\fR options) producing genotype likelihoods in VCF or BCF format, but not the textual pileup output\&. The \fBmpileup\fR command was transferred to bcftools in order to avoid errors resulting from use of incompatible versions of samtools and bcftools when using in the mpileup+bcftools call pipeline\&. +.sp +Individuals are identified from the SM tags in the @RG header lines\&. Multiple individuals can be pooled in one alignment file, also one individual can be separated into multiple files\&. If sample identifiers are absent, each input file is regarded as one sample\&. +.sp +Note that there are two orthogonal ways to specify locations in the input file; via \fB\-r\fR \fIregion\fR and \fB\-l\fR \fIpositions\fR\&. The former uses (and requires) an index to do random access while the latter streams through the file contents filtering out the specified regions, requiring no index\&. The two may be used in conjunction\&. For example a BED file containing locations of genes in chromosome 20 could be specified using \fB\-r 20 \-l chr20\&.bed\fR, meaning that the index is used to find chromosome 20 and then it is filtered for the regions listed in the BED file\&. +.sp +.it 1 an-trap +.nr an-no-space-flag 1 +.nr an-break-flag 1 +.br +.ps +1 +\fBInput options\fR +.RS 4 +.PP +\fB\-6, \-\-illumina1\&.3+\fR +.RS 4 +Assume the quality is in the Illumina 1\&.3+ encoding\&. +.RE +.PP +\fB\-A, \-\-count\-orphans\fR +.RS 4 +Do not skip anomalous read pairs in variant calling\&. +.RE +.PP +\fB\-b, \-\-bam\-list\fR \fIFILE\fR +.RS 4 +List of input alignment files, one file per line [null] +.RE +.PP +\fB\-B, \-\-no\-BAQ\fR +.RS 4 +Disable probabilistic realignment for the computation of base alignment quality (BAQ)\&. BAQ is the Phred\-scaled probability of a read base being misaligned\&. Applying this option greatly helps to reduce false SNPs caused by misalignments\&. +.RE +.PP +\fB\-C, \-\-adjust\-MQ\fR \fIINT\fR +.RS 4 +Coefficient for downgrading mapping quality for reads containing excessive mismatches\&. Given a read with a phred\-scaled probability q of being generated from the mapped posi\- tion, the new mapping quality is about sqrt((INT\-q)/INT)*INT\&. A zero value disables this functionality; if enabled, the recommended value for BWA is 50\&. [0] +.RE +.PP +\fB\-d, \-\-max\-depth\fR \fIINT\fR +.RS 4 +At a position, read maximally +\fIINT\fR +reads per input file\&. Note that bcftools has a minimum value of +\fI8000/n\fR +where +\fIn\fR +is the number of input files given to mpileup\&. This means the default is highly likely to be increased\&. Once above the cross\-sample minimum of 8000 the \-d parameter will have an effect\&. [250] +.RE +.PP +\fB\-E, \-\-redo\-BAQ\fR +.RS 4 +Recalculate BAQ on the fly, ignore existing BQ tags +.RE +.PP +\fB\-f, \-\-fasta\-ref\fR \fIFILE\fR +.RS 4 +The +\fBfaidx\fR\-indexed reference file in the FASTA format\&. The file can be optionally compressed by +\fBbgzip\fR +[null] +.RE +.PP +\fB\-G, \-\-exclude\-RG\fR \fIFILE\fR +.RS 4 +Exclude reads from readgroups listed in FILE (one @RG\-ID per line) +.RE +.PP +\fB\-l, \-\-positions\fR \fIFILE\fR +.RS 4 +BED or position list file containing a list of regions or sites where output should be generated\&. Position list files contain two columns (chromosome and position) and start counting from 1\&. BED files contain at least 3 columns (chromosome, start and end position) and are 0\-based half\-open\&. While it is possible to mix both position\-list and BED coordinates in the same file, this is strongly ill advised due to the differing coordinate systems\&. [null] +.RE +.PP +\fB\-q, \-min\-MQ\fR \fIINT\fR +.RS 4 +Minimum mapping quality for an alignment to be used [0] +.RE +.PP +\fB\-Q, \-\-min\-BQ\fR \fIINT\fR +.RS 4 +Minimum base quality for a base to be considered [13] +.RE +.PP +\fB\-r, \-\-region\fR \fISTR\fR +.RS 4 +Only generate output in region\&. Requires the alignment files to be indexed\&. If used in conjunction with \-l then considers the intersection of the two requests [all sites] +.RE +.PP +\fB\-R, \-\-ignore\-RG\fR +.RS 4 +Ignore RG tags\&. Treat all reads in one alignment file as one sample\&. +.RE +.PP +\fB\-\-rf, \-\-incl\-flags\fR \fISTR\fR|\fIINT\fR +.RS 4 +Required flags: skip reads with mask bits unset [null] +.RE +.PP +\fB\-\-ff, \-\-excl\-flags\fR \fISTR\fR|\fIINT\fR +.RS 4 +Filter flags: skip reads with mask bits set [UNMAP,SECONDARY,QCFAIL,DUP] +.RE +.PP +\fB\-x, \-\-ignore\-overlaps\fR +.RS 4 +Disable read\-pair overlap detection\&. +.RE +.RE +.sp +.it 1 an-trap +.nr an-no-space-flag 1 +.nr an-break-flag 1 +.br +.ps +1 +\fBOutput options\fR +.RS 4 +.PP +\fB\-o, \-\-output\fR \fIFILE\fR +.RS 4 +Write output to +\fIFILE\fR, rather than the default of standard output\&. (The same short option is used for both +\fB\-\-open\-prob\fR +and +\fB\-\-output\fR\&. If +\fB\-o\fR\*(Aqs argument contains any non\-digit characters other than a leading + or \- sign, it is interpreted as +\fB\-\-output\fR\&. Usually the filename extension will take care of this, but to write to an entirely numeric filename use +\fB\-o \&./123\fR +or +\fB\-\-output 123\fR\&.) +.RE +.PP +\fB\-O, \-\-output\-type\fR \fIb\fR|\fIu\fR|\fIz\fR|\fIv\fR +.RS 4 +see +\fBCommon Options\fR +.RE +.PP +\fB\-t, \-\-output\-tags\fR \fILIST\fR +.RS 4 +Comma\-separated list of FORMAT and INFO tags to output (case\-insensitive) [null]: +.sp +.RS 4 +.ie n \{\ +\h'-04'\(bu\h'+03'\c +.\} +.el \{\ +.sp -1 +.IP \(bu 2.3 +.\} + +\fBAD\fR +\&.\&. Allelic depth, FORMAT +.RE +.sp +.RS 4 +.ie n \{\ +\h'-04'\(bu\h'+03'\c +.\} +.el \{\ +.sp -1 +.IP \(bu 2.3 +.\} + +\fBINFO/AD\fR +\&.\&. Total allelic depth, INFO +.RE +.sp +.RS 4 +.ie n \{\ +\h'-04'\(bu\h'+03'\c +.\} +.el \{\ +.sp -1 +.IP \(bu 2.3 +.\} + +\fBADF\fR +\&.\&. Allelic depths on the forward strand, FORMAT +.RE +.sp +.RS 4 +.ie n \{\ +\h'-04'\(bu\h'+03'\c +.\} +.el \{\ +.sp -1 +.IP \(bu 2.3 +.\} + +\fBINFO/ADF\fR +\&.\&. Total allelic depths on the forward strand, INFO +.RE +.sp +.RS 4 +.ie n \{\ +\h'-04'\(bu\h'+03'\c +.\} +.el \{\ +.sp -1 +.IP \(bu 2.3 +.\} + +\fBADR\fR +\&.\&. Allelic depths on the reverse strand, FORMAT +.RE +.sp +.RS 4 +.ie n \{\ +\h'-04'\(bu\h'+03'\c +.\} +.el \{\ +.sp -1 +.IP \(bu 2.3 +.\} + +\fBINFO/ADR\fR +\&.\&. Total allelic depths on the reverse strand, INFO +.RE +.sp +.RS 4 +.ie n \{\ +\h'-04'\(bu\h'+03'\c +.\} +.el \{\ +.sp -1 +.IP \(bu 2.3 +.\} + +\fBDP\fR +\&.\&. Number of high\-quality bases, FORMAT +.RE +.sp +.RS 4 +.ie n \{\ +\h'-04'\(bu\h'+03'\c +.\} +.el \{\ +.sp -1 +.IP \(bu 2.3 +.\} + +\fBSP\fR +\&.\&. Phred\-scaled strand bias P\-value, FORMAT +.RE +.sp +.RS 4 +.ie n \{\ +\h'-04'\(bu\h'+03'\c +.\} +.el \{\ +.sp -1 +.IP \(bu 2.3 +.\} + +\fBDV\fR +\&.\&. Deprecated in favor of AD; Number of high\-quality non\-reference bases, FORMAT +.RE +.sp +.RS 4 +.ie n \{\ +\h'-04'\(bu\h'+03'\c +.\} +.el \{\ +.sp -1 +.IP \(bu 2.3 +.\} + +\fBDPR\fR +\&.\&. Deprecated in favor of AD; Number of high\-quality bases for each observed allele, FORMAT +.RE +.sp +.RS 4 +.ie n \{\ +\h'-04'\(bu\h'+03'\c +.\} +.el \{\ +.sp -1 +.IP \(bu 2.3 +.\} + +\fBINFO/DPR\fR +\&.\&. Deprecated in favor of INFO/AD; Number of high\-quality bases for each observed allele, INFO +.RE +.sp +.RS 4 +.ie n \{\ +\h'-04'\(bu\h'+03'\c +.\} +.el \{\ +.sp -1 +.IP \(bu 2.3 +.\} + +\fBDP4\fR +\&.\&. Deprecated in favor of ADF and ADR; Number of high\-quality ref\-forward, ref\-reverse, alt\-forward and alt\-reverse bases, FORMAT +.RE +.RE +.RE +.sp +.it 1 an-trap +.nr an-no-space-flag 1 +.nr an-break-flag 1 +.br +.ps +1 +\fBOptions for SNP/INDEL genotype likelihood computation\fR +.RS 4 +.PP +\fB\-e, \-\-ext\-prob\fR \fIINT\fR +.RS 4 +Phred\-scaled gap extension sequencing error probability\&. Reducing +\fIINT\fR +leads to longer indels [20] +.RE +.PP +\fB\-F, \-\-gap\-frac\fR \fIFLOAT\fR +.RS 4 +Minimum fraction of gapped reads [0\&.002] +.RE +.PP +\fB\-h, \-\-tandem\-qual\fR \fIINT\fR +.RS 4 +Coefficient for modeling homopolymer errors\&. Given an +\fIl\fR\-long homopolymer run, the sequencing error of an indel of size s is modeled as +\fIINT\fR*s/l [100] +.RE +.PP +\fB\-I, \-\-skip\-indels\fR +.RS 4 +Do not perform INDEL calling +.RE +.PP +\fB\-L, \-\-max\-idepth\fR \fIINT\fR +.RS 4 +Skip INDEL calling if the average per\-sample depth is above +\fIINT\fR +[250] +.RE +.PP +\fB\-m, \-\-min\-ireads\fR \fIINT\fR +.RS 4 +Minimum number gapped reads for indel candidates +\fIINT\fR +[1] +.RE +.PP +\fB\-o, \-\-open\-prob\fR \fIINT\fR +.RS 4 +Phred\-scaled gap open sequencing error probability\&. Reducing +\fIINT\fR +leads to more indel calls\&. (The same short option is used for both +\fB\-\-open\-prob\fR +and +\fB\-\-output\fR\&. When \-o\(cqs argument contains only an optional + or \- sign followed by the digits 0 to 9, it is interpreted as +\fB\-\-open\-prob\fR\&.) [40] +.RE +.PP +\fB\-p, \-\-per\-sample\-mF\fR +.RS 4 +Apply +\fB\-m\fR +and +\fB\-F\fR +thresholds per sample to increase sensitivity of calling\&. By default both options are applied to reads pooled from all samples\&. +.RE +.PP +\fB\-P, \-\-platforms\fR \fISTR\fR +.RS 4 +Comma\-delimited list of platforms (determined by +\fB@RG\-PL\fR) from which indel candidates are obtained\&. It is recommended to collect indel candidates from sequencing technologies that have low indel error rate such as ILLUMINA [all] +.RE +.RE +.sp +.it 1 an-trap +.nr an-no-space-flag 1 +.nr an-break-flag 1 +.br +.ps +1 +\fBExamples:\fR +.RS 4 +.sp +Call SNPs and short INDELs, then mark low quality sites and sites with the read depth exceeding a limit\&. (The read depth should be adjusted to about twice the average read depth as higher read depths usually indicate problematic regions which are often enriched for artefacts\&.) One may consider to add \fB\-C50\fR to mpileup if mapping quality is overestimated for reads containing excessive mismatches\&. Applying this option usually helps for BWA\-backtrack alignments, but may not other aligners\&. +.sp +.if n \{\ +.RS 4 +.\} +.nf + bcftools mpileup \-Ou \-f ref\&.fa aln\&.bam | \e + bcftools call \-Ou \-mv | \e + bcftools filter \-s LowQual \-e \*(Aq%QUAL<20 || DP>100\*(Aq > var\&.flt\&.vcf +.fi +.if n \{\ +.RE +.\} +.RE .SS "bcftools norm [\fIOPTIONS\fR] \fIfile\&.vcf\&.gz\fR" .sp Left\-align and normalize indels, check if REF alleles match the reference, split multiallelic sites into multiple rows; recover multiallelics from multiple rows\&. Left\-alignment and normalization will only be applied if the \fB\-\-fasta\-ref\fR option is supplied\&. diff --git a/doc/bcftools.html b/doc/bcftools.html index d089aec16..c7d181442 100644 --- a/doc/bcftools.html +++ b/doc/bcftools.html @@ -1,6 +1,6 @@ -bcftools

    Name

    bcftools — utilities for variant calling and manipulating VCFs and BCFs.

    Synopsis

    bcftools [--version|--version-only] [--help] [COMMAND] [OPTIONS]

    DESCRIPTION

    BCFtools is a set of utilities that manipulate variant calls in the Variant +bcftools

    Name

    bcftools — utilities for variant calling and manipulating VCFs and BCFs.

    Synopsis

    bcftools [--version|--version-only] [--help] [COMMAND] [OPTIONS]

    DESCRIPTION

    BCFtools is a set of utilities that manipulate variant calls in the Variant Call Format (VCF) and its binary counterpart BCF. All commands work transparently with both VCFs and BCFs, both uncompressed and BGZF-compressed.

    Most commands accept VCF, bgzipped VCF and BCF with filetype detected automatically even when streaming from a pipe. Indexed VCF and BCF @@ -8,7 +8,7 @@ work in most, but not all situations. In general, whenever multiple VCFs are read simultaneously, they must be indexed and therefore also compressed.

    BCFtools is designed to work on a stream. It regards an input file "-" as the standard input (stdin) and outputs to the standard output (stdout). Several -commands can thus be combined with Unix pipes.

    VERSION

    This manual page was last updated 2016-04-18 14:18 BST and refers to bcftools git version 1.3-36-g47e811c+.

    BCF1

    The BCF1 format output by versions of samtools <= 0.1.19 is not +commands can thus be combined with Unix pipes.

    VERSION

    This manual page was last updated 2016-04-26 21:06 BST and refers to bcftools git version 1.3.1-6-g0848b12+.

    BCF1

    The BCF1 format output by versions of samtools <= 0.1.19 is not compatible with this version of bcftools. To read BCF1 files one can use the view command from old versions of bcftools packaged with samtools versions <= 0.1.19 to convert to VCF, which can then be read by @@ -41,6 +41,8 @@

  • merge .. merge VCF/BCF files files from non-overlapping sample sets
  • +mpileup .. multi-way pileup producing genotype likelihoods +
  • norm .. normalize indels
  • plugin .. run user-defined plugin @@ -1230,7 +1232,212 @@ --threads INT
    see Common Options -
  • bcftools norm [OPTIONS] file.vcf.gz

    Left-align and normalize indels, check if REF alleles match the reference, +

    bcftools mpileup [OPTIONS] -f ref.fa in.bam [in2.bam […]]

    Generate VCF or BCF containing genotype likelihoods for one or multiple +alignment (BAM or CRAM) files. This is based on the original +samtools mpileup command (with the -v or -g options) producing +genotype likelihoods in VCF or BCF format, but not the textual pileup +output. The mpileup command was transferred to bcftools in order to +avoid errors resulting from use of incompatible versions of samtools +and bcftools when using in the mpileup+bcftools call pipeline.

    Individuals are identified from the SM tags in the @RG header lines. Multiple +individuals can be pooled in one alignment file, also one individual can be +separated into multiple files. If sample identifiers are absent, each input +file is regarded as one sample.

    Note that there are two orthogonal ways to specify locations in the +input file; via -r region and -l positions. The +former uses (and requires) an index to do random access while the +latter streams through the file contents filtering out the specified +regions, requiring no index. The two may be used in conjunction. For +example a BED file containing locations of genes in chromosome 20 +could be specified using -r 20 -l chr20.bed, meaning that the +index is used to find chromosome 20 and then it is filtered for the +regions listed in the BED file.

    Input options

    +-6, --illumina1.3+ +
    + Assume the quality is in the Illumina 1.3+ encoding. +
    +-A, --count-orphans +
    + Do not skip anomalous read pairs in variant calling. +
    +-b, --bam-list FILE +
    + List of input alignment files, one file per line [null] +
    +-B, --no-BAQ +
    + Disable probabilistic realignment for the computation of base alignment + quality (BAQ). BAQ is the Phred-scaled probability of a read base being + misaligned. Applying this option greatly helps to reduce false SNPs caused + by misalignments. +
    +-C, --adjust-MQ INT +
    + Coefficient for downgrading mapping quality for reads containing + excessive mismatches. Given a read with a phred-scaled probability q of + being generated from the mapped posi- tion, the new mapping quality is + about sqrt((INT-q)/INT)*INT. A zero value disables this functionality; if + enabled, the recommended value for BWA is 50. [0] +
    +-d, --max-depth INT +
    + At a position, read maximally INT reads per input file. Note that bcftools + has a minimum value of 8000/n where n is the number of input files given + to mpileup. This means the default is highly likely to be increased. Once + above the cross-sample minimum of 8000 the -d parameter will have an effect. + [250] +
    +-E, --redo-BAQ +
    + Recalculate BAQ on the fly, ignore existing BQ tags +
    +-f, --fasta-ref FILE +
    + The faidx-indexed reference file in the FASTA format. The file can be + optionally compressed by bgzip [null] +
    +-G, --exclude-RG FILE +
    + Exclude reads from readgroups listed in FILE (one @RG-ID per line) +
    +-l, --positions FILE +
    + BED or position list file containing a list of regions or sites where + output should be generated. Position list files contain two + columns (chromosome and position) and start counting from 1. BED + files contain at least 3 columns (chromosome, start and end position) + and are 0-based half-open. + While it is possible to mix both position-list and BED coordinates in + the same file, this is strongly ill advised due to the differing + coordinate systems. [null] +
    +-q, -min-MQ INT +
    + Minimum mapping quality for an alignment to be used [0] +
    +-Q, --min-BQ INT +
    + Minimum base quality for a base to be considered [13] +
    +-r, --region STR +
    + Only generate output in region. Requires the alignment files to be + indexed. If used in conjunction with -l then considers the intersection + of the two requests [all sites] +
    +-R, --ignore-RG +
    + Ignore RG tags. Treat all reads in one alignment file as one sample. +
    +--rf, --incl-flags STR|INT +
    + Required flags: skip reads with mask bits unset [null] +
    +--ff, --excl-flags STR|INT +
    + Filter flags: skip reads with mask bits set [UNMAP,SECONDARY,QCFAIL,DUP] +
    +-x, --ignore-overlaps +
    + Disable read-pair overlap detection. +

    Output options

    +-o, --output FILE +
    + Write output to FILE, rather than the default of standard output. + (The same short option is used for both --open-prob and --output. If -o's + argument contains any non-digit characters other than a leading + or - + sign, it is interpreted as --output. Usually the filename extension + will take care of this, but to write to an entirely numeric filename use -o + ./123 or --output 123.) +
    +-O, --output-type b|u|z|v +
    + see Common Options +
    +-t, --output-tags LIST +

    + Comma-separated list of FORMAT and INFO tags to output (case-insensitive) [null]: +

    • +AD .. Allelic depth, FORMAT +
    • +INFO/AD .. Total allelic depth, INFO +
    • +ADF .. Allelic depths on the forward strand, FORMAT +
    • +INFO/ADF .. Total allelic depths on the forward strand, INFO +
    • +ADR .. Allelic depths on the reverse strand, FORMAT +
    • +INFO/ADR .. Total allelic depths on the reverse strand, INFO +
    • +DP .. Number of high-quality bases, FORMAT +
    • +SP .. Phred-scaled strand bias P-value, FORMAT +
    • +DV .. Deprecated in favor of AD; + Number of high-quality non-reference bases, FORMAT +
    • +DPR .. Deprecated in favor of AD; + Number of high-quality bases for each observed allele, FORMAT +
    • +INFO/DPR .. Deprecated in favor of INFO/AD; + Number of high-quality bases for each observed allele, INFO +
    • +DP4 .. Deprecated in favor of ADF and ADR; + Number of high-quality ref-forward, ref-reverse, + alt-forward and alt-reverse bases, FORMAT +

    Options for SNP/INDEL genotype likelihood computation

    +-e, --ext-prob INT +
    + Phred-scaled gap extension sequencing error probability. Reducing INT + leads to longer indels [20] +
    +-F, --gap-frac FLOAT +
    + Minimum fraction of gapped reads [0.002] +
    +-h, --tandem-qual INT +
    + Coefficient for modeling homopolymer errors. Given an l-long homopolymer + run, the sequencing error of an indel of size s is modeled as INT*s/l [100] +
    +-I, --skip-indels +
    + Do not perform INDEL calling +
    +-L, --max-idepth INT +
    + Skip INDEL calling if the average per-sample depth is above INT [250] +
    +-m, --min-ireads INT +
    + Minimum number gapped reads for indel candidates INT [1] +
    +-o, --open-prob INT +
    + Phred-scaled gap open sequencing error probability. Reducing INT leads + to more indel calls. (The same short option is used for both --open-prob + and --output. When -o’s argument contains only an optional + or - sign + followed by the digits 0 to 9, it is interpreted as --open-prob.) [40] +
    +-p, --per-sample-mF +
    + Apply -m and -F thresholds per sample to increase sensitivity of calling. + By default both options are applied to reads pooled from all samples. +
    +-P, --platforms STR +
    + Comma-delimited list of platforms (determined by @RG-PL) from which + indel candidates are obtained. It is recommended to collect indel + candidates from sequencing technologies that have low indel error rate + such as ILLUMINA [all] +

    Examples:

    Call SNPs and short INDELs, then mark low quality sites and sites with the read +depth exceeding a limit. (The read depth should be adjusted to about twice the +average read depth as higher read depths usually indicate problematic regions +which are often enriched for artefacts.) One may consider to add -C50 to +mpileup if mapping quality is overestimated for reads containing excessive +mismatches. Applying this option usually helps for BWA-backtrack alignments, +but may not other aligners.

        bcftools mpileup -Ou -f ref.fa aln.bam | \
    +    bcftools call -Ou -mv | \
    +    bcftools filter -s LowQual -e '%QUAL<20 || DP>100' > var.flt.vcf

    bcftools norm [OPTIONS] file.vcf.gz

    Left-align and normalize indels, check if REF alleles match the reference, split multiallelic sites into multiple rows; recover multiallelics from multiple rows. Left-alignment and normalization will only be applied if the --fasta-ref option is supplied.

    @@ -1413,7 +1620,7 @@ vcf2sex
    determine sample sex by checking genotypes in haploid regions -

    Examples:

    # List options common to all plugins
    +

    Examples:

    # List options common to all plugins
     bcftools plugin
     
     # List available plugins
    @@ -1601,7 +1808,7 @@
     %TGT            Translated genotype (e.g. C/A)
     %IUPACGT        Genotype translated to IUPAC ambiguity codes (e.g. M instead of C/A)
     %LINE           Prints the whole line
    -%SAMPLE         Sample name

    Examples:

    bcftools query -f '%CHROM  %POS  %REF  %ALT{0}\n' file.vcf.gz
    +%SAMPLE         Sample name

    Examples:

    bcftools query -f '%CHROM  %POS  %REF  %ALT{0}\n' file.vcf.gz
     bcftools query -f '%CHROM\t%POS\t%REF\t%ALT[\t%SAMPLE=%GT]\n' file.vcf.gz

    bcftools reheader [OPTIONS] file.vcf.gz

    Modify header of VCF/BCF files, change sample names.

    -h, --header FILE
    @@ -1797,7 +2004,7 @@
    produce verbose per-site and per-sample output

    bcftools view [OPTIONS] file.vcf.gz [REGION […]]

    View, subset and filter VCF or BCF files by position and filtering expression. -Convert between VCF and BCF. Former bcftools subset.

    Output options

    +Convert between VCF and BCF. Former bcftools subset.

    Output options

    -G, --drop-genotypes
    drop individual genotype information (after subsetting if -s option is set) diff --git a/doc/bcftools.txt b/doc/bcftools.txt index ad0d9d170..a79e85e69 100644 --- a/doc/bcftools.txt +++ b/doc/bcftools.txt @@ -85,6 +85,7 @@ list of available options, run *bcftools* 'COMMAND' without arguments. - *<>* .. index VCF/BCF - *<>* .. intersections of VCF/BCF files - *<>* .. merge VCF/BCF files files from non-overlapping sample sets +- *<>* .. multi-way pileup producing genotype likelihoods - *<>* .. normalize indels - *<>* .. run user-defined plugin - *<>* .. detect contaminations and whole-chromosome aberrations @@ -1282,6 +1283,198 @@ For "vertical" merge take a look at *<>* instead. see *<>* +[[mpileup]] +=== bcftools mpileup ['OPTIONS'] *-f* 'ref.fa' 'in.bam' ['in2.bam' [...]] +Generate VCF or BCF containing genotype likelihoods for one or multiple +alignment (BAM or CRAM) files. This is based on the original +*samtools mpileup* command (with the *-v* or *-g* options) producing +genotype likelihoods in VCF or BCF format, but not the textual pileup +output. The *mpileup* command was transferred to bcftools in order to +avoid errors resulting from use of incompatible versions of samtools +and bcftools when using in the mpileup+bcftools call pipeline. + +Individuals are identified from the SM tags in the @RG header lines. Multiple +individuals can be pooled in one alignment file, also one individual can be +separated into multiple files. If sample identifiers are absent, each input +file is regarded as one sample. + + +Note that there are two orthogonal ways to specify locations in the +input file; via *-r* 'region' and *-l* 'positions'. The +former uses (and requires) an index to do random access while the +latter streams through the file contents filtering out the specified +regions, requiring no index. The two may be used in conjunction. For +example a BED file containing locations of genes in chromosome 20 +could be specified using *-r 20 -l chr20.bed*, meaning that the +index is used to find chromosome 20 and then it is filtered for the +regions listed in the BED file. + + +==== Input options + +*-6, --illumina1.3+*:: + Assume the quality is in the Illumina 1.3+ encoding. + +*-A, --count-orphans*:: + Do not skip anomalous read pairs in variant calling. + +*-b, --bam-list* 'FILE':: + List of input alignment files, one file per line [null] + +*-B, --no-BAQ*:: + Disable probabilistic realignment for the computation of base alignment + quality (BAQ). BAQ is the Phred-scaled probability of a read base being + misaligned. Applying this option greatly helps to reduce false SNPs caused + by misalignments. + +*-C, --adjust-MQ* 'INT':: + Coefficient for downgrading mapping quality for reads containing + excessive mismatches. Given a read with a phred-scaled probability q of + being generated from the mapped posi- tion, the new mapping quality is + about sqrt((INT-q)/INT)*INT. A zero value disables this functionality; if + enabled, the recommended value for BWA is 50. [0] + +*-d, --max-depth* 'INT':: + At a position, read maximally 'INT' reads per input file. Note that bcftools + has a minimum value of '8000/n' where 'n' is the number of input files given + to mpileup. This means the default is highly likely to be increased. Once + above the cross-sample minimum of 8000 the -d parameter will have an effect. + [250] + +*-E, --redo-BAQ*:: + Recalculate BAQ on the fly, ignore existing BQ tags + +*-f, --fasta-ref* 'FILE':: + The *faidx*-indexed reference file in the FASTA format. The file can be + optionally compressed by *bgzip* [null] + +*-G, --exclude-RG* 'FILE':: + Exclude reads from readgroups listed in FILE (one @RG-ID per line) + +*-l, --positions* 'FILE':: + BED or position list file containing a list of regions or sites where + output should be generated. Position list files contain two + columns (chromosome and position) and start counting from 1. BED + files contain at least 3 columns (chromosome, start and end position) + and are 0-based half-open. + While it is possible to mix both position-list and BED coordinates in + the same file, this is strongly ill advised due to the differing + coordinate systems. [null] + +*-q, -min-MQ* 'INT':: + Minimum mapping quality for an alignment to be used [0] + +*-Q, --min-BQ* 'INT':: + Minimum base quality for a base to be considered [13] + +*-r, --region* 'STR':: + Only generate output in region. Requires the alignment files to be + indexed. If used in conjunction with -l then considers the intersection + of the two requests [all sites] + +*-R, --ignore-RG*:: + Ignore RG tags. Treat all reads in one alignment file as one sample. + +*--rf, --incl-flags* 'STR'|'INT':: + Required flags: skip reads with mask bits unset [null] + +*--ff, --excl-flags* 'STR'|'INT':: + Filter flags: skip reads with mask bits set [UNMAP,SECONDARY,QCFAIL,DUP] + +*-x, --ignore-overlaps*:: + Disable read-pair overlap detection. + + +==== Output options + +*-o, --output* 'FILE':: + Write output to 'FILE', rather than the default of standard output. + (The same short option is used for both *--open-prob* and *--output*. If *-o*'s + argument contains any non-digit characters other than a leading + or - + sign, it is interpreted as *--output*. Usually the filename extension + will take care of this, but to write to an entirely numeric filename use *-o + ./123* or *--output 123*.) + +*-O, --output-type* 'b'|'u'|'z'|'v':: + see *<>* + +*-t, --output-tags* 'LIST':: + Comma-separated list of FORMAT and INFO tags to output (case-insensitive) [null]: + + - *AD* .. Allelic depth, FORMAT + - *INFO/AD* .. Total allelic depth, INFO + - *ADF* .. Allelic depths on the forward strand, FORMAT + - *INFO/ADF* .. Total allelic depths on the forward strand, INFO + - *ADR* .. Allelic depths on the reverse strand, FORMAT + - *INFO/ADR* .. Total allelic depths on the reverse strand, INFO + - *DP* .. Number of high-quality bases, FORMAT + - *SP* .. Phred-scaled strand bias P-value, FORMAT + + - *DV* .. Deprecated in favor of AD; + Number of high-quality non-reference bases, FORMAT + - *DPR* .. Deprecated in favor of AD; + Number of high-quality bases for each observed allele, FORMAT + - *INFO/DPR* .. Deprecated in favor of INFO/AD; + Number of high-quality bases for each observed allele, INFO + - *DP4* .. Deprecated in favor of ADF and ADR; + Number of high-quality ref-forward, ref-reverse, + alt-forward and alt-reverse bases, FORMAT + + +==== Options for SNP/INDEL genotype likelihood computation + +*-e, --ext-prob* 'INT':: + Phred-scaled gap extension sequencing error probability. Reducing 'INT' + leads to longer indels [20] + +*-F, --gap-frac* 'FLOAT':: + Minimum fraction of gapped reads [0.002] + +*-h, --tandem-qual* 'INT':: + Coefficient for modeling homopolymer errors. Given an 'l'-long homopolymer + run, the sequencing error of an indel of size s is modeled as 'INT'*s/l [100] + +*-I, --skip-indels*:: + Do not perform INDEL calling + +*-L, --max-idepth* 'INT':: + Skip INDEL calling if the average per-sample depth is above 'INT' [250] + +*-m, --min-ireads* 'INT':: + Minimum number gapped reads for indel candidates 'INT' [1] + +*-o, --open-prob* 'INT':: + Phred-scaled gap open sequencing error probability. Reducing 'INT' leads + to more indel calls. (The same short option is used for both *--open-prob* + and *--output*. When -o's argument contains only an optional + or - sign + followed by the digits 0 to 9, it is interpreted as *--open-prob*.) [40] + +*-p, --per-sample-mF*:: + Apply *-m* and *-F* thresholds per sample to increase sensitivity of calling. + By default both options are applied to reads pooled from all samples. + +*-P, --platforms* 'STR':: + Comma-delimited list of platforms (determined by *@RG-PL*) from which + indel candidates are obtained. It is recommended to collect indel + candidates from sequencing technologies that have low indel error rate + such as ILLUMINA [all] + +==== Examples: + +Call SNPs and short INDELs, then mark low quality sites and sites with the read +depth exceeding a limit. (The read depth should be adjusted to about twice the +average read depth as higher read depths usually indicate problematic regions +which are often enriched for artefacts.) One may consider to add *-C50* to +mpileup if mapping quality is overestimated for reads containing excessive +mismatches. Applying this option usually helps for BWA-backtrack alignments, +but may not other aligners. +---- + bcftools mpileup -Ou -f ref.fa aln.bam | \ + bcftools call -Ou -mv | \ + bcftools filter -s LowQual -e '%QUAL<20 || DP>100' > var.flt.vcf +---- + + [[norm]] === bcftools norm ['OPTIONS'] 'file.vcf.gz' Left-align and normalize indels, check if REF alleles match the reference, From 6546afdc2d7084ffc3e4dfbe34f10d08bb2b031e Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Mon, 9 May 2016 10:07:37 +0100 Subject: [PATCH 195/211] mpileup: remove `printw()` which was only used in the text output adds to @4e7c8fb86349761fed1b290357dbc792222ecdcb --- mpileup.c | 18 +----------------- 1 file changed, 1 insertion(+), 17 deletions(-) diff --git a/mpileup.c b/mpileup.c index 4e0883fc0..75dcba21e 100644 --- a/mpileup.c +++ b/mpileup.c @@ -38,24 +38,8 @@ DEALINGS IN THE SOFTWARE. */ #include #include #include -#include "bcftools.h" - -static inline int printw(int c, FILE *fp) -{ - char buf[16]; - int l, x; - if (c == 0) return fputc('0', fp); - for (l = 0, x = c < 0? -c : c; x > 0; x /= 10) buf[l++] = x%10 + '0'; - if (c < 0) buf[l++] = '-'; - buf[l] = 0; - for (x = 0; x < l/2; ++x) { - int y = buf[x]; buf[x] = buf[l-1-x]; buf[l-1-x] = y; - } - fputs(buf, fp); - return 0; -} - #include +#include "bcftools.h" #include "bam2bcf.h" #include "sample.h" From acb1b9b6375d12b018fae8c640588716308d11c0 Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Thu, 26 May 2016 13:56:14 +0100 Subject: [PATCH 196/211] remove deprecated options * remove deprecated `-g`, `-v`, `-u`, `-D`, `-V`, `-S` * remove `-R` short option to make way for `--regions-file` option later --- doc/bcftools.txt | 2 +- mpileup.c | 26 +++++--------------------- 2 files changed, 6 insertions(+), 22 deletions(-) diff --git a/doc/bcftools.txt b/doc/bcftools.txt index a79e85e69..fc26f6f1c 100644 --- a/doc/bcftools.txt +++ b/doc/bcftools.txt @@ -1372,7 +1372,7 @@ regions listed in the BED file. indexed. If used in conjunction with -l then considers the intersection of the two requests [all sites] -*-R, --ignore-RG*:: +*--ignore-RG*:: Ignore RG tags. Treat all reads in one alignment file as one sample. *--rf, --incl-flags* 'STR'|'INT':: diff --git a/mpileup.c b/mpileup.c index 75dcba21e..0f868e37a 100644 --- a/mpileup.c +++ b/mpileup.c @@ -652,7 +652,7 @@ static void print_usage(FILE *fp, const mplp_conf_t *mplp) " -Q, --min-BQ INT skip bases with baseQ/BAQ smaller than INT [%d]\n", mplp->min_baseQ); fprintf(fp, " -r, --region REG region in which pileup is generated\n" -" -R, --ignore-RG ignore RG tags (one BAM = one sample)\n" +" --ignore-RG ignore RG tags (one BAM = one sample)\n" " --rf, --incl-flags STR|INT required flags: skip reads with mask bits unset [%s]\n", tmp_require); fprintf(fp, " --ff, --excl-flags STR|INT filter flags: skip reads with mask bits set\n" @@ -717,6 +717,8 @@ int bam_mpileup(int argc, char *argv[]) {"excl-flags", required_argument, NULL, 2}, {"output", required_argument, NULL, 3}, {"open-prob", required_argument, NULL, 4}, + {"ignore-RG", no_argument, NULL, 5}, + {"ignore-rg", no_argument, NULL, 5}, {"illumina1.3+", no_argument, NULL, '6'}, {"count-orphans", no_argument, NULL, 'A'}, {"bam-list", required_argument, NULL, 'b'}, @@ -732,24 +734,13 @@ int bam_mpileup(int argc, char *argv[]) {"exclude-rg", required_argument, NULL, 'G'}, {"positions", required_argument, NULL, 'l'}, {"region", required_argument, NULL, 'r'}, - {"ignore-RG", no_argument, NULL, 'R'}, - {"ignore-rg", no_argument, NULL, 'R'}, {"min-MQ", required_argument, NULL, 'q'}, {"min-mq", required_argument, NULL, 'q'}, {"min-BQ", required_argument, NULL, 'Q'}, {"min-bq", required_argument, NULL, 'Q'}, {"ignore-overlaps", no_argument, NULL, 'x'}, - {"BCF", no_argument, NULL, 'g'}, - {"bcf", no_argument, NULL, 'g'}, - {"VCF", no_argument, NULL, 'v'}, - {"vcf", no_argument, NULL, 'v'}, {"output-type", required_argument, NULL, 'O'}, - {"output-BP", no_argument, NULL, 'O'}, - {"output-bp", no_argument, NULL, 'O'}, - {"output-MQ", no_argument, NULL, 's'}, - {"output-mq", no_argument, NULL, 's'}, {"output-tags", required_argument, NULL, 't'}, - {"uncompressed", no_argument, NULL, 'u'}, {"ext-prob", required_argument, NULL, 'e'}, {"gap-frac", required_argument, NULL, 'F'}, {"tandem-qual", required_argument, NULL, 'h'}, @@ -761,7 +752,7 @@ int bam_mpileup(int argc, char *argv[]) {"platforms", required_argument, NULL, 'P'}, {NULL, 0, NULL, 0} }; - while ((c = getopt_long(argc, argv, "Agf:r:l:q:Q:uRC:BDSd:L:b:P:po:e:h:Im:F:EG:6O:sVvxt:",lopts,NULL)) >= 0) { + while ((c = getopt_long(argc, argv, "Af:r:l:q:Q:C:Bd:L:b:P:po:e:h:Im:F:EG:6O:xt:",lopts,NULL)) >= 0) { switch (c) { case 'x': mplp.flag &= ~MPLP_SMART_OVERLAPS; break; case 1 : @@ -774,6 +765,7 @@ int bam_mpileup(int argc, char *argv[]) break; case 3 : mplp.output_fname = optarg; break; case 4 : mplp.openQ = atoi(optarg); break; + case 5 : mplp.flag |= MPLP_IGNORE_RG; break; case 'f': mplp.fai = fai_load(optarg); if (mplp.fai == NULL) return 1; @@ -790,18 +782,10 @@ int bam_mpileup(int argc, char *argv[]) break; case 'P': mplp.pl_list = strdup(optarg); break; case 'p': mplp.flag |= MPLP_PER_SAMPLE; break; - case 'g': fprintf(stderr,"[warning] bcftools mpileup `-g` is functional, but deprecated. Please swith to -O in future.\n"); mplp.flag |= MPLP_BCF; break; - case 'v': fprintf(stderr,"[warning] bcftools mpileup `-v` is functional, but deprecated. Please swith to -O in future.\n"); mplp.flag |= MPLP_BCF | MPLP_VCF; break; - case 'u': fprintf(stderr,"[warning] bcftools mpileup `-u` is functional, but deprecated. Please swith to -O in future.\n"); mplp.flag |= MPLP_NO_COMP | MPLP_BCF; break; case 'B': mplp.flag &= ~MPLP_REALN; break; - case 'D': mplp.fmt_flag |= B2B_FMT_DP; fprintf(stderr, "[warning] bcftools mpileup option `-D` is functional, but deprecated. Please switch to `-t DP` in future.\n"); break; - case 'S': mplp.fmt_flag |= B2B_FMT_SP; fprintf(stderr, "[warning] bcftools mpileup option `-S` is functional, but deprecated. Please switch to `-t SP` in future.\n"); break; - case 'V': mplp.fmt_flag |= B2B_FMT_DV; fprintf(stderr, "[warning] bcftools mpileup option `-V` is functional, but deprecated. Please switch to `-t DV` in future.\n"); break; case 'I': mplp.flag |= MPLP_NO_INDEL; break; case 'E': mplp.flag |= MPLP_REDO_BAQ; break; case '6': mplp.flag |= MPLP_ILLUMINA13; break; - case 'R': mplp.flag |= MPLP_IGNORE_RG; break; - case 's': error("The -s option is for text based mpileup output. Please use \"samtools mpileup -s\" instead.\n"); break; case 'O': switch (optarg[0]) { case 'b': mplp.output_type = FT_BCF_GZ; break; From d1b8e8865bc8b06259d4a6c8fa4dee8668442b05 Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Thu, 26 May 2016 14:41:51 +0100 Subject: [PATCH 197/211] mpileup: add `--gvcf` output mode This commit brings over the `--gvcf` functionality from @pd3's branch, consisting of relevant bits from pd3/bcftools@cf3219c3237dbd447bfa31be967f1605f531bfd6 and pd3/bcftools@ee8210d2f81af007c6b2ad47d699527c50d0a58e Reference only blocks will be merged into gVCF blocks when the minimum per-sample depth falls in the intervals defined by the argument to the `-gvcf` option. Documentaion added to explain the merging and a test added. --- Makefile | 4 +-- doc/bcftools.txt | 9 ++++++ mpileup.c | 49 ++++++++++++++++++++++++++-- test/mpileup/mpileup.6.out | 65 ++++++++++++++++++++++++++++++++++++++ test/test.pl | 1 + 5 files changed, 123 insertions(+), 5 deletions(-) create mode 100644 test/mpileup/mpileup.6.out diff --git a/Makefile b/Makefile index 64f564fe6..ab12a7c87 100644 --- a/Makefile +++ b/Makefile @@ -168,7 +168,7 @@ convert.o: convert.c $(htslib_vcf_h) $(htslib_synced_bcf_reader_h) $(htslib_vcfu tsv2vcf.o: tsv2vcf.c $(tsv2vcf_h) em.o: em.c $(htslib_vcf_h) kmin.h $(call_h) filter.o: filter.c $(HTSDIR)/htslib/khash_str2int.h $(filter_h) $(bcftools_h) $(htslib_hts_defs_h) $(htslib_vcfutils_h) -gvcf.o: gvcf.c $(call_h) +gvcf.o: gvcf.c gvcf.h $(call_h) kmin.o: kmin.c kmin.h mcall.o: mcall.c $(HTSDIR)/htslib/kfunc.h $(call_h) prob1.o: prob1.c $(prob1_h) @@ -177,7 +177,7 @@ ploidy.o: ploidy.c $(htslib_regidx_h) $(HTSDIR)/htslib/khash_str2int.h $(HTSDIR) polysomy.o: polysomy.c $(htslib_vcf_h) $(htslib_synced_bcf_reader_h) $(bcftools_h) peakfit.h peakfit.o: peakfit.c peakfit.h $(htslib_hts_h) $(HTSDIR)/htslib/kstring.h consensus.o: consensus.c $(htslib_hts_h) $(HTSDIR)/htslib/kseq.h rbuf.h $(bcftools_h) $(HTSDIR)/htslib/regidx.h -mpileup.o: mpileup.c $(htslib_sam_h) $(htslib_faidx_h) $(htslib_kstring_h) $(htslib_khash_str2int_h) $(htslib_regidx_h) $(bcftools_h) $(bam2bcf_h) $(sample_h) +mpileup.o: mpileup.c $(htslib_sam_h) $(htslib_faidx_h) $(htslib_kstring_h) $(htslib_khash_str2int_h) $(htslib_regidx_h) $(bcftools_h) $(call_h) $(bam2bcf_h) $(sample_h) version.o: version.h version.c test/test-rbuf.o: test/test-rbuf.c rbuf.h diff --git a/doc/bcftools.txt b/doc/bcftools.txt index fc26f6f1c..3edbb4794 100644 --- a/doc/bcftools.txt +++ b/doc/bcftools.txt @@ -1387,6 +1387,15 @@ regions listed in the BED file. ==== Output options +*-g, --gvcf* 'INT'[,...]:: + output gVCF blocks of homozygous REF calls, with depth (DP) ranges + specified by the list of integers. For example, passing '5,15' will + group sites into two types of gVCF blocks, the first with minimum + per-sample DP from the interval [5,15) and the latter with minimum + depth 15 or more. In this example, sites with minimum per-sample + depth less than 5 will be printed as separate records, outside of + gVCF blocks. + *-o, --output* 'FILE':: Write output to 'FILE', rather than the default of standard output. (The same short option is used for both *--open-prob* and *--output*. If *-o*'s diff --git a/mpileup.c b/mpileup.c index 0f868e37a..6dfbc35b4 100644 --- a/mpileup.c +++ b/mpileup.c @@ -42,6 +42,7 @@ DEALINGS IN THE SOFTWARE. */ #include "bcftools.h" #include "bam2bcf.h" #include "sample.h" +#include "gvcf.h" #define MPLP_BCF 1 #define MPLP_VCF (1<<1) @@ -66,6 +67,7 @@ typedef struct { faidx_t *fai; void *rghash; regidx_t *bed; + gvcf_t *gvcf; int argc; char **argv; } mplp_conf_t; @@ -234,6 +236,31 @@ static void group_smpl(mplp_pileup_t *m, bam_sample_t *sm, kstring_t *buf, } } +static void flush_bcf_records(mplp_conf_t *conf, htsFile *fp, bcf_hdr_t *hdr, bcf1_t *rec) +{ + if ( !conf->gvcf ) + { + if ( rec ) bcf_write1(fp, hdr, rec); + return; + } + + if ( !rec ) + { + gvcf_write(conf->gvcf, fp, hdr, NULL, 0); + return; + } + + int is_ref = 0; + if ( rec->n_allele==1 ) is_ref = 1; + else if ( rec->n_allele==2 ) + { + // second allele is mpileup's X, not a variant + if ( rec->d.allele[1][0]=='<' && rec->d.allele[1][1]=='*' && rec->d.allele[1][2]=='>' ) is_ref = 1; + } + rec = gvcf_write(conf->gvcf, fp, hdr, rec, is_ref); + if ( rec ) bcf_write1(fp,hdr,rec); +} + /* * Performs pileup * @param conf configuration for this pileup @@ -419,6 +446,8 @@ static int mpileup(mplp_conf_t *conf, int n, char **fn) bcf_hdr_append(bcf_hdr,"##INFO="); if ( conf->fmt_flag&B2B_INFO_ADR ) bcf_hdr_append(bcf_hdr,"##INFO="); + if ( conf->gvcf ) + gvcf_update_header(conf->gvcf, bcf_hdr); for (i=0; in; i++) bcf_hdr_add_sample(bcf_hdr, sm->smpl[i]); @@ -488,7 +517,7 @@ static int mpileup(mplp_conf_t *conf, int n, char **fn) bcf_call_combine(gplp.n, bcr, bca, ref16, &bc); bcf_clear1(bcf_rec); bcf_call2bcf(&bc, bcf_rec, bcr, conf->fmt_flag, 0, 0); - bcf_write1(bcf_fp, bcf_hdr, bcf_rec); + flush_bcf_records(conf, bcf_fp, bcf_hdr, bcf_rec); // call indels; todo: subsampling with total_depth>max_indel_depth instead of ignoring? if (!(conf->flag&MPLP_NO_INDEL) && total_depth < max_indel_depth && bcf_call_gap_prep(gplp.n, gplp.n_plp, gplp.plp, pos, bca, ref, rghash) >= 0) { @@ -498,10 +527,11 @@ static int mpileup(mplp_conf_t *conf, int n, char **fn) if (bcf_call_combine(gplp.n, bcr, bca, -1, &bc) >= 0) { bcf_clear1(bcf_rec); bcf_call2bcf(&bc, bcf_rec, bcr, conf->fmt_flag, bca, ref); - bcf_write1(bcf_fp, bcf_hdr, bcf_rec); + flush_bcf_records(conf, bcf_fp, bcf_hdr, bcf_rec); } } } + flush_bcf_records(conf, bcf_fp, bcf_hdr, NULL); // clean up free(bc.tmp.s); @@ -518,6 +548,7 @@ static int mpileup(mplp_conf_t *conf, int n, char **fn) free(bc.fmt_arr); free(bcr); } + if ( conf->gvcf ) gvcf_destroy(conf->gvcf); bam_smpl_destroy(sm); free(buf.s); for (i = 0; i < gplp.n; ++i) free(gplp.plp[i]); free(gplp.plp); free(gplp.n_plp); free(gplp.m_plp); @@ -661,6 +692,8 @@ static void print_usage(FILE *fp, const mplp_conf_t *mplp) " -x, --ignore-overlaps disable read-pair overlap detection\n" "\n" "Output options:\n" +" -g, --gvcf INT[,...] group non-variant sites into gVCF blocks according\n" +" to minimum per-sample DP\n" " -o, --output FILE write output to FILE [standard output]\n" " -O, --output-type TYPE 'b' compressed BCF; 'u' uncompressed BCF;\n" " 'z' compressed VCF; 'v' uncompressed VCF [v]\n" @@ -719,6 +752,7 @@ int bam_mpileup(int argc, char *argv[]) {"open-prob", required_argument, NULL, 4}, {"ignore-RG", no_argument, NULL, 5}, {"ignore-rg", no_argument, NULL, 5}, + {"gvcf", required_argument, NULL, 7}, {"illumina1.3+", no_argument, NULL, '6'}, {"count-orphans", no_argument, NULL, 'A'}, {"bam-list", required_argument, NULL, 'b'}, @@ -752,7 +786,7 @@ int bam_mpileup(int argc, char *argv[]) {"platforms", required_argument, NULL, 'P'}, {NULL, 0, NULL, 0} }; - while ((c = getopt_long(argc, argv, "Af:r:l:q:Q:C:Bd:L:b:P:po:e:h:Im:F:EG:6O:xt:",lopts,NULL)) >= 0) { + while ((c = getopt_long(argc, argv, "Ag:f:r:l:q:Q:C:Bd:L:b:P:po:e:h:Im:F:EG:6O:xt:",lopts,NULL)) >= 0) { switch (c) { case 'x': mplp.flag &= ~MPLP_SMART_OVERLAPS; break; case 1 : @@ -766,6 +800,10 @@ int bam_mpileup(int argc, char *argv[]) case 3 : mplp.output_fname = optarg; break; case 4 : mplp.openQ = atoi(optarg); break; case 5 : mplp.flag |= MPLP_IGNORE_RG; break; + case 7 : + mplp.gvcf = gvcf_init(optarg); + if ( !mplp.gvcf ) error("Could not parse: --gvcf %s\n", optarg); + break; case 'f': mplp.fai = fai_load(optarg); if (mplp.fai == NULL) return 1; @@ -831,6 +869,11 @@ int bam_mpileup(int argc, char *argv[]) } } + if ( mplp.gvcf && !(mplp.fmt_flag&B2B_FMT_DP) ) + { + fprintf(stderr,"[warning] The -t DP option is required with --gvcf, switching on.\n"); + mplp.fmt_flag |= B2B_FMT_DP; + } if ( mplp.flag&(MPLP_BCF|MPLP_VCF|MPLP_NO_COMP) ) { if ( mplp.flag&MPLP_VCF ) diff --git a/test/mpileup/mpileup.6.out b/test/mpileup/mpileup.6.out new file mode 100644 index 000000000..511652e48 --- /dev/null +++ b/test/mpileup/mpileup.6.out @@ -0,0 +1,65 @@ +##fileformat=VCFv4.2 +##FILTER= +##contig= +##ALT= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##FORMAT= +##FORMAT= +##FORMAT= +##INFO= +##INFO= +#CHROM POS ID REF ALT QUAL FILTER INFO FORMAT HG00100 HG00101 HG00102 +17 100 . C <*> . . END=117;MinDP=2;QS=3,0 PL:DP 0,24,178:8 0,6,85:2 0,12,118:4 +17 118 . G <*> . . MinDP=1;QS=3,0 PL:DP 0,27,175:9 0,3,60:1 0,21,162:7 +17 119 . G <*> . . END=173;MinDP=2;QS=3,0 PL:DP 0,15,106:5 0,6,73:2 0,12,97:4 +17 174 . G <*> . . END=188;MinDP=1;QS=3,0 PL:DP 0,15,111:5 0,3,27:1 0,15,138:5 +17 189 . C <*> . . END=255;MinDP=2;QS=3,0 PL:DP 0,18,136:6 0,6,45:2 0,9,59:3 +17 256 . A <*> . . END=258;MinDP=5;QS=3,0 PL:DP 0,33,247:11 0,15,110:5 0,18,155:6 +17 259 . C <*> . . MinDP=4;QS=3,0 PL:DP 0,33,255:11 0,12,90:4 0,18,170:6 +17 260 . T <*> . . END=265;MinDP=5;QS=3,0 PL:DP 0,33,254:11 0,15,98:5 0,15,122:5 +17 266 . G <*> . . END=267;MinDP=4;QS=3,0 PL:DP 0,33,254:11 0,12,97:4 0,15,138:5 +17 268 . T <*> . . MinDP=5;QS=3,0 PL:DP 0,33,238:11 0,15,110:5 0,15,156:5 +17 269 . C <*> . . END=270;MinDP=4;QS=3,0 PL:DP 0,36,255:12 0,12,91:4 0,15,143:5 +17 271 . T <*> . . MinDP=5;QS=3,0 PL:DP 0,36,255:12 0,15,113:5 0,15,152:5 +17 272 . C <*> . . END=283;MinDP=4;QS=3,0 PL:DP 0,30,238:10 0,12,95:4 0,12,119:4 +17 284 . T <*> . . END=301;MinDP=5;QS=3,0 PL:DP 0,30,231:10 0,18,119:6 0,15,126:5 +17 302 . T TA 0 . INDEL;IDV=7;IMF=1;DP=25;I16=2,4,8,11,214,7674,793,33369,236,10564,993,55133,109,2229,377,8629;QS=0.511212,2.48879;VDB=0.27613;SGB=-4.22417;MQSB=0.0443614;MQ0F=0 PL:DP:DV 167,0,96:11:6 157,0,9:7:6 201,21,0:7:7 +17 303 . G <*> . . END=354;MinDP=7;QS=3,0 PL:DP 0,27,225:9 0,21,183:7 0,21,185:7 +17 355 . G T,<*> 0 . DP=28;I16=14,13,0,1,1001,37907,41,1681,1442,81174,60,3600,547,12487,25,625;QS=2.875,0.125,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.450096;BQB=1;MQ0F=0 PL:DP:DV 14,0,200,38,203,231:9:1 0,27,222,27,222,222:9:0 0,30,255,30,255,255:10:0 +17 356 . G <*> . . END=374;MinDP=7;QS=3,0 PL:DP 0,27,228:9 0,21,187:7 0,27,251:9 +17 375 . A T,<*> 0 . DP=31;I16=17,13,0,1,1138,43798,14,196,1676,96964,60,3600,547,12177,4,16;QS=2.9661,0.0338983,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.763662;BQB=1;MQ0F=0 PL:DP:DV 0,36,255,36,255,255:12:0 0,24,218,24,218,218:8:0 0,18,255,30,255,255:11:1 +17 376 . G <*> . . END=404;MinDP=5;QS=3,0 PL:DP 0,33,255:11 0,15,131:5 0,30,255:10 +17 405 . T <*> . . END=411;MinDP=3;QS=3,0 PL:DP 0,39,255:13 0,9,103:3 0,30,244:10 +17 412 . C T,<*> 0 . DP=30;I16=17,12,1,0,1094,42458,14,196,1678,98882,60,3600,495,10659,25,625;QS=2.97455,0.0254545,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.991968;BQB=1;MQ0F=0 PL:DP:DV 0,30,255,42,255,255:15:1 0,12,124,12,124,124:4:0 0,33,255,33,255,255:11:0 +17 413 . A <*> . . END=464;MinDP=2;QS=3,0 PL:DP 0,42,255:14 0,6,90:2 0,21,221:7 +17 465 . C <*> . . END=511;MinDP=5;QS=3,0 PL:DP 0,51,255:17 0,15,131:5 0,24,221:8 +17 512 . A C,<*> 0 . DP=33;I16=22,10,0,1,1121,40793,13,169,1866,110210,60,3600,628,14340,9,81;QS=2.97719,0.022807,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.981935;BQB=1;MQ0F=0 PL:DP:DV 0,39,255,51,255,255:18:1 0,21,183,21,183,183:7:0 0,24,231,24,231,231:8:0 +17 513 . A <*> . . MinDP=6;QS=3,0 PL:DP 0,48,255:16 0,18,175:6 0,24,233:8 +17 514 . A T,<*> 0 . DP=32;I16=20,9,0,1,1066,40004,16,256,1686,99410,60,3600,586,13500,11,121;QS=2.97075,0.0292505,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.980594;BQB=1;MQ0F=0 PL:DP:DV 0,31,255,45,255,255:16:1 0,18,171,18,171,171:6:0 0,24,235,24,235,235:8:0 +17 515 . C <*> . . END=522;MinDP=5;QS=3,0 PL:DP 0,42,255:14 0,18,167:6 0,15,170:5 +17 523 . T G,<*> 0 . DP=32;I16=23,8,1,0,1184,45708,15,225,1837,109369,60,3600,626,14446,25,625;QS=2.9794,0.0206044,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.872525;BQB=1;MQ0F=0 PL:DP:DV 0,44,255,57,255,255:20:1 0,21,191,21,191,191:7:0 0,15,166,15,166,166:5:0 +17 524 . T <*> . . END=526;MinDP=4;QS=3,0 PL:DP 0,60,255:20 0,21,185:7 0,12,129:4 +17 527 . A <*> . . END=548;MinDP=5;QS=3,0 PL:DP 0,48,255:16 0,18,169:6 0,15,150:5 +17 549 . T G,<*> 0 . DP=32;I16=22,8,0,1,1101,40987,20,400,1746,103010,60,3600,530,11716,25,625;QS=2.96748,0.0325203,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.632337;BQB=1;MQ0F=0 PL:DP:DV 0,31,255,48,255,255:17:1 0,21,168,21,168,168:7:0 0,21,208,21,208,208:7:0 +17 550 . T <*> . . END=558;MinDP=5;QS=3,0 PL:DP 0,45,255:15 0,15,139:5 0,18,177:6 +17 559 . C A,<*> 0 . DP=27;I16=17,8,0,1,908,33726,14,196,1500,90000,29,841,448,9516,25,625;QS=2.92708,0.0729167,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.90038;BQB=1;MQ0F=0 PL:DP:DV 0,42,255,42,255,255:14:0 0,4,116,15,119,123:6:1 0,18,169,18,169,169:6:0 +17 560 . C <*> . . END=564;MinDP=5;QS=3,0 PL:DP 0,42,255:14 0,15,121:5 0,21,179:7 +17 565 . G <*> . . MinDP=4;QS=3,0 PL:DP 0,45,255:15 0,12,96:4 0,21,154:7 +17 566 . C <*> . . END=573;MinDP=5;QS=3,0 PL:DP 0,45,255:15 0,15,155:5 0,18,167:6 +17 574 . C A,<*> 0 . DP=31;I16=18,11,0,1,1088,41328,15,225,1740,104400,29,841,478,10422,25,625;QS=2.94071,0.0592885,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.929991;BQB=1;MQ0F=0 PL:DP:DV 0,48,255,48,255,255:16:0 0,9,170,21,173,177:8:1 0,18,173,18,173,173:6:0 +17 575 . T <*> . . END=578;MinDP=5;QS=3,0 PL:DP 0,42,255:14 0,21,209:7 0,15,146:5 +17 579 . G <*> . . MinDP=4;QS=3,0 PL:DP 0,48,255:16 0,24,224:8 0,12,145:4 +17 580 . A C,<*> 0 . DP=30;I16=15,14,1,0,1060,39178,16,256,1709,101641,60,3600,510,11078,17,289;QS=2.97338,0.0266223,0;SGB=-0.556633;RPB=1;MQB=1;MQSB=0.946202;BQB=1;MQ0F=0 PL:DP:DV 0,34,255,48,255,255:17:1 0,24,221,24,221,221:8:0 0,15,155,15,155,155:5:0 +17 581 . A <*> . . END=600;MinDP=5;QS=3,0 PL:DP 0,51,255:17 0,18,191:6 0,15,151:5 diff --git a/test/test.pl b/test/test.pl index 466ef0e07..7d4c9ae50 100755 --- a/test/test.pl +++ b/test/test.pl @@ -254,6 +254,7 @@ test_mpileup($opts,in=>[qw(1)],out=>'mpileup/mpileup.3.out',args=>q[-B --ff 0x14 -r17:1050-1060]); # test file converted to vcf from samtools mpileup test suite test_mpileup($opts,in=>[qw(1 2 3)],out=>'mpileup/mpileup.4.out',args=>q[-t DP,DPR,DV,DP4,INFO/DPR,SP -r17:100-600]); #test files from samtools mpileup test suite test_mpileup($opts,in=>[qw(1 2 3)],out=>'mpileup/mpileup.5.out',args=>q[-t DP,AD,ADF,ADR,SP,INFO/AD,INFO/ADF,INFO/ADR -r17:100-600]); +test_mpileup($opts,in=>[qw(1 2 3)],out=>'mpileup/mpileup.6.out',args=>q[-t DP,DV -r17:100-600 --gvcf 0,2,5]); print "\nNumber of tests:\n"; printf " total .. %d\n", $$opts{nok}+$$opts{nfailed}; From 8091e198e1999558caf1921006c0509ec48c17ab Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Fri, 27 May 2016 10:21:34 +0100 Subject: [PATCH 198/211] mpileup: new `-s` and `-S` options to include only selected samples pulling over of pd3/bcftools@cf5c354859cf7af542ba4cb936233a5ef8d2eb88 adding in `-S,--samples-file` option and exiting if no samples are read from the file or list TODO: add exclude logic with `^` prefix as in other bcftools commands removed `config.h` from `sample.c` as leftover this is in samtools, but not bcftools at the moment --- Makefile | 1 + doc/bcftools.txt | 6 +++ mpileup.c | 69 ++++++++++++++++++++++------- sample.c | 89 +++++++++++++++++--------------------- sample.h | 3 +- test/mpileup/mpileup.7.out | 70 ++++++++++++++++++++++++++++++ test/mplp.samples | 2 + test/test.pl | 3 ++ 8 files changed, 178 insertions(+), 65 deletions(-) create mode 100644 test/mpileup/mpileup.7.out create mode 100644 test/mplp.samples diff --git a/Makefile b/Makefile index ab12a7c87..d8e5ed880 100644 --- a/Makefile +++ b/Makefile @@ -178,6 +178,7 @@ polysomy.o: polysomy.c $(htslib_vcf_h) $(htslib_synced_bcf_reader_h) $(bcftools_ peakfit.o: peakfit.c peakfit.h $(htslib_hts_h) $(HTSDIR)/htslib/kstring.h consensus.o: consensus.c $(htslib_hts_h) $(HTSDIR)/htslib/kseq.h rbuf.h $(bcftools_h) $(HTSDIR)/htslib/regidx.h mpileup.o: mpileup.c $(htslib_sam_h) $(htslib_faidx_h) $(htslib_kstring_h) $(htslib_khash_str2int_h) $(htslib_regidx_h) $(bcftools_h) $(call_h) $(bam2bcf_h) $(sample_h) +sample.o: $(sample_h) $(htslib_hts_h) $(HTSDIR)/htslib/khash_str2int.h version.o: version.h version.c test/test-rbuf.o: test/test-rbuf.c rbuf.h diff --git a/doc/bcftools.txt b/doc/bcftools.txt index 3edbb4794..6afea51b8 100644 --- a/doc/bcftools.txt +++ b/doc/bcftools.txt @@ -1381,6 +1381,12 @@ regions listed in the BED file. *--ff, --excl-flags* 'STR'|'INT':: Filter flags: skip reads with mask bits set [UNMAP,SECONDARY,QCFAIL,DUP] +*-s, --samples* 'LIST':: + list of sample names. See *<>* + +*-S, --samples-file* 'FILE':: + file of sample names. See *<>* + *-x, --ignore-overlaps*:: Disable read-pair overlap detection. diff --git a/mpileup.c b/mpileup.c index 6dfbc35b4..93f0092eb 100644 --- a/mpileup.c +++ b/mpileup.c @@ -60,12 +60,12 @@ DEALINGS IN THE SOFTWARE. */ typedef struct { int min_mq, flag, min_baseQ, capQ_thres, max_depth, max_indel_depth, fmt_flag; - int rflag_require, rflag_filter, output_type; + int rflag_require, rflag_filter, output_type, sample_is_file; int openQ, extQ, tandemQ, min_support; // for indels double min_frac; // for indels - char *reg, *pl_list, *fai_fname, *output_fname; + char *reg, *pl_list, *fai_fname, *output_fname, *samples_list; faidx_t *fai; - void *rghash; + void *rghash_exc; regidx_t *bed; gvcf_t *gvcf; int argc; @@ -86,6 +86,7 @@ typedef struct { bam_hdr_t *h; mplp_ref_t *ref; const mplp_conf_t *conf; + void *rghash_inc; // whitelist for readgroups on per-bam basis } mplp_aux_t; typedef struct { @@ -158,6 +159,7 @@ static int mplp_func(void *data, bam1_t *b) int ret, skip = 0, ref_len; do { int has_ref; + skip = 0; ret = ma->iter? sam_itr_next(ma->fp, ma->iter, b) : sam_read1(ma->fp, ma->h, b); if (ret < 0) break; // The 'B' cigar operation is not part of the specification, considering as obsolete. @@ -172,9 +174,16 @@ static int mplp_func(void *data, bam1_t *b) skip = regidx_overlap(ma->conf->bed, ma->h->target_name[b->core.tid],b->core.pos, bam_endpos(b)-1, NULL) ? 0 : 1; if (skip) continue; } - if (ma->conf->rghash) { // exclude read groups + if (ma->rghash_inc) + { + // skip unless read group is listed + uint8_t *rg = bam_aux_get(b, "RG"); + if ( !rg ) { skip = 1; continue; } + if ( !khash_str2int_has_key(ma->rghash_inc, (const char*)(rg+1)) ) { skip = 1; continue; } + } + if (ma->conf->rghash_exc) { // exclude read groups uint8_t *rg = bam_aux_get(b, "RG"); - skip = (rg && khash_str2int_get(ma->conf->rghash, (const char*)(rg+1), NULL)==0); + skip = (rg && khash_str2int_get(ma->conf->rghash_exc, (const char*)(rg+1), NULL)==0); if (skip) continue; } if (ma->conf->flag & MPLP_ILLUMINA13) { @@ -278,7 +287,7 @@ static int mpileup(mplp_conf_t *conf, int n, char **fn) bam_mplp_t iter; bam_hdr_t *h = NULL; /* header of first file in input list */ char *ref; - void *rghash = NULL; + void *rghash_exc = NULL; bcf_callaux_t *bca = NULL; bcf_callret1_t *bcr = NULL; @@ -303,6 +312,24 @@ static int mpileup(mplp_conf_t *conf, int n, char **fn) exit(EXIT_FAILURE); } + void *samples_inc = NULL; + if ( conf->samples_list ) + { + int nsamples = 0; + char **samples = hts_readlist(conf->samples_list, conf->sample_is_file, &nsamples); + if (!samples) { + fprintf(stderr,"[%s] could not read the samples list %s\n", __func__, conf->samples_list); + exit(EXIT_FAILURE); + } + if ( nsamples ) samples_inc = khash_str2int_init(); + for (i=0; iflag&MPLP_IGNORE_RG)? 0 : h_tmp->text); + if ( samples_inc ) data[i]->rghash_inc = khash_str2int_init(); + bam_smpl_add(sm, fn[i], (conf->flag&MPLP_IGNORE_RG)? 0 : h_tmp->text, samples_inc, data[i]->rghash_inc); // Collect read group IDs with PL (platform) listed in pl_list (note: fragile, strstr search) - rghash = bcf_call_add_rg(rghash, h_tmp->text, conf->pl_list); + rghash_exc = bcf_call_add_rg(rghash_exc, h_tmp->text, conf->pl_list); if (conf->reg) { hts_idx_t *idx = sam_index_load(data[i]->fp, fn[i]); if (idx == NULL) { @@ -458,7 +486,6 @@ static int mpileup(mplp_conf_t *conf, int n, char **fn) // Initialise the calling algorithm bca = bcf_call_init(-1., conf->min_baseQ); bcr = (bcf_callret1_t*) calloc(sm->n, sizeof(bcf_callret1_t)); - bca->rghash = rghash; bca->openQ = conf->openQ, bca->extQ = conf->extQ, bca->tandemQ = conf->tandemQ; bca->min_frac = conf->min_frac; bca->min_support = conf->min_support; @@ -519,7 +546,8 @@ static int mpileup(mplp_conf_t *conf, int n, char **fn) bcf_call2bcf(&bc, bcf_rec, bcr, conf->fmt_flag, 0, 0); flush_bcf_records(conf, bcf_fp, bcf_hdr, bcf_rec); // call indels; todo: subsampling with total_depth>max_indel_depth instead of ignoring? - if (!(conf->flag&MPLP_NO_INDEL) && total_depth < max_indel_depth && bcf_call_gap_prep(gplp.n, gplp.n_plp, gplp.plp, pos, bca, ref, rghash) >= 0) + // check me: rghash in bcf_call_gap_prep() should have no effect, reads mplp_func already excludes them + if (!(conf->flag&MPLP_NO_INDEL) && total_depth < max_indel_depth && bcf_call_gap_prep(gplp.n, gplp.n_plp, gplp.plp, pos, bca, ref, NULL) >= 0) { bcf_callaux_clean(bca, &bc); for (i = 0; i < gplp.n; ++i) @@ -552,15 +580,17 @@ static int mpileup(mplp_conf_t *conf, int n, char **fn) bam_smpl_destroy(sm); free(buf.s); for (i = 0; i < gplp.n; ++i) free(gplp.plp[i]); free(gplp.plp); free(gplp.n_plp); free(gplp.m_plp); - bcf_call_del_rghash(rghash); + bcf_call_del_rghash(rghash_exc); bam_mplp_destroy(iter); bam_hdr_destroy(h); for (i = 0; i < n; ++i) { sam_close(data[i]->fp); if (data[i]->iter) hts_itr_destroy(data[i]->iter); + if ( data[i]->rghash_inc ) khash_str2int_destroy_free(data[i]->rghash_inc); free(data[i]); } free(data); free(plp); free(n_plp); + if ( samples_inc ) khash_str2int_destroy_free(samples_inc); free(mp_ref.ref[0]); free(mp_ref.ref[1]); return ret; @@ -689,6 +719,8 @@ static void print_usage(FILE *fp, const mplp_conf_t *mplp) " --ff, --excl-flags STR|INT filter flags: skip reads with mask bits set\n" " [%s]\n", tmp_filter); fprintf(fp, +" -s, --samples LIST comma separated list of samples to include\n" +" -S, --samples-file FILE file of samples to include\n" " -x, --ignore-overlaps disable read-pair overlap detection\n" "\n" "Output options:\n" @@ -774,6 +806,8 @@ int bam_mpileup(int argc, char *argv[]) {"min-bq", required_argument, NULL, 'Q'}, {"ignore-overlaps", no_argument, NULL, 'x'}, {"output-type", required_argument, NULL, 'O'}, + {"samples", required_argument, NULL, 's'}, + {"samples-file", required_argument, NULL, 'S'}, {"output-tags", required_argument, NULL, 't'}, {"ext-prob", required_argument, NULL, 'e'}, {"gap-frac", required_argument, NULL, 'F'}, @@ -786,7 +820,7 @@ int bam_mpileup(int argc, char *argv[]) {"platforms", required_argument, NULL, 'P'}, {NULL, 0, NULL, 0} }; - while ((c = getopt_long(argc, argv, "Ag:f:r:l:q:Q:C:Bd:L:b:P:po:e:h:Im:F:EG:6O:xt:",lopts,NULL)) >= 0) { + while ((c = getopt_long(argc, argv, "Ag:f:r:l:q:Q:C:Bd:L:b:P:po:e:h:Im:F:EG:6O:xt:s:S:",lopts,NULL)) >= 0) { switch (c) { case 'x': mplp.flag &= ~MPLP_SMART_OVERLAPS; break; case 1 : @@ -824,6 +858,11 @@ int bam_mpileup(int argc, char *argv[]) case 'I': mplp.flag |= MPLP_NO_INDEL; break; case 'E': mplp.flag |= MPLP_REDO_BAQ; break; case '6': mplp.flag |= MPLP_ILLUMINA13; break; + case 's': mplp.samples_list = optarg; break; + case 'S': + mplp.samples_list = optarg; + mplp.sample_is_file = 1; + break; case 'O': switch (optarg[0]) { case 'b': mplp.output_type = FT_BCF_GZ; break; @@ -854,11 +893,11 @@ int bam_mpileup(int argc, char *argv[]) case 'G': { FILE *fp_rg; char buf[1024]; - mplp.rghash = khash_str2int_init(); + mplp.rghash_exc = khash_str2int_init(); if ((fp_rg = fopen(optarg, "r")) == NULL) fprintf(stderr, "(%s) Fail to open file %s. Continue anyway.\n", __func__, optarg); while (!feof(fp_rg) && fscanf(fp_rg, "%s", buf) > 0) // this is not a good style, but forgive me... - khash_str2int_inc(mplp.rghash, strdup(buf)); + khash_str2int_inc(mplp.rghash_exc, strdup(buf)); fclose(fp_rg); } break; @@ -907,7 +946,7 @@ int bam_mpileup(int argc, char *argv[]) } else ret = mpileup(&mplp, argc - optind, argv + optind); - if (mplp.rghash) khash_str2int_destroy_free(mplp.rghash); + if (mplp.rghash_exc) khash_str2int_destroy_free(mplp.rghash_exc); free(mplp.reg); free(mplp.pl_list); if (mplp.fai) fai_destroy(mplp.fai); if (mplp.bed) regidx_destroy(mplp.bed); diff --git a/sample.c b/sample.c index e48cf3a39..06777ee45 100644 --- a/sample.c +++ b/sample.c @@ -1,7 +1,7 @@ /* sample.c -- group data by sample. Copyright (C) 2010, 2011 Broad Institute. - Copyright (C) 2013 Genome Research Ltd. + Copyright (C) 2013, 2016 Genome Research Ltd. Author: Heng Li @@ -23,67 +23,53 @@ LIABILITY, WHETHER IN AN ACTION OF CONTRACT, TORT OR OTHERWISE, ARISING FROM, OUT OF OR IN CONNECTION WITH THE SOFTWARE OR THE USE OR OTHER DEALINGS IN THE SOFTWARE. */ -#include - #include #include +#include +#include #include "sample.h" -#include "htslib/khash.h" -KHASH_MAP_INIT_STR(sm, int) bam_sample_t *bam_smpl_init(void) { bam_sample_t *s; s = (bam_sample_t*) calloc(1, sizeof(bam_sample_t)); - s->rg2smid = kh_init(sm); - s->sm2id = kh_init(sm); + s->rg2smid = khash_str2int_init(); + s->sm2id = khash_str2int_init(); return s; } void bam_smpl_destroy(bam_sample_t *sm) { - int i; - khint_t k; - khash_t(sm) *rg2smid = (khash_t(sm)*)sm->rg2smid; - if (sm == 0) return; - for (i = 0; i < sm->n; ++i) free(sm->smpl[i]); + if ( !sm ) return; + if ( sm->rg2smid ) khash_str2int_destroy_free(sm->rg2smid); + if ( sm->sm2id ) khash_str2int_destroy_free(sm->sm2id); free(sm->smpl); - for (k = kh_begin(rg2smid); k != kh_end(rg2smid); ++k) - if (kh_exist(rg2smid, k)) free((char*)kh_key(rg2smid, k)); - kh_destroy(sm, (khash_t(sm)*) sm->rg2smid); - kh_destroy(sm, (khash_t(sm)*) sm->sm2id); free(sm); } -static void add_pair(bam_sample_t *sm, khash_t(sm) *sm2id, const char *key, const char *val) +static void add_pair(bam_sample_t *sm, void *sm2id, const char *readgroup, const char *sample) { - khint_t k_rg, k_sm; - int ret; - khash_t(sm) *rg2smid = (khash_t(sm)*)sm->rg2smid; - k_rg = kh_get(sm, rg2smid, key); - if (k_rg != kh_end(rg2smid)) return; // duplicated @RG-ID - k_rg = kh_put(sm, rg2smid, strdup(key), &ret); - k_sm = kh_get(sm, sm2id, val); - if (k_sm == kh_end(sm2id)) { // absent - if (sm->n == sm->m) { - sm->m = sm->m? sm->m<<1 : 1; - sm->smpl = (char**) realloc(sm->smpl, sizeof(char*) * sm->m); - } - sm->smpl[sm->n] = strdup(val); - k_sm = kh_put(sm, sm2id, sm->smpl[sm->n], &ret); - kh_val(sm2id, k_sm) = sm->n++; + if ( khash_str2int_has_key(sm->rg2smid,readgroup) ) return; // duplicated @RG-ID + + int ismpl; + if ( khash_str2int_get(sm2id, sample, &ismpl) < 0 ) + { + // the sample encountered for the first time + ismpl = sm->n++; + hts_expand0(char*,sm->n,sm->m,sm->smpl); + sm->smpl[ismpl] = strdup(sample); + khash_str2int_set(sm2id, sm->smpl[ismpl], ismpl); } - kh_val(rg2smid, k_rg) = kh_val(sm2id, k_sm); + khash_str2int_set(sm->rg2smid, strdup(readgroup), ismpl); } -int bam_smpl_add(bam_sample_t *sm, const char *fn, const char *txt) +int bam_smpl_add(bam_sample_t *sm, const char *fn, const char *txt, void *white_list, void *white_hash) { const char *p = txt, *q, *r; kstring_t buf, first_sm; int n = 0; - khash_t(sm) *sm2id = (khash_t(sm)*)sm->sm2id; if (txt == 0) { - add_pair(sm, sm2id, fn, fn); + add_pair(sm, sm->sm2id, fn, fn); return 0; } memset(&buf, 0, sizeof(kstring_t)); @@ -99,36 +85,41 @@ int bam_smpl_add(bam_sample_t *sm, const char *fn, const char *txt) for (u = (char*)q; *u && *u != '\t' && *u != '\n'; ++u); for (v = (char*)r; *v && *v != '\t' && *v != '\n'; ++v); ioq = *u; ior = *v; *u = *v = '\0'; - buf.l = 0; kputs(fn, &buf); kputc('/', &buf); kputs(q, &buf); - add_pair(sm, sm2id, buf.s, r); - if ( !first_sm.s ) - kputs(r,&first_sm); + if ( !white_list || khash_str2int_has_key(white_list,r) ) + { + buf.l = 0; kputs(fn, &buf); kputc('/', &buf); kputs(q, &buf); + add_pair(sm, sm->sm2id, buf.s, r); + if ( !first_sm.s ) + kputs(r,&first_sm); + if ( white_list ) khash_str2int_inc(white_hash,strdup(q)); + } *u = ioq; *v = ior; } else break; p = q > r? q : r; ++n; } - if (n == 0) add_pair(sm, sm2id, fn, fn); + if (n == 0) add_pair(sm, sm->sm2id, fn, fn); // If there is only one RG tag present in the header and reads are not annotated, don't refuse to work but // use the tag instead. else if ( n==1 && first_sm.s ) - add_pair(sm,sm2id,fn,first_sm.s); + add_pair(sm,sm->sm2id,fn,first_sm.s); if ( first_sm.s ) free(first_sm.s); -// add_pair(sm, sm2id, fn, fn); free(buf.s); return 0; } int bam_smpl_rg2smid(const bam_sample_t *sm, const char *fn, const char *rg, kstring_t *str) { - khint_t k; - khash_t(sm) *rg2smid = (khash_t(sm)*)sm->rg2smid; - if (rg) { + int ismpl; + if ( rg ) + { str->l = 0; kputs(fn, str); kputc('/', str); kputs(rg, str); - k = kh_get(sm, rg2smid, str->s); - } else k = kh_get(sm, rg2smid, fn); - return k == kh_end(rg2smid)? -1 : kh_val(rg2smid, k); + if ( khash_str2int_get(sm->rg2smid, str->s, &ismpl) < 0 ) return -1; + return ismpl; + } + if ( khash_str2int_get(sm->rg2smid, fn, &ismpl) < 0 ) return -1; + return ismpl; } diff --git a/sample.h b/sample.h index 8e8efa5b7..f777a81f5 100644 --- a/sample.h +++ b/sample.h @@ -1,6 +1,7 @@ /* sample.h -- group data by sample. Copyright (C) 2010 Broad Institute. + Copyright (C) 2016 Genome Research Ltd. Author: Heng Li @@ -34,7 +35,7 @@ typedef struct { } bam_sample_t; bam_sample_t *bam_smpl_init(void); -int bam_smpl_add(bam_sample_t *sm, const char *abs, const char *txt); +int bam_smpl_add(bam_sample_t *sm, const char *abs, const char *txt, void *white_list, void *white_hash); int bam_smpl_rg2smid(const bam_sample_t *sm, const char *fn, const char *rg, kstring_t *str); void bam_smpl_destroy(bam_sample_t *sm); diff --git a/test/mpileup/mpileup.7.out b/test/mpileup/mpileup.7.out new file mode 100644 index 000000000..75e7fc96a --- /dev/null +++ b/test/mpileup/mpileup.7.out @@ -0,0 +1,70 @@ +##fileformat=VCFv4.2 +##FILTER= +##contig= +##ALT= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##FORMAT= +#CHROM POS ID REF ALT QUAL FILTER INFO FORMAT HG00101 HG00102 +17 100 . C <*> 0 . DP=9;I16=8,0,0,0,338,15668,0,0,449,26041,0,0,173,4019,0,0;QS=2,0;MQ0F=0 PL 0,9,108 0,15,134 +17 101 . C <*> 0 . DP=9;I16=8,0,0,0,319,14829,0,0,449,26041,0,0,172,3954,0,0;QS=2,0;MQ0F=0 PL 0,9,99 0,15,132 +17 102 . C <*> 0 . DP=9;I16=8,0,0,0,346,16476,0,0,449,26041,0,0,171,3895,0,0;QS=2,0;MQ0F=0 PL 0,9,111 0,15,139 +17 103 . T <*> 0 . DP=9;I16=8,0,0,0,354,17694,0,0,449,26041,0,0,170,3842,0,0;QS=2,0;MQ0F=0 PL 0,9,108 0,15,147 +17 104 . G <*> 0 . DP=9;I16=7,0,0,0,301,14499,0,0,420,25200,0,0,143,3121,0,0;QS=2,0;MQ0F=0 PL 0,6,89 0,15,133 +17 105 . G <*> 0 . DP=9;I16=8,0,0,0,298,12944,0,0,449,26041,0,0,166,3658,0,0;QS=2,0;MQ0F=0 PL 0,9,97 0,15,125 +17 106 . G <*> 0 . DP=9;I16=7,0,0,0,273,12195,0,0,420,25200,0,0,139,2953,0,0;QS=2,0;MQ0F=0 PL 0,6,85 0,15,124 +17 107 . C <*> 0 . DP=9;I16=8,0,0,0,330,15206,0,0,449,26041,0,0,162,3506,0,0;QS=2,0;MQ0F=0 PL 0,9,108 0,15,136 +17 108 . C <*> 0 . DP=9;I16=8,0,0,0,334,15764,0,0,449,26041,0,0,159,3393,0,0;QS=2,0;MQ0F=0 PL 0,9,108 0,15,135 +17 109 . T <*> 0 . DP=9;I16=8,0,0,0,374,19190,0,0,449,26041,0,0,156,3290,0,0;QS=2,0;MQ0F=0 PL 0,9,110 0,15,150 +17 110 . G <*> 0 . DP=9;I16=8,0,0,0,335,16083,0,0,449,26041,0,0,153,3197,0,0;QS=2,0;MQ0F=0 PL 0,9,104 0,15,136 +17 111 . G <*> 0 . DP=9;I16=6,0,0,0,268,13602,0,0,360,21600,0,0,107,2151,0,0;QS=2,0;MQ0F=0 PL 0,6,88 0,12,118 +17 112 . C <*> 0 . DP=9;I16=8,0,0,0,318,15164,0,0,449,26041,0,0,145,2945,0,0;QS=2,0;MQ0F=0 PL 0,9,95 0,15,135 +17 113 . A <*> 0 . DP=9;I16=7,0,0,0,311,15545,0,0,420,25200,0,0,116,2212,0,0;QS=2,0;MQ0F=0 PL 0,6,87 0,15,139 +17 114 . C <*> 0 . DP=9;I16=8,0,0,0,327,15347,0,0,449,26041,0,0,137,2741,0,0;QS=2,0;MQ0F=0 PL 0,9,103 0,15,133 +17 115 . C <*> 0 . DP=11;I16=8,0,0,0,341,16381,0,0,480,28800,0,0,108,2032,0,0;QS=2,0;MQ0F=0 PL 0,6,89 0,18,147 +17 116 . A <*> 0 . DP=11;I16=8,1,0,0,376,18032,0,0,509,29641,0,0,107,1965,0,0;QS=2,0;MQSB=1;MQ0F=0 PL 0,6,90 0,21,175 +17 117 . G <*> 0 . DP=11;I16=8,1,0,0,370,17312,0,0,509,29641,0,0,105,1913,0,0;QS=2,0;MQSB=1;MQ0F=0 PL 0,6,85 0,21,177 +17 118 . G <*> 0 . DP=11;I16=7,1,0,0,319,14789,0,0,449,26041,0,0,102,1876,0,0;QS=2,0;MQSB=1;MQ0F=0 PL 0,3,60 0,21,162 +17 119 . G <*> 0 . DP=10;I16=8,1,0,0,321,14467,0,0,478,26882,0,0,125,2431,0,0;QS=2,0;MQSB=1;MQ0F=0 PL 0,6,73 0,21,160 +17 120 . A <*> 0 . DP=10;I16=8,1,0,0,361,17053,0,0,478,26882,0,0,123,2373,0,0;QS=2,0;MQSB=1;MQ0F=0 PL 0,6,83 0,21,171 +17 121 . G <*> 0 . DP=10;I16=8,1,0,0,347,15913,0,0,478,26882,0,0,121,2327,0,0;QS=2,0;MQSB=1;MQ0F=0 PL 0,6,80 0,21,168 +17 122 . C <*> 0 . DP=11;I16=9,1,0,0,396,18360,0,0,538,30482,0,0,119,2293,0,0;QS=2,0;MQSB=1;MQ0F=0 PL 0,9,99 0,21,178 +17 123 . T <*> 0 . DP=10;I16=8,1,0,0,387,19215,0,0,478,26882,0,0,119,2271,0,0;QS=2,0;MQSB=1;MQ0F=0 PL 0,9,112 0,18,166 +17 124 . T <*> 0 . DP=10;I16=8,1,0,0,350,15768,0,0,478,26882,0,0,119,2261,0,0;QS=2,0;MQSB=1;MQ0F=0 PL 0,9,104 0,18,154 +17 125 . A <*> 0 . DP=10;I16=8,1,0,0,358,16494,0,0,478,26882,0,0,118,2214,0,0;QS=2,0;MQSB=1;MQ0F=0 PL 0,9,104 0,18,162 +17 126 . A <*> 0 . DP=10;I16=8,1,0,0,373,17399,0,0,478,26882,0,0,117,2181,0,0;QS=2,0;MQSB=1;MQ0F=0 PL 0,9,107 0,18,174 +17 127 . C <*> 0 . DP=10;I16=8,1,0,0,366,16632,0,0,478,26882,0,0,116,2162,0,0;QS=2,0;MQSB=1;MQ0F=0 PL 0,9,109 0,18,160 +17 128 . A <*> 0 . DP=10;I16=8,1,0,0,378,17674,0,0,478,26882,0,0,115,2157,0,0;QS=2,0;MQSB=1;MQ0F=0 PL 0,9,111 0,18,162 +17 129 . A <*> 0 . DP=9;I16=7,1,0,0,354,17046,0,0,418,23282,0,0,115,2165,0,0;QS=2,0;MQSB=1;MQ0F=0 PL 0,9,113 0,15,159 +17 130 . A <*> 0 . DP=9;I16=7,1,0,0,349,16363,0,0,418,23282,0,0,115,2185,0,0;QS=2,0;MQSB=1;MQ0F=0 PL 0,9,113 0,15,152 +17 131 . C <*> 0 . DP=9;I16=7,1,0,0,330,14822,0,0,418,23282,0,0,115,2217,0,0;QS=2,0;MQSB=1;MQ0F=0 PL 0,9,110 0,15,147 +17 132 . A <*> 0 . DP=9;I16=7,1,0,0,348,16432,0,0,418,23282,0,0,115,2261,0,0;QS=2,0;MQSB=1;MQ0F=0 PL 0,9,110 0,15,151 +17 133 . T <*> 0 . DP=8;I16=6,2,0,0,315,12451,0,0,418,23282,0,0,141,2941,0,0;QS=2,0;MQSB=0.666667;MQ0F=0 PL 0,9,105 0,15,150 +17 134 . C <*> 0 . DP=8;I16=6,2,0,0,314,12374,0,0,418,23282,0,0,142,3006,0,0;QS=2,0;MQSB=0.666667;MQ0F=0 PL 0,9,105 0,15,152 +17 135 . T <*> 0 . DP=8;I16=6,2,0,0,314,12470,0,0,418,23282,0,0,143,3081,0,0;QS=2,0;MQSB=0.666667;MQ0F=0 PL 0,9,106 0,15,156 +17 136 . G <*> 0 . DP=8;I16=6,2,0,0,291,10787,0,0,418,23282,0,0,145,3165,0,0;QS=2,0;MQSB=0.666667;MQ0F=0 PL 0,9,105 0,15,134 +17 137 . T <*> 0 . DP=8;I16=6,2,0,0,300,11444,0,0,418,23282,0,0,148,3258,0,0;QS=2,0;MQSB=0.666667;MQ0F=0 PL 0,9,104 0,15,139 +17 138 . C <*> 0 . DP=8;I16=6,2,0,0,300,11542,0,0,418,23282,0,0,150,3312,0,0;QS=2,0;MQSB=0.666667;MQ0F=0 PL 0,9,108 0,15,142 +17 139 . C <*> 0 . DP=8;I16=6,2,0,0,291,10833,0,0,418,23282,0,0,152,3378,0,0;QS=2,0;MQSB=0.666667;MQ0F=0 PL 0,9,106 0,15,143 +17 140 . A <*> 0 . DP=8;I16=6,2,0,0,314,12410,0,0,418,23282,0,0,153,3405,0,0;QS=2,0;MQSB=0.666667;MQ0F=0 PL 0,9,107 0,15,153 +17 141 . G <*> 0 . DP=8;I16=6,2,0,0,295,11151,0,0,418,23282,0,0,153,3391,0,0;QS=2,0;MQSB=0.666667;MQ0F=0 PL 0,9,108 0,15,142 +17 142 . C <*> 0 . DP=8;I16=6,2,0,0,264,9036,0,0,418,23282,0,0,153,3385,0,0;QS=2,0;MQSB=0.666667;MQ0F=0 PL 0,9,97 0,15,129 +17 143 . G <*> 0 . DP=8;I16=5,2,0,0,218,7170,0,0,358,19682,0,0,146,3338,0,0;QS=2,0;MQSB=0.7;MQ0F=0 PL 0,9,95 0,12,97 +17 144 . A <*> 0 . DP=8;I16=6,2,0,0,287,10705,0,0,418,23282,0,0,153,3397,0,0;QS=2,0;MQSB=0.666667;MQ0F=0 PL 0,9,105 0,15,129 +17 145 . A <*> 0 . DP=8;I16=6,2,0,0,294,11200,0,0,418,23282,0,0,153,3415,0,0;QS=2,0;MQSB=0.666667;MQ0F=0 PL 0,9,106 0,15,138 +17 146 . T <*> 0 . DP=8;I16=6,2,0,0,281,10419,0,0,418,23282,0,0,153,3441,0,0;QS=2,0;MQSB=0.666667;MQ0F=0 PL 0,9,103 0,15,128 +17 147 . A <*> 0 . DP=8;I16=6,2,0,0,286,10442,0,0,418,23282,0,0,153,3475,0,0;QS=2,0;MQSB=0.666667;MQ0F=0 PL 0,9,99 0,15,140 +17 148 . C <*> 0 . DP=8;I16=6,2,0,0,301,11401,0,0,418,23282,0,0,152,3466,0,0;QS=2,0;MQSB=0.666667;MQ0F=0 PL 0,9,106 0,15,146 +17 149 . C <*> 0 . DP=8;I16=6,2,0,0,293,10907,0,0,418,23282,0,0,150,3414,0,0;QS=2,0;MQSB=0.666667;MQ0F=0 PL 0,9,109 0,15,140 +17 150 . T <*> 0 . DP=7;I16=5,2,0,0,277,11093,0,0,389,22441,0,0,149,3369,0,0;QS=2,0;MQSB=0.5;MQ0F=0 PL 0,6,84 0,15,152 diff --git a/test/mplp.samples b/test/mplp.samples new file mode 100644 index 000000000..1a9b396e6 --- /dev/null +++ b/test/mplp.samples @@ -0,0 +1,2 @@ +HG00101 +HG00102 diff --git a/test/test.pl b/test/test.pl index 7d4c9ae50..84b38a40c 100755 --- a/test/test.pl +++ b/test/test.pl @@ -255,6 +255,8 @@ test_mpileup($opts,in=>[qw(1 2 3)],out=>'mpileup/mpileup.4.out',args=>q[-t DP,DPR,DV,DP4,INFO/DPR,SP -r17:100-600]); #test files from samtools mpileup test suite test_mpileup($opts,in=>[qw(1 2 3)],out=>'mpileup/mpileup.5.out',args=>q[-t DP,AD,ADF,ADR,SP,INFO/AD,INFO/ADF,INFO/ADR -r17:100-600]); test_mpileup($opts,in=>[qw(1 2 3)],out=>'mpileup/mpileup.6.out',args=>q[-t DP,DV -r17:100-600 --gvcf 0,2,5]); +test_mpileup($opts,in=>[qw(1 2 3)],out=>'mpileup/mpileup.7.out',args=>q[-r17:100-150 -s HG00101,HG00102]); +test_mpileup($opts,in=>[qw(1 2 3)],out=>'mpileup/mpileup.7.out',args=>q[-r17:100-150 -S {PATH}/mplp.samples]); print "\nNumber of tests:\n"; printf " total .. %d\n", $$opts{nok}+$$opts{nfailed}; @@ -932,6 +934,7 @@ sub test_mpileup { my ($opts,%args) = @_; + $args{args} =~ s/{PATH}/$$opts{path}/g; for my $fmt ('bam','cram') { my @files = (); From d2f30681b5ed24dece42b09c9cb7a3b46bda4d1a Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Tue, 31 May 2016 14:42:37 +0100 Subject: [PATCH 199/211] mpileup: switch `--output-tags` option to `--annotate` switch `-t/--output-tags` option to `-a/--annotate` to make room for the `-t/--targets` option available annotations are now listed on request with `-a ?` rather than cluttering up the help output. --- doc/bcftools.txt | 48 +++++++++++++++++++++--------------------- mpileup.c | 54 +++++++++++++++++++++++++++++++++++------------- test/test.pl | 8 +++---- 3 files changed, 69 insertions(+), 41 deletions(-) diff --git a/doc/bcftools.txt b/doc/bcftools.txt index 6afea51b8..35949ec97 100644 --- a/doc/bcftools.txt +++ b/doc/bcftools.txt @@ -1393,6 +1393,31 @@ regions listed in the BED file. ==== Output options +*-a, --annotate* 'LIST':: + Comma-separated list of FORMAT and INFO tags to output. (case-insensitive, + the "FORMAT/" prefix is optional, and use "?" to list available annotations + on the command line) [null]: + + *FORMAT/AD* .. Allelic depth (Number=R,Type=Integer) + *FORMAT/ADF* .. Allelic depths on the forward strand (Number=R,Type=Integer) + *FORMAT/ADR* .. Allelic depths on the reverse strand (Number=R,Type=Integer) + *FORMAT/DP* .. Number of high-quality bases (Number=1,Type=Integer) + *FORMAT/SP* .. Phred-scaled strand bias P-value (Number=1,Type=Integer) + + *INFO/AD* .. Total allelic depth (Number=R,Type=Integer) + *INFO/ADF* .. Total allelic depths on the forward strand (Number=R,Type=Integer) + *INFO/ADR* .. Total allelic depths on the reverse strand (Number=R,Type=Integer) + + *FORMAT/DV* .. Deprecated in favor of FORMAT/AD; + Number of high-quality non-reference bases, (Number=1,Type=Integer) + *FORMAT/DP4* .. Deprecated in favor of FORMAT/ADF and FORMAT/ADR; + Number of high-quality ref-forward, ref-reverse, + alt-forward and alt-reverse bases (Number=4,Type=Integer) + *FORMAT/DPR* .. Deprecated in favor of FORMAT/AD; + Number of high-quality bases for each observed allele (Number=R,Type=Integer) + *INFO/DPR* .. Deprecated in favor of INFO/AD; + Number of high-quality bases for each observed allele (Number=R,Type=Integer) + *-g, --gvcf* 'INT'[,...]:: output gVCF blocks of homozygous REF calls, with depth (DP) ranges specified by the list of integers. For example, passing '5,15' will @@ -1413,29 +1438,6 @@ regions listed in the BED file. *-O, --output-type* 'b'|'u'|'z'|'v':: see *<>* -*-t, --output-tags* 'LIST':: - Comma-separated list of FORMAT and INFO tags to output (case-insensitive) [null]: - - - *AD* .. Allelic depth, FORMAT - - *INFO/AD* .. Total allelic depth, INFO - - *ADF* .. Allelic depths on the forward strand, FORMAT - - *INFO/ADF* .. Total allelic depths on the forward strand, INFO - - *ADR* .. Allelic depths on the reverse strand, FORMAT - - *INFO/ADR* .. Total allelic depths on the reverse strand, INFO - - *DP* .. Number of high-quality bases, FORMAT - - *SP* .. Phred-scaled strand bias P-value, FORMAT - - - *DV* .. Deprecated in favor of AD; - Number of high-quality non-reference bases, FORMAT - - *DPR* .. Deprecated in favor of AD; - Number of high-quality bases for each observed allele, FORMAT - - *INFO/DPR* .. Deprecated in favor of INFO/AD; - Number of high-quality bases for each observed allele, INFO - - *DP4* .. Deprecated in favor of ADF and ADR; - Number of high-quality ref-forward, ref-reverse, - alt-forward and alt-reverse bases, FORMAT - - ==== Options for SNP/INDEL genotype likelihood computation *-e, --ext-prob* 'INT':: diff --git a/mpileup.c b/mpileup.c index 93f0092eb..b2d5d449b 100644 --- a/mpileup.c +++ b/mpileup.c @@ -660,15 +660,15 @@ int parse_format_flag(const char *str) char **tags = hts_readlist(str, 0, &n_tags); for(i=0; irflag_require); @@ -724,13 +744,12 @@ static void print_usage(FILE *fp, const mplp_conf_t *mplp) " -x, --ignore-overlaps disable read-pair overlap detection\n" "\n" "Output options:\n" +" -a, --annotate LIST optional tags to output; '?' to list []\n" " -g, --gvcf INT[,...] group non-variant sites into gVCF blocks according\n" " to minimum per-sample DP\n" " -o, --output FILE write output to FILE [standard output]\n" " -O, --output-type TYPE 'b' compressed BCF; 'u' uncompressed BCF;\n" " 'z' compressed VCF; 'v' uncompressed VCF [v]\n" -" -t, --output-tags LIST optional tags to output:\n" -" DP,AD,ADF,ADR,SP,INFO/AD,INFO/ADF,INFO/ADR []\n" "\n" "SNP/INDEL genotype likelihoods options:\n" " -e, --ext-prob INT Phred-scaled gap extension seq error probability [%d]\n", mplp->extQ); @@ -749,7 +768,8 @@ static void print_usage(FILE *fp, const mplp_conf_t *mplp) " -p, --per-sample-mF apply -m and -F per-sample for increased sensitivity\n" " -P, --platforms STR comma separated list of platforms for indels [all]\n" "\n" -"Notes: Assuming diploid individuals.\n"); +"Notes: Assuming diploid individuals.\n" +"\n"); free(tmp_require); free(tmp_filter); @@ -808,7 +828,7 @@ int bam_mpileup(int argc, char *argv[]) {"output-type", required_argument, NULL, 'O'}, {"samples", required_argument, NULL, 's'}, {"samples-file", required_argument, NULL, 'S'}, - {"output-tags", required_argument, NULL, 't'}, + {"annotate", required_argument, NULL, 'a'}, {"ext-prob", required_argument, NULL, 'e'}, {"gap-frac", required_argument, NULL, 'F'}, {"tandem-qual", required_argument, NULL, 'h'}, @@ -820,7 +840,7 @@ int bam_mpileup(int argc, char *argv[]) {"platforms", required_argument, NULL, 'P'}, {NULL, 0, NULL, 0} }; - while ((c = getopt_long(argc, argv, "Ag:f:r:l:q:Q:C:Bd:L:b:P:po:e:h:Im:F:EG:6O:xt:s:S:",lopts,NULL)) >= 0) { + while ((c = getopt_long(argc, argv, "Ag:f:r:l:q:Q:C:Bd:L:b:P:po:e:h:Im:F:EG:6O:xa:s:S:",lopts,NULL)) >= 0) { switch (c) { case 'x': mplp.flag &= ~MPLP_SMART_OVERLAPS; break; case 1 : @@ -901,7 +921,13 @@ int bam_mpileup(int argc, char *argv[]) fclose(fp_rg); } break; - case 't': mplp.fmt_flag |= parse_format_flag(optarg); break; + case 'a': + if (optarg[0]=='?') { + list_annotations(stderr); + return 1; + } + mplp.fmt_flag |= parse_format_flag(optarg); + break; default: fprintf(stderr,"Invalid option: '%c'\n", c); return 1; diff --git a/test/test.pl b/test/test.pl index 84b38a40c..f34d563f1 100755 --- a/test/test.pl +++ b/test/test.pl @@ -250,11 +250,11 @@ test_vcf_consensus($opts,in=>'consensus2',out=>'consensus2.2.out',fa=>'consensus2.fa',args=>'-H 2'); test_vcf_consensus($opts,in=>'empty',out=>'consensus.5.out',fa=>'consensus.fa',args=>''); test_mpileup($opts,in=>[qw(1 2 3)],out=>'mpileup/mpileup.1.out',args=>q[-r17:100-150]); -test_mpileup($opts,in=>[qw(1 2 3)],out=>'mpileup/mpileup.2.out',args=>q[-t DP,DV -r17:100-600]); # test files from samtools mpileup test suite +test_mpileup($opts,in=>[qw(1 2 3)],out=>'mpileup/mpileup.2.out',args=>q[-a DP,DV -r17:100-600]); # test files from samtools mpileup test suite test_mpileup($opts,in=>[qw(1)],out=>'mpileup/mpileup.3.out',args=>q[-B --ff 0x14 -r17:1050-1060]); # test file converted to vcf from samtools mpileup test suite -test_mpileup($opts,in=>[qw(1 2 3)],out=>'mpileup/mpileup.4.out',args=>q[-t DP,DPR,DV,DP4,INFO/DPR,SP -r17:100-600]); #test files from samtools mpileup test suite -test_mpileup($opts,in=>[qw(1 2 3)],out=>'mpileup/mpileup.5.out',args=>q[-t DP,AD,ADF,ADR,SP,INFO/AD,INFO/ADF,INFO/ADR -r17:100-600]); -test_mpileup($opts,in=>[qw(1 2 3)],out=>'mpileup/mpileup.6.out',args=>q[-t DP,DV -r17:100-600 --gvcf 0,2,5]); +test_mpileup($opts,in=>[qw(1 2 3)],out=>'mpileup/mpileup.4.out',args=>q[-a DP,DPR,DV,DP4,INFO/DPR,SP -r17:100-600]); #test files from samtools mpileup test suite +test_mpileup($opts,in=>[qw(1 2 3)],out=>'mpileup/mpileup.5.out',args=>q[-a DP,AD,ADF,ADR,SP,INFO/AD,INFO/ADF,INFO/ADR -r17:100-600]); +test_mpileup($opts,in=>[qw(1 2 3)],out=>'mpileup/mpileup.6.out',args=>q[-a DP,DV -r17:100-600 --gvcf 0,2,5]); test_mpileup($opts,in=>[qw(1 2 3)],out=>'mpileup/mpileup.7.out',args=>q[-r17:100-150 -s HG00101,HG00102]); test_mpileup($opts,in=>[qw(1 2 3)],out=>'mpileup/mpileup.7.out',args=>q[-r17:100-150 -S {PATH}/mplp.samples]); From c153e8b8a15aaaaf03c6752d55d8378ff08f358e Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Mon, 13 Jun 2016 16:52:39 +0100 Subject: [PATCH 200/211] regidx: import regidx api from htslib into bcftools This is meant as a temporary change while we extend the regidx api, but allow bcftools code to use these changes before they appear in some form in htslib. This commit does not add new features, just copies over `regidx.[ch]` and rejiggers the linking to use these local bcftools copies. the `*_c` are removed due to relying on `hts_internal.h` (see fc9aeb6f77668afed412119701c5c58b0fca8091) --- Makefile | 6 +- consensus.c | 2 +- ploidy.c | 2 +- ploidy.h | 2 +- regidx.c | 338 ++++++++++++++++++++++++++++++++++++++++++++++++++++ regidx.h | 154 ++++++++++++++++++++++++ 6 files changed, 498 insertions(+), 6 deletions(-) create mode 100644 regidx.c create mode 100644 regidx.h diff --git a/Makefile b/Makefile index d8e5ed880..abae700b7 100644 --- a/Makefile +++ b/Makefile @@ -135,7 +135,7 @@ call_h = call.h $(htslib_vcf_h) $(htslib_synced_bcf_reader_h) vcmp.h convert_h = convert.h $(htslib_vcf_h) tsv2vcf_h = tsv2vcf.h $(htslib_vcf_h) filter_h = filter.h $(htslib_vcf_h) -ploidy_h = ploidy.h $(htslib_regidx_h) +ploidy_h = ploidy.h regidx.h prob1_h = prob1.h $(htslib_vcf_h) $(call_h) roh_h = HMM.h $(htslib_vcf_h) $(htslib_synced_bcf_reader_h) $(HTSDIR)/htslib/kstring.h $(HTSDIR)/htslib/kseq.h $(bcftools_h) cnv_h = HMM.h $(htslib_vcf_h) $(htslib_synced_bcf_reader_h) @@ -173,10 +173,10 @@ kmin.o: kmin.c kmin.h mcall.o: mcall.c $(HTSDIR)/htslib/kfunc.h $(call_h) prob1.o: prob1.c $(prob1_h) vcmp.o: vcmp.c $(htslib_hts_h) vcmp.h -ploidy.o: ploidy.c $(htslib_regidx_h) $(HTSDIR)/htslib/khash_str2int.h $(HTSDIR)/htslib/kseq.h $(htslib_hts_h) $(bcftools_h) $(ploidy_h) +ploidy.o: ploidy.c regidx.h $(HTSDIR)/htslib/khash_str2int.h $(HTSDIR)/htslib/kseq.h $(htslib_hts_h) $(bcftools_h) $(ploidy_h) polysomy.o: polysomy.c $(htslib_vcf_h) $(htslib_synced_bcf_reader_h) $(bcftools_h) peakfit.h peakfit.o: peakfit.c peakfit.h $(htslib_hts_h) $(HTSDIR)/htslib/kstring.h -consensus.o: consensus.c $(htslib_hts_h) $(HTSDIR)/htslib/kseq.h rbuf.h $(bcftools_h) $(HTSDIR)/htslib/regidx.h +consensus.o: consensus.c $(htslib_hts_h) $(HTSDIR)/htslib/kseq.h rbuf.h $(bcftools_h) regidx.h mpileup.o: mpileup.c $(htslib_sam_h) $(htslib_faidx_h) $(htslib_kstring_h) $(htslib_khash_str2int_h) $(htslib_regidx_h) $(bcftools_h) $(call_h) $(bam2bcf_h) $(sample_h) sample.o: $(sample_h) $(htslib_hts_h) $(HTSDIR)/htslib/khash_str2int.h version.o: version.h version.c diff --git a/consensus.c b/consensus.c index 79b4a5f91..5e37b05de 100644 --- a/consensus.c +++ b/consensus.c @@ -35,8 +35,8 @@ #include #include #include -#include #include "bcftools.h" +#include "regidx.h" #include "rbuf.h" typedef struct diff --git a/ploidy.c b/ploidy.c index 719e1753c..6b54850db 100644 --- a/ploidy.c +++ b/ploidy.c @@ -22,11 +22,11 @@ THE SOFTWARE. */ -#include #include #include #include #include "bcftools.h" +#include "regidx.h" #include "ploidy.h" struct _ploidy_t diff --git a/ploidy.h b/ploidy.h index 6deef737f..1e7d2f78f 100644 --- a/ploidy.h +++ b/ploidy.h @@ -55,7 +55,7 @@ #ifndef __PLOIDY_H__ #define __PLOIDY_H__ -#include +#include "regidx.h" typedef struct _ploidy_t ploidy_t; diff --git a/regidx.c b/regidx.c new file mode 100644 index 000000000..db9086e0a --- /dev/null +++ b/regidx.c @@ -0,0 +1,338 @@ +/* + Copyright (C) 2014 Genome Research Ltd. + + Author: Petr Danecek + + Permission is hereby granted, free of charge, to any person obtaining a copy + of this software and associated documentation files (the "Software"), to deal + in the Software without restriction, including without limitation the rights + to use, copy, modify, merge, publish, distribute, sublicense, and/or sell + copies of the Software, and to permit persons to whom the Software is + furnished to do so, subject to the following conditions: + + The above copyright notice and this permission notice shall be included in + all copies or substantial portions of the Software. + + THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS OR + IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF MERCHANTABILITY, + FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. IN NO EVENT SHALL THE + AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY CLAIM, DAMAGES OR OTHER + LIABILITY, WHETHER IN AN ACTION OF CONTRACT, TORT OR OTHERWISE, ARISING FROM, + OUT OF OR IN CONNECTION WITH THE SOFTWARE OR THE USE OR OTHER DEALINGS IN + THE SOFTWARE. +*/ + +#include +#include +#include +#include +#include "regidx.h" + +#define LIDX_SHIFT 13 // number of insignificant index bits + +// List of regions for one chromosome +typedef struct +{ + int *idx, nidx; + int nregs, mregs; // n:used, m:alloced + reg_t *regs; + void *payload; +} +reglist_t; + +// Container of all sequences +struct _regidx_t +{ + int nseq, mseq; // n:used, m:alloced + reglist_t *seq; // regions for each sequence + void *seq2regs; // hash for fast lookup from chr name to regions + char **seq_names; + regidx_free_f free; // function to free any data allocated by regidx_parse_f + regidx_parse_f parse; // parse one input line + void *usr; // user data to pass to regidx_parse_f + + // temporary data for index initialization + kstring_t str; + int rid_prev, start_prev, end_prev; + int payload_size; + void *payload; +}; + +int regidx_seq_nregs(regidx_t *idx, const char *seq) +{ + int iseq; + if ( khash_str2int_get(idx->seq2regs, seq, &iseq)!=0 ) return 0; // no such sequence + return idx->seq[iseq].nregs; +} + +int regidx_nregs(regidx_t *idx) +{ + int i, nregs = 0; + for (i=0; inseq; i++) nregs += idx->seq[i].nregs; + return nregs; +} + +char **regidx_seq_names(regidx_t *idx, int *n) +{ + *n = idx->nseq; + return idx->seq_names; +} + +int _regidx_build_index(regidx_t *idx) +{ + int iseq; + for (iseq=0; iseqnseq; iseq++) + { + reglist_t *list = &idx->seq[iseq]; + int j,k, imax = 0; // max index bin + for (j=0; jnregs; j++) + { + int ibeg = list->regs[j].start >> LIDX_SHIFT; + int iend = list->regs[j].end >> LIDX_SHIFT; + if ( imax < iend + 1 ) + { + int old_imax = imax; + imax = iend + 1; + kroundup32(imax); + list->idx = (int*) realloc(list->idx, imax*sizeof(int)); + for (k=old_imax; kidx[k] = -1; + } + if ( ibeg==iend ) + { + if ( list->idx[ibeg]<0 ) list->idx[ibeg] = j; + } + else + { + for (k=ibeg; k<=iend; k++) + if ( list->idx[k]<0 ) list->idx[k] = j; + } + list->nidx = iend + 1; + } + } + return 0; +} + +int regidx_insert(regidx_t *idx, char *line) +{ + if ( !line ) + return _regidx_build_index(idx); + + char *chr_from, *chr_to; + reg_t reg; + int ret = idx->parse(line,&chr_from,&chr_to,®,idx->payload,idx->usr); + if ( ret==-2 ) return -1; // error + if ( ret==-1 ) return 0; // skip the line + + int rid; + idx->str.l = 0; + kputsn(chr_from, chr_to-chr_from+1, &idx->str); + if ( khash_str2int_get(idx->seq2regs, idx->str.s, &rid)!=0 ) + { + idx->nseq++; + int m_prev = idx->mseq; + hts_expand0(reglist_t,idx->nseq,idx->mseq,idx->seq); + hts_expand0(char*,idx->nseq,m_prev,idx->seq_names); + idx->seq_names[idx->nseq-1] = strdup(idx->str.s); + rid = khash_str2int_inc(idx->seq2regs, idx->seq_names[idx->nseq-1]); + } + + reglist_t *list = &idx->seq[rid]; + list->nregs++; + int m_prev = list->mregs; + hts_expand(reg_t,list->nregs,list->mregs,list->regs); + list->regs[list->nregs-1] = reg; + if ( idx->payload_size ) + { + if ( m_prev < list->mregs ) list->payload = realloc(list->payload,idx->payload_size*list->mregs); + memcpy(list->payload + idx->payload_size*(list->nregs-1), idx->payload, idx->payload_size); + } + + if ( idx->rid_prev==rid ) + { + if ( idx->start_prev > reg.start || (idx->start_prev==reg.start && idx->end_prev>reg.end) ) + { + fprintf(stderr,"The regions are not sorted: %s:%d-%d is before %s:%d-%d\n", + idx->str.s,idx->start_prev+1,idx->end_prev+1,idx->str.s,reg.start+1,reg.end+1); + return -1; + } + } + idx->rid_prev = rid; + idx->start_prev = reg.start; + idx->end_prev = reg.end; + return 0; +} + +regidx_t *regidx_init(const char *fname, regidx_parse_f parser, regidx_free_f free_f, size_t payload_size, void *usr_dat) +{ + if ( !parser ) + { + if ( !fname ) parser = regidx_parse_tab; + else + { + int len = strlen(fname); + if ( len>=7 && !strcasecmp(".bed.gz",fname+len-7) ) + parser = regidx_parse_bed; + else if ( len>=8 && !strcasecmp(".bed.bgz",fname+len-8) ) + parser = regidx_parse_bed; + else if ( len>=4 && !strcasecmp(".bed",fname+len-4) ) + parser = regidx_parse_bed; + else + parser = regidx_parse_tab; + } + } + + regidx_t *idx = (regidx_t*) calloc(1,sizeof(regidx_t)); + idx->free = free_f; + idx->parse = parser; + idx->usr = usr_dat; + idx->seq2regs = khash_str2int_init(); + idx->rid_prev = -1; + idx->start_prev = -1; + idx->end_prev = -1; + idx->payload_size = payload_size; + if ( payload_size ) idx->payload = malloc(payload_size); + + if ( !fname ) return idx; + + kstring_t str = {0,0,0}; + + htsFile *fp = hts_open(fname,"r"); + if ( !fp ) goto error; + + while ( hts_getline(fp, KS_SEP_LINE, &str) > 0 ) + { + if ( regidx_insert(idx, str.s) ) goto error; + } + regidx_insert(idx, NULL); + + free(str.s); + hts_close(fp); + return idx; + +error: + free(str.s); + if ( fp ) hts_close(fp); + regidx_destroy(idx); + return NULL; +} + +void regidx_destroy(regidx_t *idx) +{ + int i, j; + for (i=0; inseq; i++) + { + reglist_t *list = &idx->seq[i]; + if ( idx->free ) + { + for (j=0; jnregs; j++) + idx->free(list->payload + idx->payload_size*j); + } + free(list->payload); + free(list->regs); + free(list->idx); + } + free(idx->seq_names); + free(idx->seq); + free(idx->str.s); + free(idx->payload); + khash_str2int_destroy_free(idx->seq2regs); + free(idx); +} + +int regidx_overlap(regidx_t *idx, const char *chr, uint32_t from, uint32_t to, regitr_t *itr) +{ + if ( itr ) itr->i = itr->n = 0; + + int iseq; + if ( khash_str2int_get(idx->seq2regs, chr, &iseq)!=0 ) return 0; // no such sequence + + reglist_t *list = &idx->seq[iseq]; + if ( !list->nregs ) return 0; + + int i, ibeg = from>>LIDX_SHIFT; + int ireg = ibeg < list->nidx ? list->idx[ibeg] : list->idx[ list->nidx - 1 ]; + if ( ireg < 0 ) + { + // linear search; if slow, replace with binary search + if ( ibeg > list->nidx ) ibeg = list->nidx; + for (i=ibeg - 1; i>=0; i--) + if ( list->idx[i] >=0 ) break; + ireg = i>=0 ? list->idx[i] : 0; + } + for (i=ireg; inregs; i++) + { + if ( list->regs[i].start > to ) return 0; // no match + if ( list->regs[i].end >= from && list->regs[i].start <= to ) break; // found + } + + if ( i>=list->nregs ) return 0; // no match + + if ( !itr ) return 1; + + itr->i = 0; + itr->n = list->nregs - i; + itr->reg = &idx->seq[iseq].regs[i]; + if ( idx->payload_size ) + itr->payload = idx->seq[iseq].payload + i*idx->payload_size; + else + itr->payload = NULL; + + return 1; +} + +int regidx_parse_bed(const char *line, char **chr_beg, char **chr_end, reg_t *reg, void *payload, void *usr) +{ + char *ss = (char*) line; + while ( *ss && isspace(*ss) ) ss++; + if ( !*ss ) return -1; // skip blank lines + if ( *ss=='#' ) return -1; // skip comments + + char *se = ss; + while ( *se && !isspace(*se) ) se++; + if ( !*se ) { fprintf(stderr,"Could not parse bed line: %s\n", line); return -2; } + + *chr_beg = ss; + *chr_end = se-1; + + ss = se+1; + reg->start = hts_parse_decimal(ss, &se, 0); + if ( ss==se ) { fprintf(stderr,"Could not parse bed line: %s\n", line); return -2; } + + ss = se+1; + reg->end = hts_parse_decimal(ss, &se, 0) - 1; + if ( ss==se ) { fprintf(stderr,"Could not parse bed line: %s\n", line); return -2; } + + return 0; +} + +int regidx_parse_tab(const char *line, char **chr_beg, char **chr_end, reg_t *reg, void *payload, void *usr) +{ + char *ss = (char*) line; + while ( *ss && isspace(*ss) ) ss++; + if ( !*ss ) return -1; // skip blank lines + if ( *ss=='#' ) return -1; // skip comments + + char *se = ss; + while ( *se && !isspace(*se) ) se++; + if ( !*se ) { fprintf(stderr,"Could not parse bed line: %s\n", line); return -2; } + + *chr_beg = ss; + *chr_end = se-1; + + ss = se+1; + reg->start = hts_parse_decimal(ss, &se, 0) - 1; + if ( ss==se ) { fprintf(stderr,"Could not parse bed line: %s\n", line); return -2; } + + if ( !se[0] || !se[1] ) + reg->end = reg->start; + else + { + ss = se+1; + reg->end = hts_parse_decimal(ss, &se, 0); + if ( ss==se ) reg->end = reg->start; + else reg->end--; + } + + return 0; +} + diff --git a/regidx.h b/regidx.h new file mode 100644 index 000000000..79e82b77d --- /dev/null +++ b/regidx.h @@ -0,0 +1,154 @@ +/* + Copyright (C) 2014 Genome Research Ltd. + + Author: Petr Danecek + + Permission is hereby granted, free of charge, to any person obtaining a copy + of this software and associated documentation files (the "Software"), to deal + in the Software without restriction, including without limitation the rights + to use, copy, modify, merge, publish, distribute, sublicense, and/or sell + copies of the Software, and to permit persons to whom the Software is + furnished to do so, subject to the following conditions: + + The above copyright notice and this permission notice shall be included in + all copies or substantial portions of the Software. + + THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS OR + IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF MERCHANTABILITY, + FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. IN NO EVENT SHALL THE + AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY CLAIM, DAMAGES OR OTHER + LIABILITY, WHETHER IN AN ACTION OF CONTRACT, TORT OR OTHERWISE, ARISING FROM, + OUT OF OR IN CONNECTION WITH THE SOFTWARE OR THE USE OR OTHER DEALINGS IN + THE SOFTWARE. +*/ + +/* + Regions indexing with an optional payload. Inspired by samtools/bedidx.c. + This code is intended as future replacement of bcf_sr_regions_t. + + Example of usage: + + // Init the parser and print regions. In this example the payload is a + // pointer to a string. For the description of parse_custom and + // free_custom functions, see regidx_parse_f and regidx_free_f below, + // and for working example see test/test-regidx.c. + regidx_t *idx = regidx_init(in_fname,parse_custom,free_custom,sizeof(char*),NULL); + + // Query overlap with chr:from-to + regitr_t itr; + if ( regidx_overlap(idx, chr,from,to, &itr) ) printf("There is an overlap!\n"); + + while ( REGITR_OVERLAP(itr,from,to) ) + { + printf("[%d,%d] overlaps with [%d,%d], payload=%s\n", from,to, + REGITR_START(itr), REGITR_END(itr), REGITR_PAYLOAD(itr,char*)); + itr.i++; + } + + regidx_destroy(regs); +*/ + +#ifndef HTSLIB_REGIDX_H +#define HTSLIB_REGIDX_H + +#include +#include + +#ifdef __cplusplus +extern "C" { +#endif + +typedef struct _regidx_t regidx_t; +typedef struct +{ + uint32_t start, end; +} +reg_t; +typedef struct +{ + int i, n; + reg_t *reg; + void *payload; +} +regitr_t; + +#define REGITR_START(itr) (itr).reg[(itr).i].start +#define REGITR_END(itr) (itr).reg[(itr).i].end +#define REGITR_PAYLOAD(itr,type_t) ((type_t*)(itr).payload)[(itr).i] +#define REGITR_OVERLAP(itr,from,to) (itr.i < itr.n && REGITR_START(itr)<=to && REGITR_END(itr)>=from ) + +/* + * regidx_parse_f - Function to parse one input line, such as regidx_parse_bed + * or regidx_parse_tab below. The function is expected to set `chr_from` and + * `chr_to` to point to first and last character of chromosome name and set + * coordinates `reg->start` and `reg->end` (0-based, inclusive). If + * regidx_init() was called with non-zero payload_size, the `payload` points + * to a memory location of the payload_size and `usr` is data passed to + * regidx_init(). Any memory allocated by the function will be freed by + * regidx_free_f on regidx_destroy(). + * + * Return value: 0 on success, -1 to skip a record, -2 on fatal error. + */ +typedef int (*regidx_parse_f)(const char *line, char **chr_beg, char **chr_end, reg_t *reg, void *payload, void *usr); +typedef void (*regidx_free_f)(void *payload); + +int regidx_parse_bed(const char*,char**,char**,reg_t*,void*,void*); // CHROM,FROM,TO (0-based,right-open) +int regidx_parse_tab(const char*,char**,char**,reg_t*,void*,void*); // CHROM,POS (1-based, inclusive) + +/* + * regidx_init() - creates new index + * @param fname: input file name or NULL if regions will be added one-by-one via regidx_insert() + * @param parsef: regidx_parse_bed, regidx_parse_tab or see description of regidx_parse_f. If NULL, + * the format will be autodected, currently either regidx_parse_tab (the default) or + * regidx_parse_bed (file must be named 'bed' or 'bed.gz') will be used. Note that + * the exact autodetection algorithm will change. + * @param freef: NULL or see description of regidx_parse_f + * @param payload_size: 0 with regidx_parse_bed, regidx_parse_tab or see regidx_parse_f + * @param usr: optional user data passed to regidx_parse_f + * + * Returns index on success or NULL on error. + */ +regidx_t *regidx_init(const char *fname, regidx_parse_f parsef, regidx_free_f freef, size_t payload_size, void *usr); + +/* + * regidx_destroy() - free memory allocated by regidx_init + */ +void regidx_destroy(regidx_t *idx); + +/* + * regidx_overlap() - check overlap of the location chr:from-to with regions + * @param start,end: 0-based start, end coordinate (inclusive) + * @param itr: pointer to iterator, can be NULL if not needed + * + * Returns 0 if there is no overlap or 1 if overlap is found. The overlapping + * regions can be iterated as shown in the example above. + */ +int regidx_overlap(regidx_t *idx, const char *chr, uint32_t start, uint32_t end, regitr_t *itr); + +/* + * regidx_insert() - add a new region. + * + * After last region has been added, call regidx_insert(idx,NULL) to + * build the index. + * + * Returns 0 on success or -1 on error. + */ +int regidx_insert(regidx_t *idx, char *line); + +/* + * regidx_seq_names() - return list of all sequence names + */ +char **regidx_seq_names(regidx_t *idx, int *n); + +/* + * regidx_seq_nregs() - number of regions + * regidx_nregs() - total number of regions + */ +int regidx_seq_nregs(regidx_t *idx, const char *seq); +int regidx_nregs(regidx_t *idx); + +#ifdef __cplusplus +} +#endif + +#endif From d766590e0ef46e483a93adbee5427ff2ebe21c8e Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Fri, 17 Jun 2016 13:19:46 +0100 Subject: [PATCH 201/211] regidx: extend regidx API * added functions to loop over all regions * lazy index build in case random access is not required * support for chromosome names only, beg-end coordinates not mandatory * set cap at maximum coordinate at 2147483647, hts_itr does not support larger * tab and reg parsers will throw on finding a `0` to catch user error of using 0-based rather than 1-based coords --- Makefile | 5 +- mpileup.c | 2 +- regidx.c | 223 ++++++++++++++++++++++++++++++++++++++++++------------ regidx.h | 53 +++++++++++-- 4 files changed, 223 insertions(+), 60 deletions(-) diff --git a/Makefile b/Makefile index abae700b7..1d923e995 100644 --- a/Makefile +++ b/Makefile @@ -45,7 +45,7 @@ OBJS = main.o vcfindex.o tabix.o \ vcfstats.o vcfisec.o vcfmerge.o vcfquery.o vcffilter.o filter.o vcfsom.o \ vcfnorm.o vcfgtcheck.o vcfview.o vcfannotate.o vcfroh.o vcfconcat.o \ vcfcall.o mcall.o vcmp.o gvcf.o reheader.o convert.o vcfconvert.o tsv2vcf.o \ - vcfcnv.o HMM.o vcfplugin.o consensus.o ploidy.o version.o \ + vcfcnv.o HMM.o vcfplugin.o consensus.o ploidy.o regidx.o version.o \ mpileup.o bam2bcf.o bam2bcf_indel.o sample.o \ ccall.o em.o prob1.o kmin.o # the original samtools calling @@ -176,8 +176,9 @@ vcmp.o: vcmp.c $(htslib_hts_h) vcmp.h ploidy.o: ploidy.c regidx.h $(HTSDIR)/htslib/khash_str2int.h $(HTSDIR)/htslib/kseq.h $(htslib_hts_h) $(bcftools_h) $(ploidy_h) polysomy.o: polysomy.c $(htslib_vcf_h) $(htslib_synced_bcf_reader_h) $(bcftools_h) peakfit.h peakfit.o: peakfit.c peakfit.h $(htslib_hts_h) $(HTSDIR)/htslib/kstring.h +regidx.o: regidx.c $(htslib_hts_h) $(htslib_kstring_h) $(htslib_kseq_h) $(htslib_khash_str2int_h) regidx.h consensus.o: consensus.c $(htslib_hts_h) $(HTSDIR)/htslib/kseq.h rbuf.h $(bcftools_h) regidx.h -mpileup.o: mpileup.c $(htslib_sam_h) $(htslib_faidx_h) $(htslib_kstring_h) $(htslib_khash_str2int_h) $(htslib_regidx_h) $(bcftools_h) $(call_h) $(bam2bcf_h) $(sample_h) +mpileup.o: mpileup.c $(htslib_sam_h) $(htslib_faidx_h) $(htslib_kstring_h) $(htslib_khash_str2int_h) regidx.h $(bcftools_h) $(call_h) $(bam2bcf_h) $(sample_h) sample.o: $(sample_h) $(htslib_hts_h) $(HTSDIR)/htslib/khash_str2int.h version.o: version.h version.c diff --git a/mpileup.c b/mpileup.c index b2d5d449b..dbd0d68aa 100644 --- a/mpileup.c +++ b/mpileup.c @@ -37,8 +37,8 @@ DEALINGS IN THE SOFTWARE. */ #include #include #include -#include #include +#include "regidx.h" #include "bcftools.h" #include "bam2bcf.h" #include "sample.h" diff --git a/regidx.c b/regidx.c index db9086e0a..a3f3a57e0 100644 --- a/regidx.c +++ b/regidx.c @@ -1,5 +1,5 @@ /* - Copyright (C) 2014 Genome Research Ltd. + Copyright (C) 2014-2016 Genome Research Ltd. Author: Petr Danecek @@ -28,6 +28,7 @@ #include #include "regidx.h" +#define MAX_COOR 2147483647 // CSI and hts_itr_query limit #define LIDX_SHIFT 13 // number of insignificant index bits // List of regions for one chromosome @@ -53,7 +54,8 @@ struct _regidx_t // temporary data for index initialization kstring_t str; - int rid_prev, start_prev, end_prev; + int rid_prev; + uint32_t start_prev, end_prev; int payload_size; void *payload; }; @@ -78,50 +80,68 @@ char **regidx_seq_names(regidx_t *idx, int *n) return idx->seq_names; } -int _regidx_build_index(regidx_t *idx) +int _regidx_build_index(regidx_t *idx, reglist_t *list) { - int iseq; - for (iseq=0; iseqnseq; iseq++) + int j,k, imax = 0; // max index bin + for (j=0; jnregs; j++) { - reglist_t *list = &idx->seq[iseq]; - int j,k, imax = 0; // max index bin - for (j=0; jnregs; j++) + int ibeg = list->regs[j].start >> LIDX_SHIFT; + int iend = list->regs[j].end >> LIDX_SHIFT; + if ( imax < iend + 1 ) { - int ibeg = list->regs[j].start >> LIDX_SHIFT; - int iend = list->regs[j].end >> LIDX_SHIFT; - if ( imax < iend + 1 ) - { - int old_imax = imax; - imax = iend + 1; - kroundup32(imax); - list->idx = (int*) realloc(list->idx, imax*sizeof(int)); - for (k=old_imax; kidx[k] = -1; - } - if ( ibeg==iend ) - { - if ( list->idx[ibeg]<0 ) list->idx[ibeg] = j; - } - else - { - for (k=ibeg; k<=iend; k++) - if ( list->idx[k]<0 ) list->idx[k] = j; - } - list->nidx = iend + 1; + int old_imax = imax; + imax = iend + 1; + kroundup32(imax); + list->idx = (int*) realloc(list->idx, imax*sizeof(int)); + for (k=old_imax; kidx[k] = -1; + } + if ( ibeg==iend ) + { + if ( list->idx[ibeg]<0 ) list->idx[ibeg] = j; + } + else + { + for (k=ibeg; k<=iend; k++) + if ( list->idx[k]<0 ) list->idx[k] = j; + } + list->nidx = iend + 1; + } + return 0; +} + +int regidx_insert_list(regidx_t *idx, char *line, char delim) +{ + kstring_t tmp = {0,0,0}; + char *ss = line; + while ( *ss ) + { + char *se = ss; + while ( *se && *se!=delim ) se++; + tmp.l = 0; + kputsn(ss, se-ss, &tmp); + if ( regidx_insert(idx,tmp.s) < 0 ) + { + free(tmp.s); + return -1; } + if ( !*se ) break; + ss = se+1; } + free(tmp.s); return 0; } int regidx_insert(regidx_t *idx, char *line) { - if ( !line ) - return _regidx_build_index(idx); + if ( !line ) return 0; char *chr_from, *chr_to; reg_t reg; int ret = idx->parse(line,&chr_from,&chr_to,®,idx->payload,idx->usr); if ( ret==-2 ) return -1; // error if ( ret==-1 ) return 0; // skip the line + if ( reg.start > MAX_COOR - 1 ) reg.start = MAX_COOR - 1; + if ( reg.end > MAX_COOR - 1 ) reg.end = MAX_COOR - 1; int rid; idx->str.l = 0; @@ -151,7 +171,7 @@ int regidx_insert(regidx_t *idx, char *line) { if ( idx->start_prev > reg.start || (idx->start_prev==reg.start && idx->end_prev>reg.end) ) { - fprintf(stderr,"The regions are not sorted: %s:%d-%d is before %s:%d-%d\n", + fprintf(stderr,"The regions are not sorted: %s:%u-%u is before %s:%u-%u\n", idx->str.s,idx->start_prev+1,idx->end_prev+1,idx->str.s,reg.start+1,reg.end+1); return -1; } @@ -187,8 +207,8 @@ regidx_t *regidx_init(const char *fname, regidx_parse_f parser, regidx_free_f fr idx->usr = usr_dat; idx->seq2regs = khash_str2int_init(); idx->rid_prev = -1; - idx->start_prev = -1; - idx->end_prev = -1; + idx->start_prev = 0; + idx->end_prev = 0; idx->payload_size = payload_size; if ( payload_size ) idx->payload = malloc(payload_size); @@ -249,29 +269,42 @@ int regidx_overlap(regidx_t *idx, const char *chr, uint32_t from, uint32_t to, r reglist_t *list = &idx->seq[iseq]; if ( !list->nregs ) return 0; - int i, ibeg = from>>LIDX_SHIFT; - int ireg = ibeg < list->nidx ? list->idx[ibeg] : list->idx[ list->nidx - 1 ]; - if ( ireg < 0 ) + int i; + if ( list->nregs==1 ) { - // linear search; if slow, replace with binary search - if ( ibeg > list->nidx ) ibeg = list->nidx; - for (i=ibeg - 1; i>=0; i--) - if ( list->idx[i] >=0 ) break; - ireg = i>=0 ? list->idx[i] : 0; + // one region only, the index was not built to save memory + if ( idx->seq[iseq].regs[0].start > to ) return 0; // no match + if ( idx->seq[iseq].regs[0].end < from ) return 0; + i = 0; } - for (i=ireg; inregs; i++) + else { - if ( list->regs[i].start > to ) return 0; // no match - if ( list->regs[i].end >= from && list->regs[i].start <= to ) break; // found - } + if ( !list->idx ) _regidx_build_index(idx, list); - if ( i>=list->nregs ) return 0; // no match + int ibeg = from>>LIDX_SHIFT; + int ireg = ibeg < list->nidx ? list->idx[ibeg] : list->idx[ list->nidx - 1 ]; + if ( ireg < 0 ) + { + // linear search; if slow, replace with binary search + if ( ibeg > list->nidx ) ibeg = list->nidx; + for (i=ibeg - 1; i>=0; i--) + if ( list->idx[i] >=0 ) break; + ireg = i>=0 ? list->idx[i] : 0; + } + for (i=ireg; inregs; i++) + { + if ( list->regs[i].start > to ) return 0; // no match + if ( list->regs[i].end >= from ) break; // found + } + if ( i>=list->nregs ) return 0; // no match + } if ( !itr ) return 1; itr->i = 0; itr->n = list->nregs - i; itr->reg = &idx->seq[iseq].regs[i]; + itr->seq = iseq; if ( idx->payload_size ) itr->payload = idx->seq[iseq].payload + i*idx->payload_size; else @@ -289,11 +322,18 @@ int regidx_parse_bed(const char *line, char **chr_beg, char **chr_end, reg_t *re char *se = ss; while ( *se && !isspace(*se) ) se++; - if ( !*se ) { fprintf(stderr,"Could not parse bed line: %s\n", line); return -2; } *chr_beg = ss; *chr_end = se-1; + if ( !*se ) + { + // just the chromosome name + reg->start = 0; + reg->end = MAX_COOR - 1; + return 0; + } + ss = se+1; reg->start = hts_parse_decimal(ss, &se, 0); if ( ss==se ) { fprintf(stderr,"Could not parse bed line: %s\n", line); return -2; } @@ -314,14 +354,23 @@ int regidx_parse_tab(const char *line, char **chr_beg, char **chr_end, reg_t *re char *se = ss; while ( *se && !isspace(*se) ) se++; - if ( !*se ) { fprintf(stderr,"Could not parse bed line: %s\n", line); return -2; } *chr_beg = ss; *chr_end = se-1; + if ( !*se ) + { + // just the chromosome name + reg->start = 0; + reg->end = MAX_COOR - 1; + return 0; + } + ss = se+1; - reg->start = hts_parse_decimal(ss, &se, 0) - 1; - if ( ss==se ) { fprintf(stderr,"Could not parse bed line: %s\n", line); return -2; } + reg->start = hts_parse_decimal(ss, &se, 0); + if ( ss==se ) { fprintf(stderr,"Could not parse tab line: %s\n", line); return -2; } + if ( reg->start==0 ) { fprintf(stderr,"Could not parse tab line, expected 1-based coordinate: %s\n", line); return -2; } + reg->start--; if ( !se[0] || !se[1] ) reg->end = reg->start; @@ -330,9 +379,83 @@ int regidx_parse_tab(const char *line, char **chr_beg, char **chr_end, reg_t *re ss = se+1; reg->end = hts_parse_decimal(ss, &se, 0); if ( ss==se ) reg->end = reg->start; + else if ( reg->end==0 ) { fprintf(stderr,"Could not parse tab line, expected 1-based coordinate: %s\n", line); return -2; } else reg->end--; } + return 0; +} + +int regidx_parse_reg(const char *line, char **chr_beg, char **chr_end, reg_t *reg, void *payload, void *usr) +{ + char *ss = (char*) line; + while ( *ss && isspace(*ss) ) ss++; + if ( !*ss ) return -1; // skip blank lines + if ( *ss=='#' ) return -1; // skip comments + char *se = ss; + while ( *se && *se!=':' ) se++; + + *chr_beg = ss; + *chr_end = se-1; + + if ( !*se ) + { + reg->start = 0; + reg->end = MAX_COOR - 1; + return 0; + } + + ss = se+1; + reg->start = hts_parse_decimal(ss, &se, 0); + if ( ss==se ) { fprintf(stderr,"Could not parse reg line: %s\n", line); return -2; } + if ( reg->start==0 ) { fprintf(stderr,"Could not parse reg line, expected 1-based coordinate: %s\n", line); return -2; } + reg->start--; + + if ( !se[0] || !se[1] ) + reg->end = se[0]=='-' ? MAX_COOR - 1 : reg->start; + else + { + ss = se+1; + reg->end = hts_parse_decimal(ss, &se, 0); + if ( ss==se ) reg->end = reg->start; + else if ( reg->end==0 ) { fprintf(stderr,"Could not parse reg line, expected 1-based coordinate: %s\n", line); return -2; } + else reg->end--; + } return 0; } +int regidx_loop(regidx_t *idx, regitr_t *itr) +{ + if ( !itr->reg ) + { + if ( !idx->nseq ) return 0; + itr->i = itr->n = 0; + itr->seq = -1; + } + + itr->i++; + + if ( itr->i >= itr->n ) + { + itr->seq++; + if ( itr->seq >= idx->nseq ) return 0; + + reglist_t *list = &idx->seq[itr->seq]; + itr->reg = &list->regs[0]; + itr->i = 0; + itr->n = list->nregs; + } + + if ( idx->payload_size ) + itr->payload = idx->seq[itr->seq].payload + itr->i*idx->payload_size; + else + itr->payload = NULL; + + return 1; +} + +const char *regitr_seqname(regidx_t *idx, regitr_t *itr) +{ + return (const char*)idx->seq_names[itr->seq]; +} + diff --git a/regidx.h b/regidx.h index 79e82b77d..18cd98a35 100644 --- a/regidx.h +++ b/regidx.h @@ -1,5 +1,5 @@ /* - Copyright (C) 2014 Genome Research Ltd. + Copyright (C) 2014-2016 Genome Research Ltd. Author: Petr Danecek @@ -23,7 +23,7 @@ */ /* - Regions indexing with an optional payload. Inspired by samtools/bedidx.c. + Region indexing with an optional payload. Inspired by samtools/bedidx.c. This code is intended as future replacement of bcf_sr_regions_t. Example of usage: @@ -46,6 +46,28 @@ } regidx_destroy(regs); + + + Another example, loop over all regions: + + regidx_t *idx = regidx_init(in_fname,NULL,NULL,0,NULL); + regitr_t itr; + REGITR_INIT(itr); + while ( regidx_loop(idx,&itr) ) + printf("chr=%s beg=%d end=%d\n", regitr_seqname(&itr),REGITR_START(itr),REGITR_END(itr)); + regidx_destroy(regs); + + + A note about memory requirements: All regions are stored in memory. When + the whole uint32_t range is indexed (beg=0,end=UINT32_MAX), the index takes + up to 2.1MB of memory per sequence (50MB in total for 24 sequences). + Howeveer, in typical usage the memory requirements are 10x lower, for + example 200k human exons require 0.2MB per sequence (5MB in total). With + only one region per per sequence (e.g. whole chromosomes), the index is not + build and the required memory is neglibible. The index is created only when + regidx_overlap() is called, therefore in the regidx_loop() mode the memory + is always small. + */ #ifndef HTSLIB_REGIDX_H @@ -69,6 +91,7 @@ typedef struct int i, n; reg_t *reg; void *payload; + int seq; } regitr_t; @@ -76,6 +99,8 @@ regitr_t; #define REGITR_END(itr) (itr).reg[(itr).i].end #define REGITR_PAYLOAD(itr,type_t) ((type_t*)(itr).payload)[(itr).i] #define REGITR_OVERLAP(itr,from,to) (itr.i < itr.n && REGITR_START(itr)<=to && REGITR_END(itr)>=from ) +#define REGITR_INIT(itr) (itr).reg = 0 + /* * regidx_parse_f - Function to parse one input line, such as regidx_parse_bed @@ -92,8 +117,14 @@ regitr_t; typedef int (*regidx_parse_f)(const char *line, char **chr_beg, char **chr_end, reg_t *reg, void *payload, void *usr); typedef void (*regidx_free_f)(void *payload); -int regidx_parse_bed(const char*,char**,char**,reg_t*,void*,void*); // CHROM,FROM,TO (0-based,right-open) -int regidx_parse_tab(const char*,char**,char**,reg_t*,void*,void*); // CHROM,POS (1-based, inclusive) +/* + * A note about the parsers: + * - leading spaces are ignored + * - lines starting with "#" are ignored + */ +int regidx_parse_bed(const char*,char**,char**,reg_t*,void*,void*); // CHROM or whitespace-separated CHROM,FROM,TO (0-based,right-open) +int regidx_parse_tab(const char*,char**,char**,reg_t*,void*,void*); // CHROM or whitespace-separated CHROM,POS (1-based, inclusive) +int regidx_parse_reg(const char*,char**,char**,reg_t*,void*,void*); // CHROM, CHROM:POS, CHROM:FROM-TO, CHROM:FROM- (1-based, inclusive) /* * regidx_init() - creates new index @@ -125,15 +156,23 @@ void regidx_destroy(regidx_t *idx); */ int regidx_overlap(regidx_t *idx, const char *chr, uint32_t start, uint32_t end, regitr_t *itr); +/* + * regidx_loop() - loop over all regions + * Returns 0 when done or 1 when itr is set to next region + */ +int regidx_loop(regidx_t *idx, regitr_t *itr); + +/* Current sequence name */ +const char *regitr_seqname(regidx_t *idx, regitr_t *itr); + /* * regidx_insert() - add a new region. - * - * After last region has been added, call regidx_insert(idx,NULL) to - * build the index. + * regidx_insert_list() - add new regions from a list * * Returns 0 on success or -1 on error. */ int regidx_insert(regidx_t *idx, char *line); +int regidx_insert_list(regidx_t *idx, char *line, char delim); /* * regidx_seq_names() - return list of all sequence names From d4a7db37512b2dac3318f1aa35be7b30dd2150e2 Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Mon, 20 Jun 2016 09:58:26 +0100 Subject: [PATCH 202/211] mpileup: support multiple regions * `-r/--region` replaced by `-r/--regions` which will accept a comma separated list of regions as in other bcftools commands. `--region` still accepted * `-R/--regions-file` option added to read regions from a file This commit lifts over work originally done in pd3/bcftools@cfd7cf9092ffddc1ec0441a3c463bc2ac7084bad Note: when more than one region is given, all indices are stored in memory, which can be a problem when running on many bams. An alternative would be to cache pre-filled `hts_itr`'s for each region. Resolves #369 --- bam2bcf.h | 5 +- bam2bcf_indel.c | 70 ++---- doc/bcftools.txt | 12 +- mpileup.c | 589 ++++++++++++++++++++++++++++------------------- test/test.pl | 1 + 5 files changed, 377 insertions(+), 300 deletions(-) diff --git a/bam2bcf.h b/bam2bcf.h index 54e5faaaa..f81f9cf02 100644 --- a/bam2bcf.h +++ b/bam2bcf.h @@ -1,7 +1,7 @@ /* bam2bcf.h -- variant calling. Copyright (C) 2010-2012 Broad Institute. - Copyright (C) 2012-2014 Genome Research Ltd. + Copyright (C) 2012-2014,2016 Genome Research Ltd. Author: Heng Li @@ -128,8 +128,7 @@ extern "C" { int bcf_call_combine(int n, const bcf_callret1_t *calls, bcf_callaux_t *bca, int ref_base /*4-bit*/, bcf_call_t *call); int bcf_call2bcf(bcf_call_t *bc, bcf1_t *b, bcf_callret1_t *bcr, int fmt_flag, const bcf_callaux_t *bca, const char *ref); - int bcf_call_gap_prep(int n, int *n_plp, bam_pileup1_t **plp, int pos, bcf_callaux_t *bca, const char *ref, - const void *rghash); + int bcf_call_gap_prep(int n, int *n_plp, bam_pileup1_t **plp, int pos, bcf_callaux_t *bca, const char *ref); void bcf_callaux_clean(bcf_callaux_t *bca, bcf_call_t *call); #ifdef __cplusplus diff --git a/bam2bcf_indel.c b/bam2bcf_indel.c index 95cc5b076..9065949af 100644 --- a/bam2bcf_indel.c +++ b/bam2bcf_indel.c @@ -1,7 +1,7 @@ /* bam2bcf_indel.c -- indel caller. Copyright (C) 2010, 2011 Broad Institute. - Copyright (C) 2012-2014 Genome Research Ltd. + Copyright (C) 2012-2014,2016 Genome Research Ltd. Author: Heng Li @@ -26,26 +26,24 @@ DEALINGS IN THE SOFTWARE. */ #include #include #include -#include "htslib/hts.h" -#include "htslib/sam.h" +#include +#include +#include #include "bam2bcf.h" -#include "htslib/khash.h" -KHASH_SET_INIT_STR(rg) -#include "htslib/ksort.h" +#include KSORT_INIT_GENERIC(uint32_t) #define MINUS_CONST 0x10000000 #define INDEL_WINDOW_SIZE 50 -void *bcf_call_add_rg(void *_hash, const char *hdtext, const char *list) +void *bcf_call_add_rg(void *hash, const char *hdtext, const char *list) { const char *s, *p, *q, *r, *t; - khash_t(rg) *hash; - if (list == 0 || hdtext == 0) return _hash; - if (_hash == 0) _hash = kh_init(rg); - hash = (khash_t(rg)*)_hash; - if ((s = strstr(hdtext, "@RG\t")) == 0) return hash; + + if (list == 0 || hdtext == 0) return hash; + if ( !hash ) hash = khash_str2int_init(); + if ((s = strstr(hdtext, "@RG\t")) == 0) return hash; // @RG lines not present do { t = strstr(s + 4, "@RG\t"); // the next @RG if ((p = strstr(s, "\tID:")) != 0) p += 4; @@ -60,13 +58,10 @@ void *bcf_call_add_rg(void *_hash, const char *hdtext, const char *list) x = (char*) calloc((lp > lq? lp : lq) + 1, 1); for (r = q; *r && *r != '\t' && *r != '\n'; ++r) x[r-q] = *r; if (strstr(list, x)) { // insert ID to the hash table - khint_t k; - int ret; for (r = p; *r && *r != '\t' && *r != '\n'; ++r) x[r-p] = *r; x[r-p] = 0; - k = kh_get(rg, hash, x); - if (k == kh_end(hash)) k = kh_put(rg, hash, x, &ret); - else free(x); + if ( khash_str2int_has_key(hash,x) ) free(x); + else khash_str2int_set(hash,x,1); } else free(x); } s = t; @@ -74,15 +69,9 @@ void *bcf_call_add_rg(void *_hash, const char *hdtext, const char *list) return hash; } -void bcf_call_del_rghash(void *_hash) +void bcf_call_del_rghash(void *hash) { - khint_t k; - khash_t(rg) *hash = (khash_t(rg)*)_hash; - if (hash == 0) return; - for (k = kh_begin(hash); k < kh_end(hash); ++k) - if (kh_exist(hash, k)) - free((char*)kh_key(hash, k)); - kh_destroy(rg, hash); + khash_str2int_destroy_free(hash); } static int tpos2qpos(const bam1_core_t *c, const uint32_t *cigar, int32_t tpos, int is_left, int32_t *_tpos) @@ -144,30 +133,13 @@ static inline int est_indelreg(int pos, const char *ref, int l, char *ins4) - 8: estimated sequence quality .. (aux>>8)&0xff - 8: indel quality .. aux&0xff */ -int bcf_call_gap_prep(int n, int *n_plp, bam_pileup1_t **plp, int pos, bcf_callaux_t *bca, const char *ref, - const void *rghash) +int bcf_call_gap_prep(int n, int *n_plp, bam_pileup1_t **plp, int pos, bcf_callaux_t *bca, const char *ref) { int i, s, j, k, t, n_types, *types, max_rd_len, left, right, max_ins, *score1, *score2, max_ref2; int N, K, l_run, ref_type, n_alt; char *inscns = 0, *ref2, *query, **ref_sample; - khash_t(rg) *hash = (khash_t(rg)*)rghash; if (ref == 0 || bca == 0) return -1; - // mark filtered reads - if (rghash) { - N = 0; - for (s = N = 0; s < n; ++s) { - for (i = 0; i < n_plp[s]; ++i) { - bam_pileup1_t *p = plp[s] + i; - const uint8_t *rg = bam_aux_get(p->b, "RG"); - p->aux = 1; // filtered by default - if (rg) { - khint_t k = kh_get(rg, hash, (const char*)(rg + 1)); - if (k != kh_end(hash)) p->aux = 0, ++N; // not filtered - } - } - } - if (N == 0) return -1; // no reads left - } + // determine if there is a gap for (s = N = 0; s < n; ++s) { for (i = 0; i < n_plp[s]; ++i) @@ -187,12 +159,10 @@ int bcf_call_gap_prep(int n, int *n_plp, bam_pileup1_t **plp, int pos, bcf_calla int na = 0, nt = 0; for (i = 0; i < n_plp[s]; ++i) { const bam_pileup1_t *p = plp[s] + i; - if (rghash == 0 || p->aux == 0) { - ++nt; - if (p->indel != 0) { - ++na; - aux[m++] = MINUS_CONST + p->indel; - } + ++nt; + if (p->indel != 0) { + ++na; + aux[m++] = MINUS_CONST + p->indel; } j = bam_cigar2qlen(p->b->core.n_cigar, bam_get_cigar(p->b)); if (j > max_rd_len) max_rd_len = j; diff --git a/doc/bcftools.txt b/doc/bcftools.txt index 35949ec97..1e966ae9d 100644 --- a/doc/bcftools.txt +++ b/doc/bcftools.txt @@ -1367,10 +1367,14 @@ regions listed in the BED file. *-Q, --min-BQ* 'INT':: Minimum base quality for a base to be considered [13] -*-r, --region* 'STR':: - Only generate output in region. Requires the alignment files to be - indexed. If used in conjunction with -l then considers the intersection - of the two requests [all sites] +*-r, --regions* 'CHR'|'CHR:POS'|'CHR:FROM-TO'|'CHR:FROM-'[,...]:: + Only generate mpileup output in given regions. Requires the alignment files + to be indexed. If used in conjunction with -l then considers the intersection; + see *<>* + +*-R, --regions-file* 'FILE':: + As for *-r, --regions*, but regions read from FILE; + see *<>* *--ignore-RG*:: Ignore RG tags. Treat all reads in one alignment file as one sample. diff --git a/mpileup.c b/mpileup.c index dbd0d68aa..cfccde46b 100644 --- a/mpileup.c +++ b/mpileup.c @@ -58,16 +58,39 @@ DEALINGS IN THE SOFTWARE. */ #define MPLP_PER_SAMPLE (1<<11) #define MPLP_SMART_OVERLAPS (1<<12) +typedef struct _mplp_aux_t mplp_aux_t; +typedef struct _mplp_pileup_t mplp_pileup_t; + +// Data shared by all bam files typedef struct { int min_mq, flag, min_baseQ, capQ_thres, max_depth, max_indel_depth, fmt_flag; int rflag_require, rflag_filter, output_type, sample_is_file; int openQ, extQ, tandemQ, min_support; // for indels double min_frac; // for indels - char *reg, *pl_list, *fai_fname, *output_fname, *samples_list; + char *reg_fname, *pl_list, *fai_fname, *output_fname, *samples_list; + int reg_is_file; faidx_t *fai; - void *rghash_exc; - regidx_t *bed; + regidx_t *bed, *reg; // bed: skipping regions, reg: index-jump to regions gvcf_t *gvcf; + + // auxiliary structures for calling + bcf_callaux_t *bca; + bcf_callret1_t *bcr; + bcf_call_t bc; + bam_mplp_t iter; + mplp_aux_t **mplp_data; + int nfiles; + char **files; + mplp_pileup_t *gplp; + int *n_plp; + const bam_pileup1_t **plp; + bam_sample_t *smpl; + kstring_t buf; + bcf1_t *bcf_rec; + htsFile *bcf_fp; + bcf_hdr_t *bcf_hdr; + void *rghash_exc; // shared by all bams + int argc; char **argv; } mplp_conf_t; @@ -80,20 +103,24 @@ typedef struct { #define MPLP_REF_INIT {{NULL,NULL},{-1,-1},{0,0}} -typedef struct { +// Data specific to each bam file +struct _mplp_aux_t { samFile *fp; hts_itr_t *iter; bam_hdr_t *h; mplp_ref_t *ref; const mplp_conf_t *conf; - void *rghash_inc; // whitelist for readgroups on per-bam basis -} mplp_aux_t; + void *rghash_inc; // whitelist for readgroups on per-bam basis, precedes blacklist + void *rghash_exc; // blacklist of readgroups + hts_idx_t *idx; // maintained only with more than one -r regions +}; -typedef struct { +// Data passed to htslib/mpileup +struct _mplp_pileup_t { int n; int *n_plp, *m_plp; bam_pileup1_t **plp; -} mplp_pileup_t; +}; static int mplp_get_ref(mplp_aux_t *ma, int tid, char **ref, int *ref_len) { mplp_ref_t *r = ma->ref; @@ -156,35 +183,34 @@ static int mplp_func(void *data, bam1_t *b) { char *ref; mplp_aux_t *ma = (mplp_aux_t*)data; - int ret, skip = 0, ref_len; - do { + int ret, ref_len; + while (1) + { int has_ref; - skip = 0; ret = ma->iter? sam_itr_next(ma->fp, ma->iter, b) : sam_read1(ma->fp, ma->h, b); if (ret < 0) break; // The 'B' cigar operation is not part of the specification, considering as obsolete. // bam_remove_B(b); - if (b->core.tid < 0 || (b->core.flag&BAM_FUNMAP)) { // exclude unmapped reads - skip = 1; - continue; - } - if (ma->conf->rflag_require && !(ma->conf->rflag_require&b->core.flag)) { skip = 1; continue; } - if (ma->conf->rflag_filter && ma->conf->rflag_filter&b->core.flag) { skip = 1; continue; } - if (ma->conf->bed) { // test overlap - skip = regidx_overlap(ma->conf->bed, ma->h->target_name[b->core.tid],b->core.pos, bam_endpos(b)-1, NULL) ? 0 : 1; - if (skip) continue; + if (b->core.tid < 0 || (b->core.flag&BAM_FUNMAP)) continue; // exclude unmapped reads + if (ma->conf->rflag_require && !(ma->conf->rflag_require&b->core.flag)) continue; + if (ma->conf->rflag_filter && ma->conf->rflag_filter&b->core.flag) continue; + if (ma->conf->bed) + { + // test overlap + if ( !regidx_overlap(ma->conf->bed, ma->h->target_name[b->core.tid],b->core.pos, bam_endpos(b)-1, NULL) ) continue; } if (ma->rghash_inc) { // skip unless read group is listed uint8_t *rg = bam_aux_get(b, "RG"); - if ( !rg ) { skip = 1; continue; } - if ( !khash_str2int_has_key(ma->rghash_inc, (const char*)(rg+1)) ) { skip = 1; continue; } + if ( !rg ) continue; + if ( !khash_str2int_has_key(ma->rghash_inc, (const char*)(rg+1)) ) continue; } - if (ma->conf->rghash_exc) { // exclude read groups + if ( ma->rghash_exc ) + { + // exclude read groups uint8_t *rg = bam_aux_get(b, "RG"); - skip = (rg && khash_str2int_get(ma->conf->rghash_exc, (const char*)(rg+1), NULL)==0); - if (skip) continue; + if ( rg && khash_str2int_has_key(ma->rghash_exc, (const char*)(rg+1)) ) continue; } if (ma->conf->flag & MPLP_ILLUMINA13) { int i; @@ -198,23 +224,23 @@ static int mplp_func(void *data, bam1_t *b) if (has_ref && ref_len <= b->core.pos) { // exclude reads outside of the reference sequence fprintf(stderr,"[%s] Skipping because %d is outside of %d [ref:%d]\n", __func__, b->core.pos, ref_len, b->core.tid); - skip = 1; continue; } } else { has_ref = 0; } - skip = 0; if (has_ref && (ma->conf->flag&MPLP_REALN)) sam_prob_realn(b, ref, ref_len, (ma->conf->flag & MPLP_REDO_BAQ)? 7 : 3); if (has_ref && ma->conf->capQ_thres > 10) { int q = sam_cap_mapq(b, ref, ref_len, ma->conf->capQ_thres); - if (q < 0) skip = 1; + if (q < 0) continue; // skip else if (b->core.qual > q) b->core.qual = q; } - if (b->core.qual < ma->conf->min_mq) skip = 1; - else if ((ma->conf->flag&MPLP_NO_ORPHAN) && (b->core.flag&BAM_FPAIRED) && !(b->core.flag&BAM_FPROPER_PAIR)) skip = 1; - } while (skip); + if (b->core.qual < ma->conf->min_mq) continue; + else if ((ma->conf->flag&MPLP_NO_ORPHAN) && (b->core.flag&BAM_FPAIRED) && !(b->core.flag&BAM_FPROPER_PAIR)) continue; + + return ret; + }; return ret; } @@ -270,48 +296,70 @@ static void flush_bcf_records(mplp_conf_t *conf, htsFile *fp, bcf_hdr_t *hdr, bc if ( rec ) bcf_write1(fp,hdr,rec); } -/* - * Performs pileup - * @param conf configuration for this pileup - * @param n number of files specified in fn - * @param fn filenames - */ -static int mpileup(mplp_conf_t *conf, int n, char **fn) +static int mpileup_reg(mplp_conf_t *conf, uint32_t beg, uint32_t end) { - extern void *bcf_call_add_rg(void *rghash, const char *hdtext, const char *list); - extern void bcf_call_del_rghash(void *rghash); - mplp_aux_t **data; - int i, tid, pos, *n_plp, beg0 = 0, end0 = INT_MAX, ref_len, max_depth, max_indel_depth; - const bam_pileup1_t **plp; - mplp_ref_t mp_ref = MPLP_REF_INIT; - bam_mplp_t iter; - bam_hdr_t *h = NULL; /* header of first file in input list */ + bam_hdr_t *hdr = conf->mplp_data[0]->h; // header of first file in input list + + int ret, i, tid, pos, ref_len; char *ref; - void *rghash_exc = NULL; - bcf_callaux_t *bca = NULL; - bcf_callret1_t *bcr = NULL; - bcf_call_t bc; - htsFile *bcf_fp = NULL; - bcf_hdr_t *bcf_hdr = NULL; + while ( (ret=bam_mplp_auto(conf->iter, &tid, &pos, conf->n_plp, conf->plp)) > 0) + { + if ( end && (posend) ) continue; + if (conf->bed && tid >= 0 && !regidx_overlap(conf->bed, hdr->target_name[tid], pos, pos, NULL)) continue; + mplp_get_ref(conf->mplp_data[0], tid, &ref, &ref_len); - bam_sample_t *sm = NULL; - kstring_t buf; - mplp_pileup_t gplp; + int total_depth, _ref0, ref16; + for (i = total_depth = 0; i < conf->nfiles; ++i) total_depth += conf->n_plp[i]; + group_smpl(conf->gplp, conf->smpl, &conf->buf, conf->nfiles, conf->files, conf->n_plp, conf->plp, conf->flag & MPLP_IGNORE_RG); + _ref0 = (ref && pos < ref_len)? ref[pos] : 'N'; + ref16 = seq_nt16_table[_ref0]; + bcf_callaux_clean(conf->bca, &conf->bc); + for (i = 0; i < conf->gplp->n; ++i) + bcf_call_glfgen(conf->gplp->n_plp[i], conf->gplp->plp[i], ref16, conf->bca, conf->bcr + i); + conf->bc.tid = tid; conf->bc.pos = pos; + bcf_call_combine(conf->gplp->n, conf->bcr, conf->bca, ref16, &conf->bc); + bcf_clear1(conf->bcf_rec); + bcf_call2bcf(&conf->bc, conf->bcf_rec, conf->bcr, conf->fmt_flag, 0, 0); + flush_bcf_records(conf, conf->bcf_fp, conf->bcf_hdr, conf->bcf_rec); + + // call indels; todo: subsampling with total_depth>max_indel_depth instead of ignoring? + // check me: rghash in bcf_call_gap_prep() should have no effect, reads mplp_func already excludes them + if (!(conf->flag&MPLP_NO_INDEL) && total_depth < conf->max_indel_depth + && bcf_call_gap_prep(conf->gplp->n, conf->gplp->n_plp, conf->gplp->plp, pos, conf->bca, ref) >= 0) + { + bcf_callaux_clean(conf->bca, &conf->bc); + for (i = 0; i < conf->gplp->n; ++i) + bcf_call_glfgen(conf->gplp->n_plp[i], conf->gplp->plp[i], -1, conf->bca, conf->bcr + i); + if (bcf_call_combine(conf->gplp->n, conf->bcr, conf->bca, -1, &conf->bc) >= 0) + { + bcf_clear1(conf->bcf_rec); + bcf_call2bcf(&conf->bc, conf->bcf_rec, conf->bcr, conf->fmt_flag, conf->bca, ref); + flush_bcf_records(conf, conf->bcf_fp, conf->bcf_hdr, conf->bcf_rec); + } + } + } + return 0; +} - memset(&gplp, 0, sizeof(mplp_pileup_t)); - memset(&buf, 0, sizeof(kstring_t)); - memset(&bc, 0, sizeof(bcf_call_t)); - data = (mplp_aux_t**) calloc(n, sizeof(mplp_aux_t*)); - plp = (const bam_pileup1_t**) calloc(n, sizeof(bam_pileup1_t*)); - n_plp = (int*) calloc(n, sizeof(int)); - sm = bam_smpl_init(); +static int mpileup(mplp_conf_t *conf) +{ + extern void *bcf_call_add_rg(void *rghash, const char *hdtext, const char *list); + extern void bcf_call_del_rghash(void *rghash); - if (n == 0) { + if (conf->nfiles == 0) { fprintf(stderr,"[%s] no input file/data given\n", __func__); exit(EXIT_FAILURE); } + mplp_ref_t mp_ref = MPLP_REF_INIT; + conf->gplp = (mplp_pileup_t *) calloc(1,sizeof(mplp_pileup_t)); + conf->mplp_data = (mplp_aux_t**) calloc(conf->nfiles, sizeof(mplp_aux_t*)); + conf->plp = (const bam_pileup1_t**) calloc(conf->nfiles, sizeof(bam_pileup1_t*)); + conf->n_plp = (int*) calloc(conf->nfiles, sizeof(int)); + conf->smpl = bam_smpl_init(); + + int i; void *samples_inc = NULL; if ( conf->samples_list ) { @@ -330,270 +378,313 @@ static int mpileup(mplp_conf_t *conf, int n, char **fn) free(samples); } + // Allow to run mpileup on multiple regions in one go. This comes at cost: the bai index + // must be kept in the memory for the whole time which can be a problem with many bams. + // Therefore if none or only one region is requested, we initialize the bam iterator as + // before and free the index. Only when multiple regions are queried, we keep the index. + regitr_t reg_itr; + REGITR_INIT(reg_itr); + int nregs = 0; + if ( conf->reg_fname ) + { + if ( conf->reg_is_file ) + { + conf->reg = regidx_init(conf->reg_fname,NULL,NULL,0,NULL); + if ( !conf->reg ) { + fprintf(stderr,"Could not parse the regions: %s\n", conf->reg_fname); + exit(EXIT_FAILURE); + } + } + else + { + conf->reg = regidx_init(NULL,regidx_parse_reg,NULL,sizeof(char*),NULL); + if ( regidx_insert_list(conf->reg,conf->reg_fname,',') !=0 ) { + fprintf(stderr,"Could not parse the regions: %s\n", conf->reg_fname); + exit(EXIT_FAILURE); + } + } + nregs = regidx_nregs(conf->reg); + regidx_loop(conf->reg,®_itr); // position the region iterator at the first region + } + // read the header of each file in the list and initialize data - for (i = 0; i < n; ++i) { + // beware: mpileup has always assumed that tid's are consistent in the headers, add sanity check at least! + bam_hdr_t *hdr = NULL; // header of first file in input list + for (i = 0; i < conf->nfiles; ++i) { bam_hdr_t *h_tmp; - data[i] = (mplp_aux_t*) calloc(1, sizeof(mplp_aux_t)); - data[i]->fp = sam_open(fn[i], "rb"); - if ( !data[i]->fp ) + conf->mplp_data[i] = (mplp_aux_t*) calloc(1, sizeof(mplp_aux_t)); + conf->mplp_data[i]->fp = sam_open(conf->files[i], "rb"); + if ( !conf->mplp_data[i]->fp ) { - fprintf(stderr, "[%s] failed to open %s: %s\n", __func__, fn[i], strerror(errno)); + fprintf(stderr, "[%s] failed to open %s: %s\n", __func__, conf->files[i], strerror(errno)); exit(EXIT_FAILURE); } - if (hts_set_opt(data[i]->fp, CRAM_OPT_DECODE_MD, 0)) { + if (hts_set_opt(conf->mplp_data[i]->fp, CRAM_OPT_DECODE_MD, 0)) { fprintf(stderr, "Failed to set CRAM_OPT_DECODE_MD value\n"); exit(EXIT_FAILURE); } - if (conf->fai_fname && hts_set_fai_filename(data[i]->fp, conf->fai_fname) != 0) { + if (conf->fai_fname && hts_set_fai_filename(conf->mplp_data[i]->fp, conf->fai_fname) != 0) { fprintf(stderr, "[%s] failed to process %s: %s\n", __func__, conf->fai_fname, strerror(errno)); exit(EXIT_FAILURE); } - data[i]->conf = conf; - data[i]->ref = &mp_ref; - h_tmp = sam_hdr_read(data[i]->fp); + conf->mplp_data[i]->conf = conf; + conf->mplp_data[i]->ref = &mp_ref; + h_tmp = sam_hdr_read(conf->mplp_data[i]->fp); if ( !h_tmp ) { - fprintf(stderr,"[%s] fail to read the header of %s\n", __func__, fn[i]); + fprintf(stderr,"[%s] fail to read the header of %s\n", __func__, conf->files[i]); exit(EXIT_FAILURE); } - if ( samples_inc ) data[i]->rghash_inc = khash_str2int_init(); - bam_smpl_add(sm, fn[i], (conf->flag&MPLP_IGNORE_RG)? 0 : h_tmp->text, samples_inc, data[i]->rghash_inc); + conf->mplp_data[i]->h = i? hdr : h_tmp; // for i==0, "h" has not been set yet + conf->mplp_data[i]->rghash_exc = conf->rghash_exc; + if ( samples_inc ) conf->mplp_data[i]->rghash_inc = khash_str2int_init(); + bam_smpl_add(conf->smpl, conf->files[i], (conf->flag&MPLP_IGNORE_RG)? 0 : h_tmp->text, samples_inc, conf->mplp_data[i]->rghash_inc); // Collect read group IDs with PL (platform) listed in pl_list (note: fragile, strstr search) - rghash_exc = bcf_call_add_rg(rghash_exc, h_tmp->text, conf->pl_list); + conf->mplp_data[i]->rghash_exc = bcf_call_add_rg(conf->mplp_data[i]->rghash_exc, h_tmp->text, conf->pl_list); if (conf->reg) { - hts_idx_t *idx = sam_index_load(data[i]->fp, fn[i]); + hts_idx_t *idx = sam_index_load(conf->mplp_data[i]->fp, conf->files[i]); if (idx == NULL) { - fprintf(stderr, "[%s] fail to load index for %s\n", __func__, fn[i]); + fprintf(stderr, "[%s] fail to load index for %s\n", __func__, conf->files[i]); exit(EXIT_FAILURE); } - if ( (data[i]->iter=sam_itr_querys(idx, h_tmp, conf->reg)) == 0) { - fprintf(stderr, "[E::%s] fail to parse region '%s' with %s\n", __func__, conf->reg, fn[i]); + conf->buf.l = 0; + ksprintf(&conf->buf,"%s:%u-%u",regitr_seqname(conf->reg,®_itr),REGITR_START(reg_itr)+1,REGITR_END(reg_itr)+1); + conf->mplp_data[i]->iter = sam_itr_querys(idx, conf->mplp_data[i]->h, conf->buf.s); + if ( !conf->mplp_data[i]->iter ) + { + conf->mplp_data[i]->iter = sam_itr_querys(idx, conf->mplp_data[i]->h, regitr_seqname(conf->reg,®_itr)); + if ( conf->mplp_data[i]->iter ) { + fprintf(stderr,"[E::%s] fail to parse region '%s'\n", __func__, conf->buf.s); + exit(EXIT_FAILURE); + } + fprintf(stderr,"[E::%s] the sequence \"%s\" not found: %s\n",__func__,regitr_seqname(conf->reg,®_itr),conf->files[i]); exit(EXIT_FAILURE); } - if (i == 0) beg0 = data[i]->iter->beg, end0 = data[i]->iter->end; - hts_idx_destroy(idx); + if ( nregs==1 ) // no need to keep the index in memory + hts_idx_destroy(idx); + else + conf->mplp_data[i]->idx = idx; } - else - data[i]->iter = NULL; - if (i == 0) h = data[i]->h = h_tmp; // save the header of the first file + if (i == 0) hdr = h_tmp; /* save the header of first file in list */ else { // FIXME: check consistency between h and h_tmp bam_hdr_destroy(h_tmp); // we store only the first file's header; it's (alleged to be) // compatible with the i-th file's target_name lookup needs - data[i]->h = h; + conf->mplp_data[i]->h = hdr; } } // allocate data storage proportionate to number of samples being studied sm->n - gplp.n = sm->n; - gplp.n_plp = (int*) calloc(sm->n, sizeof(int)); - gplp.m_plp = (int*) calloc(sm->n, sizeof(int)); - gplp.plp = (bam_pileup1_t**) calloc(sm->n, sizeof(bam_pileup1_t*)); + conf->gplp->n = conf->smpl->n; + conf->gplp->n_plp = (int*) calloc(conf->smpl->n, sizeof(int)); + conf->gplp->m_plp = (int*) calloc(conf->smpl->n, sizeof(int)); + conf->gplp->plp = (bam_pileup1_t**) calloc(conf->smpl->n, sizeof(bam_pileup1_t*)); - fprintf(stderr, "[%s] %d samples in %d input files\n", __func__, sm->n, n); + fprintf(stderr, "[%s] %d samples in %d input files\n", __func__, conf->smpl->n, conf->nfiles); // write the VCF header - bcf_fp = hts_open(conf->output_fname?conf->output_fname:"-", hts_bcf_wmode(conf->output_type)); - if (bcf_fp == NULL) { + conf->bcf_fp = hts_open(conf->output_fname?conf->output_fname:"-", hts_bcf_wmode(conf->output_type)); + if (conf->bcf_fp == NULL) { fprintf(stderr, "[%s] failed to write to %s: %s\n", __func__, conf->output_fname? conf->output_fname : "standard output", strerror(errno)); exit(EXIT_FAILURE); } // BCF header creation - bcf_hdr = bcf_hdr_init("w"); - kstring_t str = {0,0,NULL}; + conf->bcf_hdr = bcf_hdr_init("w"); + conf->buf.l = 0; - ksprintf(&str, "##bcftoolsVersion=%s+htslib-%s\n",bcftools_version(),hts_version()); - bcf_hdr_append(bcf_hdr, str.s); + ksprintf(&conf->buf, "##bcftoolsVersion=%s+htslib-%s\n",bcftools_version(),hts_version()); + bcf_hdr_append(conf->bcf_hdr, conf->buf.s); - str.l = 0; - ksprintf(&str, "##bcftoolsCommand=mpileup"); - for (i=1; iargc; i++) ksprintf(&str, " %s", conf->argv[i]); - kputc('\n', &str); - bcf_hdr_append(bcf_hdr, str.s); + conf->buf.l = 0; + ksprintf(&conf->buf, "##bcftoolsCommand=mpileup"); + for (i=1; iargc; i++) ksprintf(&conf->buf, " %s", conf->argv[i]); + kputc('\n', &conf->buf); + bcf_hdr_append(conf->bcf_hdr, conf->buf.s); if (conf->fai_fname) { - str.l = 0; - ksprintf(&str, "##reference=file://%s\n", conf->fai_fname); - bcf_hdr_append(bcf_hdr, str.s); + conf->buf.l = 0; + ksprintf(&conf->buf, "##reference=file://%s\n", conf->fai_fname); + bcf_hdr_append(conf->bcf_hdr, conf->buf.s); } // Translate BAM @SQ tags to BCF ##contig tags // todo: use/write new BAM header manipulation routines, fill also UR, M5 - for (i=0; in_targets; i++) + for (i=0; in_targets; i++) { - str.l = 0; - ksprintf(&str, "##contig=", h->target_name[i], h->target_len[i]); - bcf_hdr_append(bcf_hdr, str.s); - } - free(str.s); - bcf_hdr_append(bcf_hdr,"##ALT="); - bcf_hdr_append(bcf_hdr,"##INFO="); - bcf_hdr_append(bcf_hdr,"##INFO="); - bcf_hdr_append(bcf_hdr,"##INFO="); - bcf_hdr_append(bcf_hdr,"##INFO="); - bcf_hdr_append(bcf_hdr,"##INFO="); - bcf_hdr_append(bcf_hdr,"##INFO="); - bcf_hdr_append(bcf_hdr,"##INFO="); - bcf_hdr_append(bcf_hdr,"##INFO="); - bcf_hdr_append(bcf_hdr,"##INFO="); + conf->buf.l = 0; + ksprintf(&conf->buf, "##contig=", hdr->target_name[i], hdr->target_len[i]); + bcf_hdr_append(conf->bcf_hdr, conf->buf.s); + } + conf->buf.l = 0; + + bcf_hdr_append(conf->bcf_hdr,"##ALT="); + bcf_hdr_append(conf->bcf_hdr,"##INFO="); + bcf_hdr_append(conf->bcf_hdr,"##INFO="); + bcf_hdr_append(conf->bcf_hdr,"##INFO="); + bcf_hdr_append(conf->bcf_hdr,"##INFO="); + bcf_hdr_append(conf->bcf_hdr,"##INFO="); + bcf_hdr_append(conf->bcf_hdr,"##INFO="); + bcf_hdr_append(conf->bcf_hdr,"##INFO="); + bcf_hdr_append(conf->bcf_hdr,"##INFO="); + bcf_hdr_append(conf->bcf_hdr,"##INFO="); #if CDF_MWU_TESTS - bcf_hdr_append(bcf_hdr,"##INFO="); - bcf_hdr_append(bcf_hdr,"##INFO="); - bcf_hdr_append(bcf_hdr,"##INFO="); - bcf_hdr_append(bcf_hdr,"##INFO="); + bcf_hdr_append(conf->bcf_hdr,"##INFO="); + bcf_hdr_append(conf->bcf_hdr,"##INFO="); + bcf_hdr_append(conf->bcf_hdr,"##INFO="); + bcf_hdr_append(conf->bcf_hdr,"##INFO="); #endif - bcf_hdr_append(bcf_hdr,"##INFO="); - bcf_hdr_append(bcf_hdr,"##INFO="); - bcf_hdr_append(bcf_hdr,"##INFO="); - bcf_hdr_append(bcf_hdr,"##INFO="); - bcf_hdr_append(bcf_hdr,"##FORMAT="); + bcf_hdr_append(conf->bcf_hdr,"##INFO="); + bcf_hdr_append(conf->bcf_hdr,"##INFO="); + bcf_hdr_append(conf->bcf_hdr,"##INFO="); + bcf_hdr_append(conf->bcf_hdr,"##INFO="); + bcf_hdr_append(conf->bcf_hdr,"##FORMAT="); if ( conf->fmt_flag&B2B_FMT_DP ) - bcf_hdr_append(bcf_hdr,"##FORMAT="); + bcf_hdr_append(conf->bcf_hdr,"##FORMAT="); if ( conf->fmt_flag&B2B_FMT_DV ) - bcf_hdr_append(bcf_hdr,"##FORMAT="); + bcf_hdr_append(conf->bcf_hdr,"##FORMAT="); if ( conf->fmt_flag&B2B_FMT_DPR ) - bcf_hdr_append(bcf_hdr,"##FORMAT="); + bcf_hdr_append(conf->bcf_hdr,"##FORMAT="); if ( conf->fmt_flag&B2B_INFO_DPR ) - bcf_hdr_append(bcf_hdr,"##INFO="); + bcf_hdr_append(conf->bcf_hdr,"##INFO="); if ( conf->fmt_flag&B2B_FMT_DP4 ) - bcf_hdr_append(bcf_hdr,"##FORMAT="); + bcf_hdr_append(conf->bcf_hdr,"##FORMAT="); if ( conf->fmt_flag&B2B_FMT_SP ) - bcf_hdr_append(bcf_hdr,"##FORMAT="); + bcf_hdr_append(conf->bcf_hdr,"##FORMAT="); if ( conf->fmt_flag&B2B_FMT_AD ) - bcf_hdr_append(bcf_hdr,"##FORMAT="); + bcf_hdr_append(conf->bcf_hdr,"##FORMAT="); if ( conf->fmt_flag&B2B_FMT_ADF ) - bcf_hdr_append(bcf_hdr,"##FORMAT="); + bcf_hdr_append(conf->bcf_hdr,"##FORMAT="); if ( conf->fmt_flag&B2B_FMT_ADR ) - bcf_hdr_append(bcf_hdr,"##FORMAT="); + bcf_hdr_append(conf->bcf_hdr,"##FORMAT="); if ( conf->fmt_flag&B2B_INFO_AD ) - bcf_hdr_append(bcf_hdr,"##INFO="); + bcf_hdr_append(conf->bcf_hdr,"##INFO="); if ( conf->fmt_flag&B2B_INFO_ADF ) - bcf_hdr_append(bcf_hdr,"##INFO="); + bcf_hdr_append(conf->bcf_hdr,"##INFO="); if ( conf->fmt_flag&B2B_INFO_ADR ) - bcf_hdr_append(bcf_hdr,"##INFO="); + bcf_hdr_append(conf->bcf_hdr,"##INFO="); if ( conf->gvcf ) - gvcf_update_header(conf->gvcf, bcf_hdr); - - for (i=0; in; i++) - bcf_hdr_add_sample(bcf_hdr, sm->smpl[i]); - bcf_hdr_add_sample(bcf_hdr, NULL); - bcf_hdr_write(bcf_fp, bcf_hdr); - // End of BCF header creation - - // Initialise the calling algorithm - bca = bcf_call_init(-1., conf->min_baseQ); - bcr = (bcf_callret1_t*) calloc(sm->n, sizeof(bcf_callret1_t)); - bca->openQ = conf->openQ, bca->extQ = conf->extQ, bca->tandemQ = conf->tandemQ; - bca->min_frac = conf->min_frac; - bca->min_support = conf->min_support; - bca->per_sample_flt = conf->flag & MPLP_PER_SAMPLE; - - bc.bcf_hdr = bcf_hdr; - bc.n = sm->n; - bc.PL = (int32_t*) malloc(15 * sm->n * sizeof(*bc.PL)); + gvcf_update_header(conf->gvcf, conf->bcf_hdr); + + for (i=0; ismpl->n; i++) + bcf_hdr_add_sample(conf->bcf_hdr, conf->smpl->smpl[i]); + bcf_hdr_add_sample(conf->bcf_hdr, NULL); + bcf_hdr_write(conf->bcf_fp, conf->bcf_hdr); + + conf->bca = bcf_call_init(-1., conf->min_baseQ); + conf->bcr = (bcf_callret1_t*) calloc(conf->smpl->n, sizeof(bcf_callret1_t)); + conf->bca->openQ = conf->openQ, conf->bca->extQ = conf->extQ, conf->bca->tandemQ = conf->tandemQ; + conf->bca->min_frac = conf->min_frac; + conf->bca->min_support = conf->min_support; + conf->bca->per_sample_flt = conf->flag & MPLP_PER_SAMPLE; + + conf->bc.bcf_hdr = conf->bcf_hdr; + conf->bc.n = conf->smpl->n; + conf->bc.PL = (int32_t*) malloc(15 * conf->smpl->n * sizeof(*conf->bc.PL)); if (conf->fmt_flag) { assert( sizeof(float)==sizeof(int32_t) ); - bc.DP4 = (int32_t*) malloc(sm->n * sizeof(int32_t) * 4); - bc.fmt_arr = (uint8_t*) malloc(sm->n * sizeof(float)); // all fmt_flag fields + conf->bc.DP4 = (int32_t*) malloc(conf->smpl->n * sizeof(int32_t) * 4); + conf->bc.fmt_arr = (uint8_t*) malloc(conf->smpl->n * sizeof(float)); // all fmt_flag fields, float and int32 if ( conf->fmt_flag&(B2B_INFO_DPR|B2B_FMT_DPR|B2B_INFO_AD|B2B_INFO_ADF|B2B_INFO_ADR|B2B_FMT_AD|B2B_FMT_ADF|B2B_FMT_ADR) ) { // first B2B_MAX_ALLELES fields for total numbers, the rest per-sample - bc.ADR = (int32_t*) malloc((sm->n+1)*B2B_MAX_ALLELES*sizeof(int32_t)); - bc.ADF = (int32_t*) malloc((sm->n+1)*B2B_MAX_ALLELES*sizeof(int32_t)); - for (i=0; in; i++) + conf->bc.ADR = (int32_t*) malloc((conf->smpl->n+1)*B2B_MAX_ALLELES*sizeof(int32_t)); + conf->bc.ADF = (int32_t*) malloc((conf->smpl->n+1)*B2B_MAX_ALLELES*sizeof(int32_t)); + for (i=0; ismpl->n; i++) { - bcr[i].ADR = bc.ADR + (i+1)*B2B_MAX_ALLELES; - bcr[i].ADF = bc.ADF + (i+1)*B2B_MAX_ALLELES; + conf->bcr[i].ADR = conf->bc.ADR + (i+1)*B2B_MAX_ALLELES; + conf->bcr[i].ADF = conf->bc.ADF + (i+1)*B2B_MAX_ALLELES; } } } - // init pileup - iter = bam_mplp_init(n, mplp_func, (void**)data); - if ( conf->flag & MPLP_SMART_OVERLAPS ) bam_mplp_init_overlaps(iter); - max_depth = conf->max_depth; - if (max_depth * sm->n > 1<<20) + // init mpileup + conf->iter = bam_mplp_init(conf->nfiles, mplp_func, (void**)conf->mplp_data); + if ( conf->flag & MPLP_SMART_OVERLAPS ) bam_mplp_init_overlaps(conf->iter); + if ( conf->max_depth * conf->smpl->n > 1<<20) fprintf(stderr, "(%s) Max depth is above 1M. Potential memory hog!\n", __func__); - if (max_depth * sm->n < 8000) { - max_depth = 8000 / sm->n; - fprintf(stderr, "<%s> Set max per-file depth to %d\n", __func__, max_depth); + if ( conf->max_depth * conf->smpl->n < 8000) { + conf->max_depth = 8000 / conf->smpl->n; + fprintf(stderr, "<%s> Set max per-file depth to %d\n", __func__, conf->max_depth); } - max_indel_depth = conf->max_indel_depth * sm->n; - bam_mplp_set_maxcnt(iter, max_depth); - bcf1_t *bcf_rec = bcf_init1(); - int ret; - // begin pileup - while ( (ret=bam_mplp_auto(iter, &tid, &pos, n_plp, plp)) > 0) { - if (conf->reg && (pos < beg0 || pos >= end0)) continue; // out of the region requested - if (conf->bed && tid >= 0 && !regidx_overlap(conf->bed, h->target_name[tid], pos, pos, NULL)) continue; - mplp_get_ref(data[0], tid, &ref, &ref_len); - //printf("tid=%d len=%d ref=%p/%s\n", tid, ref_len, ref, ref); - int total_depth, _ref0, ref16; - for (i = total_depth = 0; i < n; ++i) total_depth += n_plp[i]; - group_smpl(&gplp, sm, &buf, n, fn, n_plp, plp, conf->flag & MPLP_IGNORE_RG); - _ref0 = (ref && pos < ref_len)? ref[pos] : 'N'; - ref16 = seq_nt16_table[_ref0]; - bcf_callaux_clean(bca, &bc); - for (i = 0; i < gplp.n; ++i) - bcf_call_glfgen(gplp.n_plp[i], gplp.plp[i], ref16, bca, bcr + i); - bc.tid = tid; bc.pos = pos; - bcf_call_combine(gplp.n, bcr, bca, ref16, &bc); - bcf_clear1(bcf_rec); - bcf_call2bcf(&bc, bcf_rec, bcr, conf->fmt_flag, 0, 0); - flush_bcf_records(conf, bcf_fp, bcf_hdr, bcf_rec); - // call indels; todo: subsampling with total_depth>max_indel_depth instead of ignoring? - // check me: rghash in bcf_call_gap_prep() should have no effect, reads mplp_func already excludes them - if (!(conf->flag&MPLP_NO_INDEL) && total_depth < max_indel_depth && bcf_call_gap_prep(gplp.n, gplp.n_plp, gplp.plp, pos, bca, ref, NULL) >= 0) + bam_mplp_set_maxcnt(conf->iter, conf->max_depth); + conf->max_indel_depth = conf->max_indel_depth * conf->smpl->n; + conf->bcf_rec = bcf_init1(); + + // Run mpileup for multiple regions + if ( nregs ) + { + int ireg = 0; + do { - bcf_callaux_clean(bca, &bc); - for (i = 0; i < gplp.n; ++i) - bcf_call_glfgen(gplp.n_plp[i], gplp.plp[i], -1, bca, bcr + i); - if (bcf_call_combine(gplp.n, bcr, bca, -1, &bc) >= 0) { - bcf_clear1(bcf_rec); - bcf_call2bcf(&bc, bcf_rec, bcr, conf->fmt_flag, bca, ref); - flush_bcf_records(conf, bcf_fp, bcf_hdr, bcf_rec); + // first region is already positioned + if ( ireg++ > 0 ) + { + conf->buf.l = 0; + ksprintf(&conf->buf,"%s:%u-%u",regitr_seqname(conf->reg,®_itr),REGITR_START(reg_itr),REGITR_END(reg_itr)); + + for (i=0; infiles; i++) + { + hts_itr_destroy(conf->mplp_data[i]->iter); + conf->mplp_data[i]->iter = sam_itr_querys(conf->mplp_data[i]->idx, conf->mplp_data[i]->h, conf->buf.s); + if ( !conf->mplp_data[i]->iter ) + { + conf->mplp_data[i]->iter = sam_itr_querys(conf->mplp_data[i]->idx, conf->mplp_data[i]->h, regitr_seqname(conf->reg,®_itr)); + if ( conf->mplp_data[i]->iter ) { + fprintf(stderr,"[E::%s] fail to parse region '%s'\n", __func__, conf->buf.s); + exit(EXIT_FAILURE); + } + fprintf(stderr,"[E::%s] the sequence \"%s\" not found: %s\n",__func__,regitr_seqname(conf->reg,®_itr),conf->files[i]); + exit(EXIT_FAILURE); + } + bam_mplp_reset(conf->iter); + } } + mpileup_reg(conf,REGITR_START(reg_itr),REGITR_END(reg_itr)); } + while ( regidx_loop(conf->reg,®_itr) ); } - flush_bcf_records(conf, bcf_fp, bcf_hdr, NULL); + else + mpileup_reg(conf,0,0); + + flush_bcf_records(conf, conf->bcf_fp, conf->bcf_hdr, NULL); // clean up - free(bc.tmp.s); - bcf_destroy1(bcf_rec); - if (bcf_fp) + free(conf->bc.tmp.s); + bcf_destroy1(conf->bcf_rec); + if (conf->bcf_fp) { - hts_close(bcf_fp); - bcf_hdr_destroy(bcf_hdr); - bcf_call_destroy(bca); - free(bc.PL); - free(bc.DP4); - free(bc.ADR); - free(bc.ADF); - free(bc.fmt_arr); - free(bcr); + hts_close(conf->bcf_fp); + bcf_hdr_destroy(conf->bcf_hdr); + bcf_call_destroy(conf->bca); + free(conf->bc.PL); + free(conf->bc.DP4); + free(conf->bc.ADR); + free(conf->bc.ADF); + free(conf->bc.fmt_arr); + free(conf->bcr); } if ( conf->gvcf ) gvcf_destroy(conf->gvcf); - bam_smpl_destroy(sm); free(buf.s); - for (i = 0; i < gplp.n; ++i) free(gplp.plp[i]); - free(gplp.plp); free(gplp.n_plp); free(gplp.m_plp); - bcf_call_del_rghash(rghash_exc); - bam_mplp_destroy(iter); - bam_hdr_destroy(h); - for (i = 0; i < n; ++i) { - sam_close(data[i]->fp); - if (data[i]->iter) hts_itr_destroy(data[i]->iter); - if ( data[i]->rghash_inc ) khash_str2int_destroy_free(data[i]->rghash_inc); - free(data[i]); + bam_smpl_destroy(conf->smpl); free(conf->buf.s); + for (i = 0; i < conf->gplp->n; ++i) free(conf->gplp->plp[i]); + free(conf->gplp->plp); free(conf->gplp->n_plp); free(conf->gplp->m_plp); free(conf->gplp); + bam_mplp_destroy(conf->iter); + bam_hdr_destroy(hdr); + for (i = 0; i < conf->nfiles; ++i) { + if ( nregs>1 ) hts_idx_destroy(conf->mplp_data[i]->idx); + sam_close(conf->mplp_data[i]->fp); + if ( conf->mplp_data[i]->iter) hts_itr_destroy(conf->mplp_data[i]->iter); + if ( conf->mplp_data[i]->rghash_inc ) khash_str2int_destroy_free(conf->mplp_data[i]->rghash_inc); + free(conf->mplp_data[i]); } - free(data); free(plp); free(n_plp); + free(conf->mplp_data); free(conf->plp); free(conf->n_plp); if ( samples_inc ) khash_str2int_destroy_free(samples_inc); free(mp_ref.ref[0]); free(mp_ref.ref[1]); - return ret; + return 0; } #define MAX_PATH_LEN 1024 @@ -732,7 +823,8 @@ static void print_usage(FILE *fp, const mplp_conf_t *mplp) fprintf(fp, " -Q, --min-BQ INT skip bases with baseQ/BAQ smaller than INT [%d]\n", mplp->min_baseQ); fprintf(fp, -" -r, --region REG region in which pileup is generated\n" +" -r, --regions REG[,...] comma separated list of regions in which pileup is generated\n" +" -R, --regions-file FILE restrict to regions listed in a file\n" " --ignore-RG ignore RG tags (one BAM = one sample)\n" " --rf, --incl-flags STR|INT required flags: skip reads with mask bits unset [%s]\n", tmp_require); fprintf(fp, @@ -820,6 +912,8 @@ int bam_mpileup(int argc, char *argv[]) {"exclude-rg", required_argument, NULL, 'G'}, {"positions", required_argument, NULL, 'l'}, {"region", required_argument, NULL, 'r'}, + {"regions", required_argument, NULL, 'r'}, + {"regions-file", required_argument, NULL, 'R'}, {"min-MQ", required_argument, NULL, 'q'}, {"min-mq", required_argument, NULL, 'q'}, {"min-BQ", required_argument, NULL, 'Q'}, @@ -840,7 +934,7 @@ int bam_mpileup(int argc, char *argv[]) {"platforms", required_argument, NULL, 'P'}, {NULL, 0, NULL, 0} }; - while ((c = getopt_long(argc, argv, "Ag:f:r:l:q:Q:C:Bd:L:b:P:po:e:h:Im:F:EG:6O:xa:s:S:",lopts,NULL)) >= 0) { + while ((c = getopt_long(argc, argv, "Ag:f:r:R:l:q:Q:C:Bd:L:b:P:po:e:h:Im:F:EG:6O:xa:s:S:",lopts,NULL)) >= 0) { switch (c) { case 'x': mplp.flag &= ~MPLP_SMART_OVERLAPS; break; case 1 : @@ -864,7 +958,8 @@ int bam_mpileup(int argc, char *argv[]) mplp.fai_fname = optarg; break; case 'd': mplp.max_depth = atoi(optarg); break; - case 'r': mplp.reg = strdup(optarg); break; + case 'r': mplp.reg_fname = strdup(optarg); break; + case 'R': mplp.reg_fname = strdup(optarg); mplp.reg_is_file = 1; break; case 'l': // In the original version the whole BAM was streamed which is inefficient // with few BED intervals and big BAMs. Todo: devise a heuristic to determine @@ -964,17 +1059,25 @@ int bam_mpileup(int argc, char *argv[]) return 1; } int ret; - if (file_list) { + if (file_list) + { if ( read_file_list(file_list,&nfiles,&fn) ) return 1; - ret = mpileup(&mplp,nfiles,fn); + mplp.files = fn; + mplp.nfiles = nfiles; + ret = mpileup(&mplp); for (c=0; c[qw(1 2 3)],out=>'mpileup/mpileup.4.out',args=>q[-a DP,DPR,DV,DP4,INFO/DPR,SP -r17:100-600]); #test files from samtools mpileup test suite test_mpileup($opts,in=>[qw(1 2 3)],out=>'mpileup/mpileup.5.out',args=>q[-a DP,AD,ADF,ADR,SP,INFO/AD,INFO/ADF,INFO/ADR -r17:100-600]); test_mpileup($opts,in=>[qw(1 2 3)],out=>'mpileup/mpileup.6.out',args=>q[-a DP,DV -r17:100-600 --gvcf 0,2,5]); +test_mpileup($opts,in=>[qw(1 2 3)],out=>'mpileup/mpileup.6.out',args=>q[-a DP,DV -r17:100-200,17:201-300,17:301-400,17:401-500,17:501-600 --gvcf 0,2,5]); test_mpileup($opts,in=>[qw(1 2 3)],out=>'mpileup/mpileup.7.out',args=>q[-r17:100-150 -s HG00101,HG00102]); test_mpileup($opts,in=>[qw(1 2 3)],out=>'mpileup/mpileup.7.out',args=>q[-r17:100-150 -S {PATH}/mplp.samples]); From ceb0a20edc0b7c0384d3c9a1330a9f1704f9176f Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Wed, 22 Jun 2016 10:38:52 +0100 Subject: [PATCH 203/211] mpileup: in read_file_list(), check for URL syntax or extant files see samtools/samtools@91283dd2093f7ce7a2e1bda34db72f12df2aa7ae --- mpileup.c | 9 ++++++++- test/test.pl | 28 +++++++++++++++++++++++++++- 2 files changed, 35 insertions(+), 2 deletions(-) diff --git a/mpileup.c b/mpileup.c index cfccde46b..f76f12e57 100644 --- a/mpileup.c +++ b/mpileup.c @@ -687,6 +687,13 @@ static int mpileup(mplp_conf_t *conf) return 0; } +static int is_url(const char *s) +{ + static const char uri_scheme_chars[] = + "ABCDEFGHIJKLMNOPQRSTUVWXYZabcdefghijklmnopqrstuvwxyz0123456789+.-"; + return s[strspn(s, uri_scheme_chars)] == ':'; +} + #define MAX_PATH_LEN 1024 int read_file_list(const char *file_list,int *n,char **argv[]) { @@ -716,7 +723,7 @@ int read_file_list(const char *file_list,int *n,char **argv[]) // check sanity of the file list buf[len] = 0; - if (stat(buf, &sb) != 0) + if (! (is_url(buf) || stat(buf, &sb) == 0)) { // no such file, check if it is safe to print its name int i, safe_to_print = 1; diff --git a/test/test.pl b/test/test.pl index b6ea2304d..5304e1575 100755 --- a/test/test.pl +++ b/test/test.pl @@ -30,6 +30,7 @@ use lib "$FindBin::Bin"; use Getopt::Long; use File::Temp qw/ tempfile tempdir /; +use Cwd qw/ abs_path /; my $opts = parse_params(); @@ -249,7 +250,7 @@ test_vcf_consensus($opts,in=>'consensus2',out=>'consensus2.1.out',fa=>'consensus2.fa',args=>'-H 1'); test_vcf_consensus($opts,in=>'consensus2',out=>'consensus2.2.out',fa=>'consensus2.fa',args=>'-H 2'); test_vcf_consensus($opts,in=>'empty',out=>'consensus.5.out',fa=>'consensus.fa',args=>''); -test_mpileup($opts,in=>[qw(1 2 3)],out=>'mpileup/mpileup.1.out',args=>q[-r17:100-150]); +test_mpileup($opts,in=>[qw(1 2 3)],out=>'mpileup/mpileup.1.out',args=>q[-r17:100-150],test_list=>1); test_mpileup($opts,in=>[qw(1 2 3)],out=>'mpileup/mpileup.2.out',args=>q[-a DP,DV -r17:100-600]); # test files from samtools mpileup test suite test_mpileup($opts,in=>[qw(1)],out=>'mpileup/mpileup.3.out',args=>q[-B --ff 0x14 -r17:1050-1060]); # test file converted to vcf from samtools mpileup test suite test_mpileup($opts,in=>[qw(1 2 3)],out=>'mpileup/mpileup.4.out',args=>q[-a DP,DPR,DV,DP4,INFO/DPR,SP -r17:100-600]); #test files from samtools mpileup test suite @@ -935,6 +936,26 @@ sub test_mpileup { my ($opts,%args) = @_; + if ($args{test_list}) + { + # make a local copy, create bams, index the bams and the reference + open(my $fh1,'>',"$$opts{tmp}/mpileup.bam.list") or error("$$opts{tmp}/mpileup.bam.list: $!"); + open(my $fh2,'>',"$$opts{tmp}/mpileup.cram.list") or error("$$opts{tmp}/mpileup.cram.list: $!"); + open(my $fh3,'>',"$$opts{tmp}/mpileup.bam.urllist") or error("$$opts{tmp}/mpileup.bam.urllist: $!"); + open(my $fh4,'>',"$$opts{tmp}/mpileup.cram.urllist") or error("$$opts{tmp}/mpileup.cram.urllist: $!"); + for my $file (@{$args{in}}) + { + print $fh1 "$$opts{path}/mpileup/mpileup.$file.bam\n"; + print $fh2 "$$opts{path}/mpileup/mpileup.$file.cram\n"; + print $fh3 "file://", abs_path("$$opts{path}/mpileup/mpileup.$file.bam"), "\n"; + print $fh4 "file://", abs_path("$$opts{path}/mpileup/mpileup.$file.cram"), "\n"; + } + close($fh1); + close($fh2); + close($fh3); + close($fh4); + } + $args{args} =~ s/{PATH}/$$opts{path}/g; for my $fmt ('bam','cram') { @@ -944,5 +965,10 @@ sub test_mpileup my $grep_hdr = "grep -v ^##bcftools | grep -v ^##reference"; test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools mpileup $args{args} -f $$opts{path}/mpileup/mpileup.ref.fa $files 2>/dev/null | $grep_hdr"); test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools mpileup $args{args} -f $$opts{path}/mpileup/mpileup.ref.fa -Ob $files 2>/dev/null | $$opts{bin}/bcftools view | $grep_hdr"); + if ($args{test_list}) + { + test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools mpileup $args{args} -f $$opts{path}/mpileup/mpileup.ref.fa -b $$opts{tmp}/mpileup.$fmt.list 2>/dev/null | $grep_hdr"); + test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools mpileup $args{args} -f $$opts{path}/mpileup/mpileup.ref.fa -Ob -b $$opts{tmp}/mpileup.$fmt.urllist 2>/dev/null | $$opts{bin}/bcftools view | $grep_hdr"); + } } } From 46479b6a01b8d17b54eea35e2cf954e4a6596435 Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Wed, 22 Jun 2016 11:47:53 +0100 Subject: [PATCH 204/211] mpileup: add `--no-version` and `--threads` options as for other bcftools commands the point of `--no-version` is to remove invocation specify metadata in the header lines for pipeline systems that are tracking this separately. we are outputting the `##reference` line though in mpileup. could drop this as well when `--no-version` used. seems silly to add a separate option. --- doc/bcftools.txt | 6 ++++++ mpileup.c | 28 ++++++++++++++++++++-------- test/test.pl | 2 +- 3 files changed, 27 insertions(+), 9 deletions(-) diff --git a/doc/bcftools.txt b/doc/bcftools.txt index 1e966ae9d..d0e67b8e4 100644 --- a/doc/bcftools.txt +++ b/doc/bcftools.txt @@ -1431,6 +1431,9 @@ regions listed in the BED file. depth less than 5 will be printed as separate records, outside of gVCF blocks. +*--no-version*:: + see *<>* + *-o, --output* 'FILE':: Write output to 'FILE', rather than the default of standard output. (The same short option is used for both *--open-prob* and *--output*. If *-o*'s @@ -1442,6 +1445,9 @@ regions listed in the BED file. *-O, --output-type* 'b'|'u'|'z'|'v':: see *<>* +*--threads* 'INT':: + see *<>* + ==== Options for SNP/INDEL genotype likelihood computation *-e, --ext-prob* 'INT':: diff --git a/mpileup.c b/mpileup.c index f76f12e57..68c7d1ff8 100644 --- a/mpileup.c +++ b/mpileup.c @@ -68,7 +68,7 @@ typedef struct { int openQ, extQ, tandemQ, min_support; // for indels double min_frac; // for indels char *reg_fname, *pl_list, *fai_fname, *output_fname, *samples_list; - int reg_is_file; + int reg_is_file, record_cmd_line, n_threads; faidx_t *fai; regidx_t *bed, *reg; // bed: skipping regions, reg: index-jump to regions gvcf_t *gvcf; @@ -489,19 +489,23 @@ static int mpileup(mplp_conf_t *conf) fprintf(stderr, "[%s] failed to write to %s: %s\n", __func__, conf->output_fname? conf->output_fname : "standard output", strerror(errno)); exit(EXIT_FAILURE); } + if ( conf->n_threads ) hts_set_threads(conf->bcf_fp, conf->n_threads); // BCF header creation conf->bcf_hdr = bcf_hdr_init("w"); conf->buf.l = 0; - ksprintf(&conf->buf, "##bcftoolsVersion=%s+htslib-%s\n",bcftools_version(),hts_version()); - bcf_hdr_append(conf->bcf_hdr, conf->buf.s); + if (conf->record_cmd_line) + { + ksprintf(&conf->buf, "##bcftoolsVersion=%s+htslib-%s\n",bcftools_version(),hts_version()); + bcf_hdr_append(conf->bcf_hdr, conf->buf.s); - conf->buf.l = 0; - ksprintf(&conf->buf, "##bcftoolsCommand=mpileup"); - for (i=1; iargc; i++) ksprintf(&conf->buf, " %s", conf->argv[i]); - kputc('\n', &conf->buf); - bcf_hdr_append(conf->bcf_hdr, conf->buf.s); + conf->buf.l = 0; + ksprintf(&conf->buf, "##bcftoolsCommand=mpileup"); + for (i=1; iargc; i++) ksprintf(&conf->buf, " %s", conf->argv[i]); + kputc('\n', &conf->buf); + bcf_hdr_append(conf->bcf_hdr, conf->buf.s); + } if (conf->fai_fname) { @@ -846,9 +850,11 @@ static void print_usage(FILE *fp, const mplp_conf_t *mplp) " -a, --annotate LIST optional tags to output; '?' to list []\n" " -g, --gvcf INT[,...] group non-variant sites into gVCF blocks according\n" " to minimum per-sample DP\n" +" --no-version do not append version and command line to the header\n" " -o, --output FILE write output to FILE [standard output]\n" " -O, --output-type TYPE 'b' compressed BCF; 'u' uncompressed BCF;\n" " 'z' compressed VCF; 'v' uncompressed VCF [v]\n" +" --threads INT number of extra output compression threads [0]\n" "\n" "SNP/INDEL genotype likelihoods options:\n" " -e, --ext-prob INT Phred-scaled gap extension seq error probability [%d]\n", mplp->extQ); @@ -892,6 +898,8 @@ int bam_mpileup(int argc, char *argv[]) mplp.rflag_filter = BAM_FUNMAP | BAM_FSECONDARY | BAM_FQCFAIL | BAM_FDUP; mplp.output_fname = NULL; mplp.output_type = FT_VCF; + mplp.record_cmd_line = 1; + mplp.n_threads = 0; static const struct option lopts[] = { @@ -904,6 +912,8 @@ int bam_mpileup(int argc, char *argv[]) {"ignore-RG", no_argument, NULL, 5}, {"ignore-rg", no_argument, NULL, 5}, {"gvcf", required_argument, NULL, 7}, + {"no-version", no_argument, NULL, 8}, + {"threads",required_argument,NULL,9}, {"illumina1.3+", no_argument, NULL, '6'}, {"count-orphans", no_argument, NULL, 'A'}, {"bam-list", required_argument, NULL, 'b'}, @@ -964,6 +974,8 @@ int bam_mpileup(int argc, char *argv[]) if (mplp.fai == NULL) return 1; mplp.fai_fname = optarg; break; + case 8 : mplp.record_cmd_line = 0; break; + case 9 : mplp.n_threads = strtol(optarg, 0, 0); break; case 'd': mplp.max_depth = atoi(optarg); break; case 'r': mplp.reg_fname = strdup(optarg); break; case 'R': mplp.reg_fname = strdup(optarg); mplp.reg_is_file = 1; break; diff --git a/test/test.pl b/test/test.pl index 5304e1575..542d72c3b 100755 --- a/test/test.pl +++ b/test/test.pl @@ -967,7 +967,7 @@ sub test_mpileup test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools mpileup $args{args} -f $$opts{path}/mpileup/mpileup.ref.fa -Ob $files 2>/dev/null | $$opts{bin}/bcftools view | $grep_hdr"); if ($args{test_list}) { - test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools mpileup $args{args} -f $$opts{path}/mpileup/mpileup.ref.fa -b $$opts{tmp}/mpileup.$fmt.list 2>/dev/null | $grep_hdr"); + test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools mpileup $args{args} -f $$opts{path}/mpileup/mpileup.ref.fa -b $$opts{tmp}/mpileup.$fmt.list --no-version 2>/dev/null | grep -v ^##reference"); test_cmd($opts,%args,cmd=>"$$opts{bin}/bcftools mpileup $args{args} -f $$opts{path}/mpileup/mpileup.ref.fa -Ob -b $$opts{tmp}/mpileup.$fmt.urllist 2>/dev/null | $$opts{bin}/bcftools view | $grep_hdr"); } } From c5520606270ce31d602822225ca9b7a2f11f0116 Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Thu, 23 Jun 2016 08:59:42 +0100 Subject: [PATCH 205/211] mpileup: enable `-g` short `--gvcf` option that was missed --- mpileup.c | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/mpileup.c b/mpileup.c index 68c7d1ff8..057ba42cf 100644 --- a/mpileup.c +++ b/mpileup.c @@ -911,7 +911,7 @@ int bam_mpileup(int argc, char *argv[]) {"open-prob", required_argument, NULL, 4}, {"ignore-RG", no_argument, NULL, 5}, {"ignore-rg", no_argument, NULL, 5}, - {"gvcf", required_argument, NULL, 7}, + {"gvcf", required_argument, NULL, 'g'}, {"no-version", no_argument, NULL, 8}, {"threads",required_argument,NULL,9}, {"illumina1.3+", no_argument, NULL, '6'}, @@ -965,7 +965,7 @@ int bam_mpileup(int argc, char *argv[]) case 3 : mplp.output_fname = optarg; break; case 4 : mplp.openQ = atoi(optarg); break; case 5 : mplp.flag |= MPLP_IGNORE_RG; break; - case 7 : + case 'g': mplp.gvcf = gvcf_init(optarg); if ( !mplp.gvcf ) error("Could not parse: --gvcf %s\n", optarg); break; From 2607f11bdc2df8daaa637d639c67f14a27867208 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Thu, 23 Jun 2016 11:00:13 +0100 Subject: [PATCH 206/211] mpileup: exclude samples when prefixed with ^ --- mpileup.c | 24 ++++++++----- sample.c | 14 ++++++-- sample.h | 2 +- test/mpileup/mpileup.8.out | 70 ++++++++++++++++++++++++++++++++++++++ test/test.pl | 2 ++ 5 files changed, 99 insertions(+), 13 deletions(-) create mode 100644 test/mpileup/mpileup.8.out diff --git a/mpileup.c b/mpileup.c index 057ba42cf..31e5433f7 100644 --- a/mpileup.c +++ b/mpileup.c @@ -359,20 +359,26 @@ static int mpileup(mplp_conf_t *conf) conf->n_plp = (int*) calloc(conf->nfiles, sizeof(int)); conf->smpl = bam_smpl_init(); - int i; - void *samples_inc = NULL; + int i, samples_logic = 1; // 1: include, 0: exclude + void *samples_list = NULL; // hash of sample names to include or exclude if ( conf->samples_list ) { int nsamples = 0; - char **samples = hts_readlist(conf->samples_list, conf->sample_is_file, &nsamples); + char *list = conf->samples_list; + if ( list[0]=='^' ) + { + list++; + samples_logic = 0; + } + char **samples = hts_readlist(list, conf->sample_is_file, &nsamples); if (!samples) { - fprintf(stderr,"[%s] could not read the samples list %s\n", __func__, conf->samples_list); + fprintf(stderr,"[%s] could not read the samples list %s\n", __func__, list); exit(EXIT_FAILURE); } - if ( nsamples ) samples_inc = khash_str2int_init(); + if ( nsamples ) samples_list = khash_str2int_init(); for (i=0; implp_data[i]->h = i? hdr : h_tmp; // for i==0, "h" has not been set yet conf->mplp_data[i]->rghash_exc = conf->rghash_exc; - if ( samples_inc ) conf->mplp_data[i]->rghash_inc = khash_str2int_init(); - bam_smpl_add(conf->smpl, conf->files[i], (conf->flag&MPLP_IGNORE_RG)? 0 : h_tmp->text, samples_inc, conf->mplp_data[i]->rghash_inc); + if ( samples_list ) conf->mplp_data[i]->rghash_inc = khash_str2int_init(); + bam_smpl_add(conf->smpl, conf->files[i], (conf->flag&MPLP_IGNORE_RG)? 0 : h_tmp->text, samples_list, samples_logic, conf->mplp_data[i]->rghash_inc); // Collect read group IDs with PL (platform) listed in pl_list (note: fragile, strstr search) conf->mplp_data[i]->rghash_exc = bcf_call_add_rg(conf->mplp_data[i]->rghash_exc, h_tmp->text, conf->pl_list); if (conf->reg) { @@ -685,7 +691,7 @@ static int mpileup(mplp_conf_t *conf) free(conf->mplp_data[i]); } free(conf->mplp_data); free(conf->plp); free(conf->n_plp); - if ( samples_inc ) khash_str2int_destroy_free(samples_inc); + if ( samples_list ) khash_str2int_destroy_free(samples_list); free(mp_ref.ref[0]); free(mp_ref.ref[1]); return 0; diff --git a/sample.c b/sample.c index 06777ee45..40361a2cb 100644 --- a/sample.c +++ b/sample.c @@ -63,7 +63,7 @@ static void add_pair(bam_sample_t *sm, void *sm2id, const char *readgroup, const khash_str2int_set(sm->rg2smid, strdup(readgroup), ismpl); } -int bam_smpl_add(bam_sample_t *sm, const char *fn, const char *txt, void *white_list, void *white_hash) +int bam_smpl_add(bam_sample_t *sm, const char *fn, const char *txt, void *sample_list, int sample_logic, void *white_hash) { const char *p = txt, *q, *r; kstring_t buf, first_sm; @@ -85,13 +85,21 @@ int bam_smpl_add(bam_sample_t *sm, const char *fn, const char *txt, void *white_ for (u = (char*)q; *u && *u != '\t' && *u != '\n'; ++u); for (v = (char*)r; *v && *v != '\t' && *v != '\n'; ++v); ioq = *u; ior = *v; *u = *v = '\0'; - if ( !white_list || khash_str2int_has_key(white_list,r) ) + + // r now points to a null terminated sample name + int accept_rg = 1; + if ( sample_list ) + { + accept_rg = khash_str2int_has_key(sample_list,r); + if ( sample_logic==0 ) accept_rg = accept_rg ? 0 : 1; + } + if ( accept_rg ) { buf.l = 0; kputs(fn, &buf); kputc('/', &buf); kputs(q, &buf); add_pair(sm, sm->sm2id, buf.s, r); if ( !first_sm.s ) kputs(r,&first_sm); - if ( white_list ) khash_str2int_inc(white_hash,strdup(q)); + if ( sample_list ) khash_str2int_inc(white_hash,strdup(q)); } *u = ioq; *v = ior; } else break; diff --git a/sample.h b/sample.h index f777a81f5..4828c32f2 100644 --- a/sample.h +++ b/sample.h @@ -35,7 +35,7 @@ typedef struct { } bam_sample_t; bam_sample_t *bam_smpl_init(void); -int bam_smpl_add(bam_sample_t *sm, const char *abs, const char *txt, void *white_list, void *white_hash); +int bam_smpl_add(bam_sample_t *sm, const char *abs, const char *txt, void *sample_list, int sample_logic, void *white_hash); int bam_smpl_rg2smid(const bam_sample_t *sm, const char *fn, const char *rg, kstring_t *str); void bam_smpl_destroy(bam_sample_t *sm); diff --git a/test/mpileup/mpileup.8.out b/test/mpileup/mpileup.8.out new file mode 100644 index 000000000..c13653928 --- /dev/null +++ b/test/mpileup/mpileup.8.out @@ -0,0 +1,70 @@ +##fileformat=VCFv4.2 +##FILTER= +##contig= +##ALT= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##FORMAT= +#CHROM POS ID REF ALT QUAL FILTER INFO FORMAT HG00100 +17 100 . C <*> 0 . DP=9;I16=9,0,0,0,350,14094,0,0,509,29641,0,0,159,3427,0,0;QS=1,0;MQ0F=0 PL 0,27,189 +17 101 . C <*> 0 . DP=9;I16=9,0,0,0,331,12701,0,0,509,29641,0,0,159,3349,0,0;QS=1,0;MQ0F=0 PL 0,27,182 +17 102 . C <*> 0 . DP=9;I16=9,0,0,0,349,13977,0,0,509,29641,0,0,159,3283,0,0;QS=1,0;MQ0F=0 PL 0,27,188 +17 103 . T <*> 0 . DP=9;I16=8,0,0,0,338,14304,0,0,480,28800,0,0,153,3193,0,0;QS=1,0;MQ0F=0 PL 0,24,189 +17 104 . G <*> 0 . DP=9;I16=8,0,0,0,310,12224,0,0,480,28800,0,0,152,3138,0,0;QS=1,0;MQ0F=0 PL 0,24,178 +17 105 . G <*> 0 . DP=10;I16=9,0,0,0,306,10992,0,0,540,32400,0,0,151,3093,0,0;QS=1,0;MQ0F=0 PL 0,27,170 +17 106 . G <*> 0 . DP=10;I16=10,0,0,0,371,14379,0,0,569,33241,0,0,160,3140,0,0;QS=1,0;MQ0F=0 PL 0,30,190 +17 107 . C <*> 0 . DP=10;I16=9,0,0,0,364,14858,0,0,540,32400,0,0,151,3037,0,0;QS=1,0;MQ0F=0 PL 0,27,192 +17 108 . C <*> 0 . DP=10;I16=9,0,0,0,358,14384,0,0,540,32400,0,0,151,3027,0,0;QS=1,0;MQ0F=0 PL 0,27,190 +17 109 . T <*> 0 . DP=10;I16=9,0,0,0,367,15083,0,0,540,32400,0,0,151,3029,0,0;QS=1,0;MQ0F=0 PL 0,27,195 +17 110 . G <*> 0 . DP=10;I16=9,0,0,0,369,15193,0,0,540,32400,0,0,151,3043,0,0;QS=1,0;MQ0F=0 PL 0,27,194 +17 111 . G <*> 0 . DP=10;I16=10,0,0,0,316,10760,0,0,569,33241,0,0,165,3265,0,0;QS=1,0;MQ0F=0 PL 0,30,167 +17 112 . C <*> 0 . DP=10;I16=9,0,0,0,362,14690,0,0,540,32400,0,0,151,3107,0,0;QS=1,0;MQ0F=0 PL 0,27,191 +17 113 . A <*> 0 . DP=10;I16=9,0,0,0,334,12490,0,0,540,32400,0,0,150,3106,0,0;QS=1,0;MQ0F=0 PL 0,27,176 +17 114 . C <*> 0 . DP=10;I16=9,0,0,0,347,13441,0,0,540,32400,0,0,149,3115,0,0;QS=1,0;MQ0F=0 PL 0,27,182 +17 115 . C <*> 0 . DP=10;I16=10,0,0,0,367,14165,0,0,569,33241,0,0,166,3458,0,0;QS=1,0;MQ0F=0 PL 0,30,189 +17 116 . A <*> 0 . DP=10;I16=9,0,0,0,351,13723,0,0,540,32400,0,0,146,3114,0,0;QS=1,0;MQ0F=0 PL 0,27,183 +17 117 . G <*> 0 . DP=10;I16=9,0,0,0,342,13166,0,0,540,32400,0,0,144,3106,0,0;QS=1,0;MQ0F=0 PL 0,27,183 +17 118 . G <*> 0 . DP=9;I16=9,0,0,0,317,11785,0,0,509,29641,0,0,164,3550,0,0;QS=1,0;MQ0F=0 PL 0,27,175 +17 119 . G <*> 0 . DP=9;I16=8,0,0,0,308,11972,0,0,480,28800,0,0,142,3122,0,0;QS=1,0;MQ0F=0 PL 0,24,175 +17 120 . A <*> 0 . DP=9;I16=8,0,0,0,311,12135,0,0,480,28800,0,0,141,3145,0,0;QS=1,0;MQ0F=0 PL 0,24,175 +17 121 . G <*> 0 . DP=9;I16=8,0,0,0,315,12547,0,0,480,28800,0,0,139,3127,0,0;QS=1,0;MQ0F=0 PL 0,24,181 +17 122 . C <*> 0 . DP=9;I16=8,0,0,0,320,12864,0,0,480,28800,0,0,137,3117,0,0;QS=1,0;MQ0F=0 PL 0,24,181 +17 123 . T <*> 0 . DP=8;I16=7,0,0,0,274,10782,0,0,420,25200,0,0,136,3114,0,0;QS=1,0;MQ0F=0 PL 0,21,167 +17 124 . T <*> 0 . DP=9;I16=9,0,0,0,276,9034,0,0,509,29641,0,0,160,3742,0,0;QS=1,0;MQ0F=0 PL 0,27,154 +17 125 . A <*> 0 . DP=8;I16=7,0,0,0,253,9195,0,0,420,25200,0,0,136,3126,0,0;QS=1,0;MQ0F=0 PL 0,21,154 +17 126 . A <*> 0 . DP=8;I16=8,0,0,0,275,9967,0,0,449,26041,0,0,162,3766,0,0;QS=1,0;MQ0F=0 PL 0,24,162 +17 127 . C <*> 0 . DP=8;I16=8,0,0,0,280,10340,0,0,449,26041,0,0,163,3787,0,0;QS=1,0;MQ0F=0 PL 0,24,163 +17 128 . A <*> 0 . DP=8;I16=8,0,0,0,295,11123,0,0,449,26041,0,0,164,3814,0,0;QS=1,0;MQ0F=0 PL 0,24,169 +17 129 . A <*> 0 . DP=8;I16=8,0,0,0,291,10845,0,0,449,26041,0,0,165,3847,0,0;QS=1,0;MQ0F=0 PL 0,24,168 +17 130 . A <*> 0 . DP=8;I16=8,0,0,0,292,10932,0,0,449,26041,0,0,166,3886,0,0;QS=1,0;MQ0F=0 PL 0,24,169 +17 131 . C <*> 0 . DP=7;I16=7,0,0,0,276,10910,0,0,420,25200,0,0,141,3255,0,0;QS=1,0;MQ0F=0 PL 0,21,167 +17 132 . A <*> 0 . DP=7;I16=7,0,0,0,279,11147,0,0,420,25200,0,0,141,3253,0,0;QS=1,0;MQ0F=0 PL 0,21,169 +17 133 . T <*> 0 . DP=7;I16=7,0,0,0,269,10365,0,0,420,25200,0,0,141,3255,0,0;QS=1,0;MQ0F=0 PL 0,21,163 +17 134 . C <*> 0 . DP=7;I16=7,0,0,0,293,12279,0,0,420,25200,0,0,141,3261,0,0;QS=1,0;MQ0F=0 PL 0,21,177 +17 135 . T <*> 0 . DP=7;I16=7,0,0,0,286,11708,0,0,420,25200,0,0,141,3271,0,0;QS=1,0;MQ0F=0 PL 0,21,173 +17 136 . G <*> 0 . DP=7;I16=7,0,0,0,283,11471,0,0,420,25200,0,0,141,3285,0,0;QS=1,0;MQ0F=0 PL 0,21,172 +17 137 . T <*> 0 . DP=7;I16=7,0,0,0,263,9933,0,0,420,25200,0,0,141,3303,0,0;QS=1,0;MQ0F=0 PL 0,21,160 +17 138 . C <*> 0 . DP=7;I16=7,0,0,0,284,11546,0,0,420,25200,0,0,141,3325,0,0;QS=1,0;MQ0F=0 PL 0,21,172 +17 139 . C <*> 0 . DP=7;I16=7,0,0,0,263,9957,0,0,420,25200,0,0,140,3302,0,0;QS=1,0;MQ0F=0 PL 0,21,161 +17 140 . A <*> 0 . DP=7;I16=7,0,0,0,269,10379,0,0,420,25200,0,0,139,3285,0,0;QS=1,0;MQ0F=0 PL 0,21,163 +17 141 . G <*> 0 . DP=6;I16=6,0,0,0,239,9599,0,0,360,21600,0,0,139,3273,0,0;QS=1,0;MQ0F=0 PL 0,18,158 +17 142 . C <*> 0 . DP=6;I16=6,0,0,0,239,9557,0,0,360,21600,0,0,139,3265,0,0;QS=1,0;MQ0F=0 PL 0,18,157 +17 143 . G <*> 0 . DP=6;I16=6,0,0,0,197,6487,0,0,360,21600,0,0,139,3261,0,0;QS=1,0;MQ0F=0 PL 0,18,128 +17 144 . A <*> 0 . DP=6;I16=6,0,0,0,232,9020,0,0,360,21600,0,0,138,3212,0,0;QS=1,0;MQ0F=0 PL 0,18,152 +17 145 . A <*> 0 . DP=6;I16=6,0,0,0,233,9089,0,0,360,21600,0,0,137,3169,0,0;QS=1,0;MQ0F=0 PL 0,18,153 +17 146 . T <*> 0 . DP=6;I16=6,0,0,0,233,9065,0,0,360,21600,0,0,136,3132,0,0;QS=1,0;MQ0F=0 PL 0,18,152 +17 147 . A <*> 0 . DP=6;I16=6,0,0,0,229,8771,0,0,360,21600,0,0,135,3101,0,0;QS=1,0;MQ0F=0 PL 0,18,150 +17 148 . C <*> 0 . DP=6;I16=6,0,0,0,240,9618,0,0,360,21600,0,0,134,3076,0,0;QS=1,0;MQ0F=0 PL 0,18,157 +17 149 . C <*> 0 . DP=6;I16=6,0,0,0,219,8419,0,0,360,21600,0,0,133,3057,0,0;QS=1,0;MQ0F=0 PL 0,18,148 +17 150 . T <*> 0 . DP=6;I16=6,0,0,0,234,9158,0,0,360,21600,0,0,131,2993,0,0;QS=1,0;MQ0F=0 PL 0,18,153 diff --git a/test/test.pl b/test/test.pl index 542d72c3b..577d1e57e 100755 --- a/test/test.pl +++ b/test/test.pl @@ -259,6 +259,8 @@ test_mpileup($opts,in=>[qw(1 2 3)],out=>'mpileup/mpileup.6.out',args=>q[-a DP,DV -r17:100-200,17:201-300,17:301-400,17:401-500,17:501-600 --gvcf 0,2,5]); test_mpileup($opts,in=>[qw(1 2 3)],out=>'mpileup/mpileup.7.out',args=>q[-r17:100-150 -s HG00101,HG00102]); test_mpileup($opts,in=>[qw(1 2 3)],out=>'mpileup/mpileup.7.out',args=>q[-r17:100-150 -S {PATH}/mplp.samples]); +test_mpileup($opts,in=>[qw(1 2 3)],out=>'mpileup/mpileup.8.out',args=>q[-r17:100-150 -s ^HG00101,HG00102]); +test_mpileup($opts,in=>[qw(1 2 3)],out=>'mpileup/mpileup.8.out',args=>q[-r17:100-150 -S ^{PATH}/mplp.samples]); print "\nNumber of tests:\n"; printf " total .. %d\n", $$opts{nok}+$$opts{nfailed}; From 51e31af88085104472ec74bebb70f40f281b93ae Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Thu, 23 Jun 2016 12:05:43 +0100 Subject: [PATCH 207/211] mpileup: -l replaced with -t,-T to match other bcftools commands --- doc/bcftools.txt | 25 +++++++++++-------------- mpileup.c | 45 +++++++++++++++++++++++++++++++++++++++------ test/test.pl | 1 + 3 files changed, 51 insertions(+), 20 deletions(-) diff --git a/doc/bcftools.txt b/doc/bcftools.txt index d0e67b8e4..2b87151de 100644 --- a/doc/bcftools.txt +++ b/doc/bcftools.txt @@ -1298,16 +1298,17 @@ individuals can be pooled in one alignment file, also one individual can be separated into multiple files. If sample identifiers are absent, each input file is regarded as one sample. - Note that there are two orthogonal ways to specify locations in the -input file; via *-r* 'region' and *-l* 'positions'. The +input file; via *-r* 'region' and *-t* 'positions'. The former uses (and requires) an index to do random access while the latter streams through the file contents filtering out the specified regions, requiring no index. The two may be used in conjunction. For example a BED file containing locations of genes in chromosome 20 -could be specified using *-r 20 -l chr20.bed*, meaning that the +could be specified using *-r 20 -t chr20.bed*, meaning that the index is used to find chromosome 20 and then it is filtered for the -regions listed in the BED file. +regions listed in the BED file. Also note that the *-r* option can be much +slower than *-t* with many regions and can require more memory when +multiple regions and many alignment files are processed. ==== Input options @@ -1351,16 +1352,6 @@ regions listed in the BED file. *-G, --exclude-RG* 'FILE':: Exclude reads from readgroups listed in FILE (one @RG-ID per line) -*-l, --positions* 'FILE':: - BED or position list file containing a list of regions or sites where - output should be generated. Position list files contain two - columns (chromosome and position) and start counting from 1. BED - files contain at least 3 columns (chromosome, start and end position) - and are 0-based half-open. - While it is possible to mix both position-list and BED coordinates in - the same file, this is strongly ill advised due to the differing - coordinate systems. [null] - *-q, -min-MQ* 'INT':: Minimum mapping quality for an alignment to be used [0] @@ -1391,6 +1382,12 @@ regions listed in the BED file. *-S, --samples-file* 'FILE':: file of sample names. See *<>* +*-t, --targets* 'LIST':: + see *<>* + +*-T, --targets-file* 'FILE':: + see *<>* + *-x, --ignore-overlaps*:: Disable read-pair overlap detection. diff --git a/mpileup.c b/mpileup.c index 31e5433f7..bc2f7d12a 100644 --- a/mpileup.c +++ b/mpileup.c @@ -71,6 +71,7 @@ typedef struct { int reg_is_file, record_cmd_line, n_threads; faidx_t *fai; regidx_t *bed, *reg; // bed: skipping regions, reg: index-jump to regions + int bed_logic; // 1: include region, 0: exclude region gvcf_t *gvcf; // auxiliary structures for calling @@ -197,7 +198,20 @@ static int mplp_func(void *data, bam1_t *b) if (ma->conf->bed) { // test overlap - if ( !regidx_overlap(ma->conf->bed, ma->h->target_name[b->core.tid],b->core.pos, bam_endpos(b)-1, NULL) ) continue; + regitr_t itr; + int beg = b->core.pos, end = bam_endpos(b)-1; + int overlap = regidx_overlap(ma->conf->bed, ma->h->target_name[b->core.tid],beg,end, &itr); + if ( !ma->conf->bed_logic && !overlap ) + { + // exclude only reads which are fully contained in the region + while ( REGITR_OVERLAP(itr,beg,end) ) + { + if ( beg < REGITR_START(itr) ) { overlap = 1; break; } + if ( end > REGITR_END(itr) ) { overlap = 1; break; } + itr.i++; + } + } + if ( !overlap ) continue; } if (ma->rghash_inc) { @@ -306,7 +320,12 @@ static int mpileup_reg(mplp_conf_t *conf, uint32_t beg, uint32_t end) while ( (ret=bam_mplp_auto(conf->iter, &tid, &pos, conf->n_plp, conf->plp)) > 0) { if ( end && (posend) ) continue; - if (conf->bed && tid >= 0 && !regidx_overlap(conf->bed, hdr->target_name[tid], pos, pos, NULL)) continue; + if ( conf->bed && tid >= 0 ) + { + int overlap = regidx_overlap(conf->bed, hdr->target_name[tid], pos, pos, NULL); + if ( !conf->bed_logic ) overlap = overlap ? 0 : 1; + if ( !overlap ) continue; + } mplp_get_ref(conf->mplp_data[0], tid, &ref, &ref_len); int total_depth, _ref0, ref16; @@ -835,7 +854,6 @@ static void print_usage(FILE *fp, const mplp_conf_t *mplp) " -E, --redo-BAQ recalculate BAQ on the fly, ignore existing BQs\n" " -f, --fasta-ref FILE faidx indexed reference sequence file\n" " -G, --exclude-RG FILE exclude read groups listed in FILE\n" -" -l, --positions FILE skip unlisted positions (chr pos) or regions (BED)\n" " -q, --min-MQ INT skip alignments with mapQ smaller than INT [%d]\n", mplp->min_mq); fprintf(fp, " -Q, --min-BQ INT skip bases with baseQ/BAQ smaller than INT [%d]\n", mplp->min_baseQ); @@ -850,6 +868,8 @@ static void print_usage(FILE *fp, const mplp_conf_t *mplp) fprintf(fp, " -s, --samples LIST comma separated list of samples to include\n" " -S, --samples-file FILE file of samples to include\n" +" -t, --targets REG[,...] similar to -r but streams rather than index-jumps\n" +" -T, --targets-file FILE similar to -R but streams rather than index-jumps\n" " -x, --ignore-overlaps disable read-pair overlap detection\n" "\n" "Output options:\n" @@ -933,10 +953,11 @@ int bam_mpileup(int argc, char *argv[]) {"fasta-ref", required_argument, NULL, 'f'}, {"exclude-RG", required_argument, NULL, 'G'}, {"exclude-rg", required_argument, NULL, 'G'}, - {"positions", required_argument, NULL, 'l'}, {"region", required_argument, NULL, 'r'}, {"regions", required_argument, NULL, 'r'}, {"regions-file", required_argument, NULL, 'R'}, + {"targets", required_argument, NULL, 't'}, + {"targets-file", required_argument, NULL, 'T'}, {"min-MQ", required_argument, NULL, 'q'}, {"min-mq", required_argument, NULL, 'q'}, {"min-BQ", required_argument, NULL, 'Q'}, @@ -957,7 +978,7 @@ int bam_mpileup(int argc, char *argv[]) {"platforms", required_argument, NULL, 'P'}, {NULL, 0, NULL, 0} }; - while ((c = getopt_long(argc, argv, "Ag:f:r:R:l:q:Q:C:Bd:L:b:P:po:e:h:Im:F:EG:6O:xa:s:S:",lopts,NULL)) >= 0) { + while ((c = getopt_long(argc, argv, "Ag:f:r:R:q:Q:C:Bd:L:b:P:po:e:h:Im:F:EG:6O:xa:s:S:t:T:",lopts,NULL)) >= 0) { switch (c) { case 'x': mplp.flag &= ~MPLP_SMART_OVERLAPS; break; case 1 : @@ -985,10 +1006,22 @@ int bam_mpileup(int argc, char *argv[]) case 'd': mplp.max_depth = atoi(optarg); break; case 'r': mplp.reg_fname = strdup(optarg); break; case 'R': mplp.reg_fname = strdup(optarg); mplp.reg_is_file = 1; break; - case 'l': + case 't': // In the original version the whole BAM was streamed which is inefficient // with few BED intervals and big BAMs. Todo: devise a heuristic to determine // best strategy, that is streaming or jumping. + if ( optarg[0]=='^' ) optarg++; + else mplp.bed_logic = 1; + mplp.bed = regidx_init(NULL,regidx_parse_reg,NULL,0,NULL); + if ( regidx_insert_list(mplp.bed,optarg,',') !=0 ) + { + fprintf(stderr,"Could not parse the targets: %s\n", optarg); + exit(EXIT_FAILURE); + } + break; + case 'T': + if ( optarg[0]=='^' ) optarg++; + else mplp.bed_logic = 1; mplp.bed = regidx_init(optarg,NULL,NULL,0,NULL); if (!mplp.bed) { fprintf(stderr, "bcftools mpileup: Could not read file \"%s\"", optarg); return 1; } break; diff --git a/test/test.pl b/test/test.pl index 577d1e57e..9c807d30e 100755 --- a/test/test.pl +++ b/test/test.pl @@ -261,6 +261,7 @@ test_mpileup($opts,in=>[qw(1 2 3)],out=>'mpileup/mpileup.7.out',args=>q[-r17:100-150 -S {PATH}/mplp.samples]); test_mpileup($opts,in=>[qw(1 2 3)],out=>'mpileup/mpileup.8.out',args=>q[-r17:100-150 -s ^HG00101,HG00102]); test_mpileup($opts,in=>[qw(1 2 3)],out=>'mpileup/mpileup.8.out',args=>q[-r17:100-150 -S ^{PATH}/mplp.samples]); +test_mpileup($opts,in=>[qw(1 2 3)],out=>'mpileup/mpileup.8.out',args=>q[-t17:100-150 -S ^{PATH}/mplp.samples]); print "\nNumber of tests:\n"; printf " total .. %d\n", $$opts{nok}+$$opts{nfailed}; From 7f4929c3d16fc41540ba70e16ca64072e3c6211c Mon Sep 17 00:00:00 2001 From: Shane McCarthy Date: Thu, 30 Jun 2016 09:14:36 +0100 Subject: [PATCH 208/211] rename sample.* to bam_sample.* --- Makefile | 8 ++++---- sample.c => bam_sample.c | 4 ++-- sample.h => bam_sample.h | 2 +- mpileup.c | 2 +- 4 files changed, 8 insertions(+), 8 deletions(-) rename sample.c => bam_sample.c (98%) rename sample.h => bam_sample.h (97%) diff --git a/Makefile b/Makefile index 1d923e995..75cc3b85b 100644 --- a/Makefile +++ b/Makefile @@ -46,7 +46,7 @@ OBJS = main.o vcfindex.o tabix.o \ vcfnorm.o vcfgtcheck.o vcfview.o vcfannotate.o vcfroh.o vcfconcat.o \ vcfcall.o mcall.o vcmp.o gvcf.o reheader.o convert.o vcfconvert.o tsv2vcf.o \ vcfcnv.o HMM.o vcfplugin.o consensus.o ploidy.o regidx.o version.o \ - mpileup.o bam2bcf.o bam2bcf_indel.o sample.o \ + mpileup.o bam2bcf.o bam2bcf_indel.o bam_sample.o \ ccall.o em.o prob1.o kmin.o # the original samtools calling EXTRA_CPPFLAGS = -I. -I$(HTSDIR) -DPLUGINPATH=\"$(pluginpath)\" @@ -141,7 +141,7 @@ roh_h = HMM.h $(htslib_vcf_h) $(htslib_synced_bcf_reader_h) $(HTSDIR)/htslib/kst cnv_h = HMM.h $(htslib_vcf_h) $(htslib_synced_bcf_reader_h) bam2bcf_h = bam2bcf.h $(htslib_hts_h) $(htslib_vcf_h) sam_h = sam.h $(htslib_sam_h) $(bam_h) -sample_h = sample.h $(htslib_kstring_h) +bam_sample_h = bam_sample.h $(htslib_kstring_h) main.o: main.c $(htslib_hts_h) version.h $(bcftools_h) vcfannotate.o: vcfannotate.c $(htslib_vcf_h) $(htslib_synced_bcf_reader_h) $(HTSDIR)/htslib/kseq.h $(bcftools_h) vcmp.h $(filter_h) @@ -178,8 +178,8 @@ polysomy.o: polysomy.c $(htslib_vcf_h) $(htslib_synced_bcf_reader_h) $(bcftools_ peakfit.o: peakfit.c peakfit.h $(htslib_hts_h) $(HTSDIR)/htslib/kstring.h regidx.o: regidx.c $(htslib_hts_h) $(htslib_kstring_h) $(htslib_kseq_h) $(htslib_khash_str2int_h) regidx.h consensus.o: consensus.c $(htslib_hts_h) $(HTSDIR)/htslib/kseq.h rbuf.h $(bcftools_h) regidx.h -mpileup.o: mpileup.c $(htslib_sam_h) $(htslib_faidx_h) $(htslib_kstring_h) $(htslib_khash_str2int_h) regidx.h $(bcftools_h) $(call_h) $(bam2bcf_h) $(sample_h) -sample.o: $(sample_h) $(htslib_hts_h) $(HTSDIR)/htslib/khash_str2int.h +mpileup.o: mpileup.c $(htslib_sam_h) $(htslib_faidx_h) $(htslib_kstring_h) $(htslib_khash_str2int_h) regidx.h $(bcftools_h) $(call_h) $(bam2bcf_h) $(bam_sample_h) +bam_sample.o: $(bam_sample_h) $(htslib_hts_h) $(HTSDIR)/htslib/khash_str2int.h version.o: version.h version.c test/test-rbuf.o: test/test-rbuf.c rbuf.h diff --git a/sample.c b/bam_sample.c similarity index 98% rename from sample.c rename to bam_sample.c index 40361a2cb..c5d0c0c21 100644 --- a/sample.c +++ b/bam_sample.c @@ -1,4 +1,4 @@ -/* sample.c -- group data by sample. +/* bam_sample.c -- group data by sample. Copyright (C) 2010, 2011 Broad Institute. Copyright (C) 2013, 2016 Genome Research Ltd. @@ -27,7 +27,7 @@ DEALINGS IN THE SOFTWARE. */ #include #include #include -#include "sample.h" +#include "bam_sample.h" bam_sample_t *bam_smpl_init(void) { diff --git a/sample.h b/bam_sample.h similarity index 97% rename from sample.h rename to bam_sample.h index 4828c32f2..16bbfb4bd 100644 --- a/sample.h +++ b/bam_sample.h @@ -1,4 +1,4 @@ -/* sample.h -- group data by sample. +/* bam_sample.h -- group data by sample. Copyright (C) 2010 Broad Institute. Copyright (C) 2016 Genome Research Ltd. diff --git a/mpileup.c b/mpileup.c index bc2f7d12a..d0c1c97db 100644 --- a/mpileup.c +++ b/mpileup.c @@ -41,7 +41,7 @@ DEALINGS IN THE SOFTWARE. */ #include "regidx.h" #include "bcftools.h" #include "bam2bcf.h" -#include "sample.h" +#include "bam_sample.h" #include "gvcf.h" #define MPLP_BCF 1 From 5562f0594ddf2af2b8a5faeece0ad627dc06bee9 Mon Sep 17 00:00:00 2001 From: Petr Danecek Date: Fri, 24 Jun 2016 21:18:21 +0100 Subject: [PATCH 209/211] mpileup: changes -G/--exclude-RG to -G/--read-groups * prefix with ^ to negate the selection * assign/rename samples by providing second field: RG_ID_1 SAMPLE_A RG_ID_2 SAMPLE_A RG_ID_3 SAMPLE_B * on read group name conflict give the alignment file, asterisk for all reads in the file: RG_ID_1 FILE_1.bam SAMPLE_A RG_ID_2 FILE_2.bam SAMPLE_A * FILE_3.bam SAMPLE_C Resolves 4th item in https://github.com/samtools/bcftools/pull/414#issuecomment-222139272 and https://github.com/samtools/samtools/issues/324. --- Makefile | 2 +- bam2bcf_indel.c | 37 ---- bam_sample.c | 333 +++++++++++++++++++++++++++++------- bam_sample.h | 32 ++-- doc/bcftools.txt | 22 ++- mpileup.c | 189 ++++++++------------ test/mpileup/mpileup.10.out | 70 ++++++++ test/mpileup/mpileup.9.out | 70 ++++++++ test/mplp.10.samples | 5 + test/mplp.9.samples | 2 + test/test.pl | 3 +- 11 files changed, 524 insertions(+), 241 deletions(-) create mode 100644 test/mpileup/mpileup.10.out create mode 100644 test/mpileup/mpileup.9.out create mode 100644 test/mplp.10.samples create mode 100644 test/mplp.9.samples diff --git a/Makefile b/Makefile index 75cc3b85b..341f729ac 100644 --- a/Makefile +++ b/Makefile @@ -141,7 +141,7 @@ roh_h = HMM.h $(htslib_vcf_h) $(htslib_synced_bcf_reader_h) $(HTSDIR)/htslib/kst cnv_h = HMM.h $(htslib_vcf_h) $(htslib_synced_bcf_reader_h) bam2bcf_h = bam2bcf.h $(htslib_hts_h) $(htslib_vcf_h) sam_h = sam.h $(htslib_sam_h) $(bam_h) -bam_sample_h = bam_sample.h $(htslib_kstring_h) +bam_sample_h = bam_sample.h $(htslib_sam_h) main.o: main.c $(htslib_hts_h) version.h $(bcftools_h) vcfannotate.o: vcfannotate.c $(htslib_vcf_h) $(htslib_synced_bcf_reader_h) $(HTSDIR)/htslib/kseq.h $(bcftools_h) vcmp.h $(filter_h) diff --git a/bam2bcf_indel.c b/bam2bcf_indel.c index 9065949af..eda81afa8 100644 --- a/bam2bcf_indel.c +++ b/bam2bcf_indel.c @@ -37,43 +37,6 @@ KSORT_INIT_GENERIC(uint32_t) #define MINUS_CONST 0x10000000 #define INDEL_WINDOW_SIZE 50 -void *bcf_call_add_rg(void *hash, const char *hdtext, const char *list) -{ - const char *s, *p, *q, *r, *t; - - if (list == 0 || hdtext == 0) return hash; - if ( !hash ) hash = khash_str2int_init(); - if ((s = strstr(hdtext, "@RG\t")) == 0) return hash; // @RG lines not present - do { - t = strstr(s + 4, "@RG\t"); // the next @RG - if ((p = strstr(s, "\tID:")) != 0) p += 4; - if ((q = strstr(s, "\tPL:")) != 0) q += 4; - if (p && q && (t == 0 || (p < t && q < t))) { // ID and PL are both present - int lp, lq; - char *x; - for (r = p; *r && *r != '\t' && *r != '\n'; ++r) { } - lp = r - p; - for (r = q; *r && *r != '\t' && *r != '\n'; ++r) { } - lq = r - q; - x = (char*) calloc((lp > lq? lp : lq) + 1, 1); - for (r = q; *r && *r != '\t' && *r != '\n'; ++r) x[r-q] = *r; - if (strstr(list, x)) { // insert ID to the hash table - for (r = p; *r && *r != '\t' && *r != '\n'; ++r) x[r-p] = *r; - x[r-p] = 0; - if ( khash_str2int_has_key(hash,x) ) free(x); - else khash_str2int_set(hash,x,1); - } else free(x); - } - s = t; - } while (s); - return hash; -} - -void bcf_call_del_rghash(void *hash) -{ - khash_str2int_destroy_free(hash); -} - static int tpos2qpos(const bam1_core_t *c, const uint32_t *cigar, int32_t tpos, int is_left, int32_t *_tpos) { int k, x = c->pos, y = 0, last_y = 0; diff --git a/bam_sample.c b/bam_sample.c index c5d0c0c21..a8f22bd16 100644 --- a/bam_sample.c +++ b/bam_sample.c @@ -25,109 +25,316 @@ DEALINGS IN THE SOFTWARE. */ #include #include +#include #include +#include #include +#include #include "bam_sample.h" -bam_sample_t *bam_smpl_init(void) + +typedef struct +{ + char *fname; + void *rg2idx; // hash: read group name to BCF output sample index. Maintained by bsmpl_add_readgroup + int default_idx; // default BCF output sample index +} +file_t; + +struct _bam_smpl_t { - bam_sample_t *s; - s = (bam_sample_t*) calloc(1, sizeof(bam_sample_t)); - s->rg2smid = khash_str2int_init(); - s->sm2id = khash_str2int_init(); - return s; + kstring_t tmp; + file_t *files; + int ignore_rg, nsmpl, nfiles; + char **smpl; // list of BCF output sample names. Maintained by bsmpl_add_readgroup + void *sample_list; // hash: BAM input sample name to BCF output sample name. This is the -s/-S list + int sample_logic; // the -s/-S logic, 1: include, 0: exclude + void *rg_list; // hash: BAM/rg_id to sample name or */rg_id for global ids. This is the -G list + int rg_logic; // the -G logic, 1: include, 0: exclude + void *name2idx; // hash: BCF output sample name to BCF output sample index. Maintained by bsmpl_add_readgroup +}; + +bam_smpl_t *bam_smpl_init(void) +{ + bam_smpl_t *bsmpl; + bsmpl = (bam_smpl_t*) calloc(1, sizeof(bam_smpl_t)); + bsmpl->name2idx = khash_str2int_init(); + return bsmpl; } -void bam_smpl_destroy(bam_sample_t *sm) +void bam_smpl_destroy(bam_smpl_t *bsmpl) { - if ( !sm ) return; - if ( sm->rg2smid ) khash_str2int_destroy_free(sm->rg2smid); - if ( sm->sm2id ) khash_str2int_destroy_free(sm->sm2id); - free(sm->smpl); - free(sm); + if ( !bsmpl ) return; + if ( bsmpl->name2idx ) khash_str2int_destroy_free(bsmpl->name2idx); + if ( bsmpl->sample_list ) khash_str2str_destroy_free_all(bsmpl->sample_list); + if ( bsmpl->rg_list ) khash_str2str_destroy_free_all(bsmpl->rg_list); + int i; + for (i=0; infiles; i++) + { + file_t *file = &bsmpl->files[i]; + if ( file->rg2idx ) khash_str2int_destroy_free(file->rg2idx); + free(file->fname); + } + free(bsmpl->smpl); + free(bsmpl->files); + free(bsmpl->tmp.s); + free(bsmpl); } -static void add_pair(bam_sample_t *sm, void *sm2id, const char *readgroup, const char *sample) +void bam_smpl_ignore_readgroups(bam_smpl_t* bsmpl) +{ + bsmpl->ignore_rg = 1; +} + +static void bsmpl_add_readgroup(bam_smpl_t *bsmpl, file_t *file, const char *rg_id, const char *smpl_name) { - if ( khash_str2int_has_key(sm->rg2smid,readgroup) ) return; // duplicated @RG-ID - int ismpl; - if ( khash_str2int_get(sm2id, sample, &ismpl) < 0 ) + if ( khash_str2int_get(bsmpl->name2idx,smpl_name,&ismpl) < 0 ) { - // the sample encountered for the first time - ismpl = sm->n++; - hts_expand0(char*,sm->n,sm->m,sm->smpl); - sm->smpl[ismpl] = strdup(sample); - khash_str2int_set(sm2id, sm->smpl[ismpl], ismpl); + // new sample + bsmpl->nsmpl++; + bsmpl->smpl = (char**) realloc(bsmpl->smpl,sizeof(char*)*bsmpl->nsmpl); + bsmpl->smpl[bsmpl->nsmpl-1] = strdup(smpl_name); + ismpl = khash_str2int_inc(bsmpl->name2idx,bsmpl->smpl[bsmpl->nsmpl-1]); } - khash_str2int_set(sm->rg2smid, strdup(readgroup), ismpl); + if ( !strcmp("*",rg_id) ) + { + // all read groups in the bam treated as the same sample + file->default_idx = ismpl; + return; + } + if ( !file->rg2idx ) file->rg2idx = khash_str2int_init(); + if ( khash_str2int_has_key(file->rg2idx,rg_id) ) return; // duplicate @RG:ID + khash_str2int_set(file->rg2idx, strdup(rg_id), ismpl); } +int bsmpl_keep_readgroup(bam_smpl_t *bsmpl, file_t *file, const char *rg_id, const char **smpl_name) +{ + char *rg_smpl = khash_str2str_get(bsmpl->rg_list,rg_id); // unique read group present in one bam only + if ( !rg_smpl ) + { + // read group specific to this bam + bsmpl->tmp.l = 0; + ksprintf(&bsmpl->tmp,"%s\t%s",rg_id,file->fname); + rg_smpl = khash_str2str_get(bsmpl->rg_list,bsmpl->tmp.s); + } + if ( !rg_smpl ) + { + // any read group in this file? + bsmpl->tmp.l = 0; + ksprintf(&bsmpl->tmp,"*\t%s",file->fname); + rg_smpl = khash_str2str_get(bsmpl->rg_list,bsmpl->tmp.s); + } + if ( !rg_smpl && bsmpl->rg_logic ) return 0; + if ( rg_smpl && !bsmpl->rg_logic ) return 0; -int bam_smpl_add(bam_sample_t *sm, const char *fn, const char *txt, void *sample_list, int sample_logic, void *white_hash) + if ( rg_smpl && rg_smpl[0]!='\t' ) *smpl_name = rg_smpl; + return 1; +} + +int bam_smpl_add_bam(bam_smpl_t *bsmpl, char *bam_hdr, const char *fname) { - const char *p = txt, *q, *r; - kstring_t buf, first_sm; - int n = 0; - if (txt == 0) { - add_pair(sm, sm->sm2id, fn, fn); - return 0; + bsmpl->nfiles++; + bsmpl->files = (file_t*) realloc(bsmpl->files,bsmpl->nfiles*sizeof(file_t)); + file_t *file = &bsmpl->files[bsmpl->nfiles-1]; + memset(file,0,sizeof(file_t)); + file->fname = strdup(fname); + file->default_idx = -1; + + if ( bsmpl->ignore_rg || !bam_hdr ) + { + bsmpl_add_readgroup(bsmpl,file,"*",file->fname); // --ignore-RG set or no BAM header + return bsmpl->nfiles-1; } - memset(&buf, 0, sizeof(kstring_t)); - memset(&first_sm, 0, sizeof(kstring_t)); - while ((q = strstr(p, "@RG")) != 0) { + + int has_rg = 0; + const char *p = bam_hdr, *q, *r; + while ((q = strstr(p, "@RG")) != 0) + { p = q + 3; r = q = 0; if ((q = strstr(p, "\tID:")) != 0) q += 4; if ((r = strstr(p, "\tSM:")) != 0) r += 4; - if (r && q) { + if (r && q) + { char *u, *v; int ioq, ior; for (u = (char*)q; *u && *u != '\t' && *u != '\n'; ++u); for (v = (char*)r; *v && *v != '\t' && *v != '\n'; ++v); ioq = *u; ior = *v; *u = *v = '\0'; - // r now points to a null terminated sample name + // q now points to a null terminated read group id + // r points to a null terminated sample name int accept_rg = 1; - if ( sample_list ) + if ( bsmpl->sample_list ) + { + // restrict samples based on the -s/-S options + char *name = khash_str2str_get(bsmpl->sample_list,r); + if ( bsmpl->sample_logic==0 ) + accept_rg = name ? 0 : 1; + else if ( !name ) + accept_rg = 0; + else + r = name; + } + if ( accept_rg && bsmpl->rg_list ) { - accept_rg = khash_str2int_has_key(sample_list,r); - if ( sample_logic==0 ) accept_rg = accept_rg ? 0 : 1; + // restrict readgroups based on the -G option, possibly renaming the sample + accept_rg = bsmpl_keep_readgroup(bsmpl,file,q,&r); } if ( accept_rg ) { - buf.l = 0; kputs(fn, &buf); kputc('/', &buf); kputs(q, &buf); - add_pair(sm, sm->sm2id, buf.s, r); - if ( !first_sm.s ) - kputs(r,&first_sm); - if ( sample_list ) khash_str2int_inc(white_hash,strdup(q)); + bsmpl_add_readgroup(bsmpl,file,q,r); + has_rg = 1; } + *u = ioq; *v = ior; - } else break; + } + else + break; p = q > r? q : r; - ++n; } - if (n == 0) add_pair(sm, sm->sm2id, fn, fn); - // If there is only one RG tag present in the header and reads are not annotated, don't refuse to work but - // use the tag instead. - else if ( n==1 && first_sm.s ) - add_pair(sm,sm->sm2id,fn,first_sm.s); - if ( first_sm.s ) - free(first_sm.s); - - free(buf.s); - return 0; + if ( !has_rg ) + { + free(file->fname); + bsmpl->nfiles--; + return -1; + } + return bsmpl->nfiles-1; } -int bam_smpl_rg2smid(const bam_sample_t *sm, const char *fn, const char *rg, kstring_t *str) +const char **bam_smpl_get_samples(bam_smpl_t *bsmpl, int *nsmpl) { - int ismpl; - if ( rg ) + *nsmpl = bsmpl->nsmpl; + return (const char**)bsmpl->smpl; +} + +int bam_smpl_get_sample_id(bam_smpl_t *bsmpl, int bam_id, bam1_t *bam_rec) +{ + file_t *file = &bsmpl->files[bam_id]; + if ( file->default_idx >= 0 ) return file->default_idx; + + char *aux_rg = (char*) bam_aux_get(bam_rec, "RG"); + if ( !aux_rg ) return -1; + + int rg_id; + if ( khash_str2int_get(file->rg2idx, aux_rg+1, &rg_id)==0 ) return rg_id; + return -1; +} + +int bam_smpl_add_samples(bam_smpl_t *bsmpl, char *list, int is_file) +{ + if ( list[0]!='^' ) bsmpl->sample_logic = 1; + else list++; + + int i, nsamples = 0; + char **samples = hts_readlist(list, is_file, &nsamples); + if ( !nsamples ) return 0; + + kstring_t ori = {0,0,0}; + kstring_t ren = {0,0,0}; + + bsmpl->sample_list = khash_str2str_init(); + for (i=0; isample_list,strdup(ori.s),strdup(ren.l?ren.s:ori.s)); + free(samples[i]); + } + free(samples); + free(ori.s); + free(ren.s); + return nsamples; +} + +int bam_smpl_add_readgroups(bam_smpl_t *bsmpl, char *list, int is_file) +{ + if ( list[0]!='^' ) bsmpl->rg_logic = 1; + else list++; + + int i, nrows = 0; + char **rows = hts_readlist(list, is_file, &nrows); + if ( !nrows ) return 0; + + kstring_t fld1 = {0,0,0}; + kstring_t fld2 = {0,0,0}; + kstring_t fld3 = {0,0,0}; + + bsmpl->rg_list = khash_str2str_init(); + for (i=0; il = 0; - kputs(fn, str); kputc('/', str); kputs(rg, str); - if ( khash_str2int_get(sm->rg2smid, str->s, &ismpl) < 0 ) return -1; - return ismpl; + char *ptr = rows[i]; + fld1.l = fld2.l = fld3.l = 0; + int escaped = 0; + while ( *ptr ) + { + if ( *ptr=='\\' && !escaped ) { escaped = 1; ptr++; continue; } + if ( isspace(*ptr) && !escaped ) break; + kputc(*ptr, &fld1); + escaped = 0; + ptr++; + } + if ( *ptr ) + { + while ( *ptr && isspace(*ptr) ) ptr++; + while ( *ptr ) + { + if ( *ptr=='\\' && !escaped ) { escaped = 1; ptr++; continue; } + if ( isspace(*ptr) && !escaped ) break; + kputc(*ptr, &fld2); + escaped = 0; + ptr++; + } + } + if ( *ptr ) + { + while ( *ptr && isspace(*ptr) ) ptr++; + while ( *ptr ) + { + if ( *ptr=='\\' && !escaped ) { escaped = 1; ptr++; continue; } + if ( isspace(*ptr) && !escaped ) break; + kputc(*ptr, &fld3); + escaped = 0; + ptr++; + } + } + if ( fld3.l ) + { + // ID FILE SAMPLE + kputc('\t',&fld1); + kputs(fld2.s,&fld1); + fld2.l = 0; + kputs(fld3.s,&fld2); + } + khash_str2str_set(bsmpl->rg_list,strdup(fld1.s),strdup(fld2.l?fld2.s:"\t")); + free(rows[i]); } - if ( khash_str2int_get(sm->rg2smid, fn, &ismpl) < 0 ) return -1; - return ismpl; + free(rows); + free(fld1.s); + free(fld2.s); + free(fld3.s); + return nrows; } + + diff --git a/bam_sample.h b/bam_sample.h index 16bbfb4bd..ea493d35d 100644 --- a/bam_sample.h +++ b/bam_sample.h @@ -26,17 +26,25 @@ DEALINGS IN THE SOFTWARE. */ #ifndef BAM_SAMPLE_H #define BAM_SAMPLE_H -#include "htslib/kstring.h" - -typedef struct { - int n, m; - char **smpl; - void *rg2smid, *sm2id; -} bam_sample_t; - -bam_sample_t *bam_smpl_init(void); -int bam_smpl_add(bam_sample_t *sm, const char *abs, const char *txt, void *sample_list, int sample_logic, void *white_hash); -int bam_smpl_rg2smid(const bam_sample_t *sm, const char *fn, const char *rg, kstring_t *str); -void bam_smpl_destroy(bam_sample_t *sm); +#include + +typedef struct _bam_smpl_t bam_smpl_t; + +bam_smpl_t *bam_smpl_init(void); + +int bam_smpl_add_samples(bam_smpl_t *bsmpl, char *list, int is_file); +int bam_smpl_add_readgroups(bam_smpl_t *bsmpl, char *list, int is_file); +void bam_smpl_ignore_readgroups(bam_smpl_t* bsmpl); + +// The above should be called only before bams are added. Returns the BAM id +// to be passed to bam_smpl_get_sample_id() later. It is safe to assume +// sequential numbering, starting from 0. +// +int bam_smpl_add_bam(bam_smpl_t *bsmpl, char *bam_hdr, const char *fname); + +const char **bam_smpl_get_samples(bam_smpl_t *bsmpl, int *nsmpl); +int bam_smpl_get_sample_id(bam_smpl_t *bsmpl, int bam_id, bam1_t *bam_rec); + +void bam_smpl_destroy(bam_smpl_t *bsmpl); #endif diff --git a/doc/bcftools.txt b/doc/bcftools.txt index 2b87151de..b7ae585ed 100644 --- a/doc/bcftools.txt +++ b/doc/bcftools.txt @@ -1349,8 +1349,15 @@ multiple regions and many alignment files are processed. The *faidx*-indexed reference file in the FASTA format. The file can be optionally compressed by *bgzip* [null] -*-G, --exclude-RG* 'FILE':: - Exclude reads from readgroups listed in FILE (one @RG-ID per line) +*-G, --read-groups* [^]'FILE':: + list of read groups to include or exclude if prefixed with "^". + One read group per line. This file can also be used to assign new sample + names to read groups by giving the new sample name as a second + white-space-separated field, like this: "read_group_id new_sample_name". + If the read group name is not unique, also the bam file name can + be included: "read_group_id file_name sample_name". If all + reads from the alignment file should be treated as a single sample, the + asterisk symbol can be used: "* file_name sample_name". *-q, -min-MQ* 'INT':: Minimum mapping quality for an alignment to be used [0] @@ -1376,11 +1383,16 @@ multiple regions and many alignment files are processed. *--ff, --excl-flags* 'STR'|'INT':: Filter flags: skip reads with mask bits set [UNMAP,SECONDARY,QCFAIL,DUP] -*-s, --samples* 'LIST':: +*-s, --samples* [^]'LIST':: list of sample names. See *<>* -*-S, --samples-file* 'FILE':: - file of sample names. See *<>* +*-S, --samples-file* [^]'FILE':: + file of sample names to include or exclude if prefixed with "^". + One sample per line. This file can also be used to rename samples by giving + the new sample name as a second white-space-separated column, like this: + "old_name new_name". If a sample name contains spaces, the spaces can be + escaped using the backslash character, for example "Not\ a\ good\ sample\ + name". *-t, --targets* 'LIST':: see *<>* diff --git a/mpileup.c b/mpileup.c index d0c1c97db..8c2d4e147 100644 --- a/mpileup.c +++ b/mpileup.c @@ -64,10 +64,10 @@ typedef struct _mplp_pileup_t mplp_pileup_t; // Data shared by all bam files typedef struct { int min_mq, flag, min_baseQ, capQ_thres, max_depth, max_indel_depth, fmt_flag; - int rflag_require, rflag_filter, output_type, sample_is_file; + int rflag_require, rflag_filter, output_type; int openQ, extQ, tandemQ, min_support; // for indels double min_frac; // for indels - char *reg_fname, *pl_list, *fai_fname, *output_fname, *samples_list; + char *reg_fname, *pl_list, *fai_fname, *output_fname; int reg_is_file, record_cmd_line, n_threads; faidx_t *fai; regidx_t *bed, *reg; // bed: skipping regions, reg: index-jump to regions @@ -85,13 +85,11 @@ typedef struct { mplp_pileup_t *gplp; int *n_plp; const bam_pileup1_t **plp; - bam_sample_t *smpl; + bam_smpl_t *bsmpl; kstring_t buf; bcf1_t *bcf_rec; htsFile *bcf_fp; bcf_hdr_t *bcf_hdr; - void *rghash_exc; // shared by all bams - int argc; char **argv; } mplp_conf_t; @@ -111,8 +109,7 @@ struct _mplp_aux_t { bam_hdr_t *h; mplp_ref_t *ref; const mplp_conf_t *conf; - void *rghash_inc; // whitelist for readgroups on per-bam basis, precedes blacklist - void *rghash_exc; // blacklist of readgroups + int bam_id; hts_idx_t *idx; // maintained only with more than one -r regions }; @@ -213,19 +210,7 @@ static int mplp_func(void *data, bam1_t *b) } if ( !overlap ) continue; } - if (ma->rghash_inc) - { - // skip unless read group is listed - uint8_t *rg = bam_aux_get(b, "RG"); - if ( !rg ) continue; - if ( !khash_str2int_has_key(ma->rghash_inc, (const char*)(rg+1)) ) continue; - } - if ( ma->rghash_exc ) - { - // exclude read groups - uint8_t *rg = bam_aux_get(b, "RG"); - if ( rg && khash_str2int_has_key(ma->rghash_exc, (const char*)(rg+1)) ) continue; - } + if ( bam_smpl_get_sample_id(ma->conf->bsmpl,ma->bam_id,b)<0 ) continue; if (ma->conf->flag & MPLP_ILLUMINA13) { int i; uint8_t *qual = bam_get_qual(b); @@ -258,25 +243,18 @@ static int mplp_func(void *data, bam1_t *b) return ret; } -static void group_smpl(mplp_pileup_t *m, bam_sample_t *sm, kstring_t *buf, - int n, char *const*fn, int *n_plp, const bam_pileup1_t **plp, int ignore_rg) +static void group_smpl(mplp_pileup_t *m, bam_smpl_t *bsmpl, int n, int *n_plp, const bam_pileup1_t **plp) { int i, j; memset(m->n_plp, 0, m->n * sizeof(int)); - for (i = 0; i < n; ++i) { - for (j = 0; j < n_plp[i]; ++j) { + for (i = 0; i < n; ++i) // iterate over all bams + { + for (j = 0; j < n_plp[i]; ++j) // iterate over all reads available at this position + { const bam_pileup1_t *p = plp[i] + j; - uint8_t *q; - int id = -1; - q = ignore_rg? NULL : bam_aux_get(p->b, "RG"); - if (q) id = bam_smpl_rg2smid(sm, fn[i], (char*)q+1, buf); - if (id < 0) id = bam_smpl_rg2smid(sm, fn[i], 0, buf); - if (id < 0 || id >= m->n) { - assert(q); // otherwise a bug - fprintf(stderr, "[%s] Read group %s used in file %s but absent from the header or an alignment missing read group.\n", __func__, (char*)q+1, fn[i]); - exit(EXIT_FAILURE); - } - if (m->n_plp[id] == m->m_plp[id]) { + int id = bam_smpl_get_sample_id(bsmpl,i,p->b); + if (m->n_plp[id] == m->m_plp[id]) + { m->m_plp[id] = m->m_plp[id]? m->m_plp[id]<<1 : 8; m->plp[id] = (bam_pileup1_t*) realloc(m->plp[id], sizeof(bam_pileup1_t) * m->m_plp[id]); } @@ -330,7 +308,7 @@ static int mpileup_reg(mplp_conf_t *conf, uint32_t beg, uint32_t end) int total_depth, _ref0, ref16; for (i = total_depth = 0; i < conf->nfiles; ++i) total_depth += conf->n_plp[i]; - group_smpl(conf->gplp, conf->smpl, &conf->buf, conf->nfiles, conf->files, conf->n_plp, conf->plp, conf->flag & MPLP_IGNORE_RG); + group_smpl(conf->gplp, conf->bsmpl, conf->nfiles, conf->n_plp, conf->plp); _ref0 = (ref && pos < ref_len)? ref[pos] : 'N'; ref16 = seq_nt16_table[_ref0]; bcf_callaux_clean(conf->bca, &conf->bc); @@ -363,9 +341,6 @@ static int mpileup_reg(mplp_conf_t *conf, uint32_t beg, uint32_t end) static int mpileup(mplp_conf_t *conf) { - extern void *bcf_call_add_rg(void *rghash, const char *hdtext, const char *list); - extern void bcf_call_del_rghash(void *rghash); - if (conf->nfiles == 0) { fprintf(stderr,"[%s] no input file/data given\n", __func__); exit(EXIT_FAILURE); @@ -376,32 +351,6 @@ static int mpileup(mplp_conf_t *conf) conf->mplp_data = (mplp_aux_t**) calloc(conf->nfiles, sizeof(mplp_aux_t*)); conf->plp = (const bam_pileup1_t**) calloc(conf->nfiles, sizeof(bam_pileup1_t*)); conf->n_plp = (int*) calloc(conf->nfiles, sizeof(int)); - conf->smpl = bam_smpl_init(); - - int i, samples_logic = 1; // 1: include, 0: exclude - void *samples_list = NULL; // hash of sample names to include or exclude - if ( conf->samples_list ) - { - int nsamples = 0; - char *list = conf->samples_list; - if ( list[0]=='^' ) - { - list++; - samples_logic = 0; - } - char **samples = hts_readlist(list, conf->sample_is_file, &nsamples); - if (!samples) { - fprintf(stderr,"[%s] could not read the samples list %s\n", __func__, list); - exit(EXIT_FAILURE); - } - if ( nsamples ) samples_list = khash_str2int_init(); - for (i=0; infiles; ++i) { bam_hdr_t *h_tmp; conf->mplp_data[i] = (mplp_aux_t*) calloc(1, sizeof(mplp_aux_t)); @@ -460,12 +410,20 @@ static int mpileup(mplp_conf_t *conf) fprintf(stderr,"[%s] fail to read the header of %s\n", __func__, conf->files[i]); exit(EXIT_FAILURE); } - conf->mplp_data[i]->h = i? hdr : h_tmp; // for i==0, "h" has not been set yet - conf->mplp_data[i]->rghash_exc = conf->rghash_exc; - if ( samples_list ) conf->mplp_data[i]->rghash_inc = khash_str2int_init(); - bam_smpl_add(conf->smpl, conf->files[i], (conf->flag&MPLP_IGNORE_RG)? 0 : h_tmp->text, samples_list, samples_logic, conf->mplp_data[i]->rghash_inc); - // Collect read group IDs with PL (platform) listed in pl_list (note: fragile, strstr search) - conf->mplp_data[i]->rghash_exc = bcf_call_add_rg(conf->mplp_data[i]->rghash_exc, h_tmp->text, conf->pl_list); + conf->mplp_data[i]->h = i ? hdr : h_tmp; // for j==0, "h" has not been set yet + conf->mplp_data[i]->bam_id = bam_smpl_add_bam(conf->bsmpl,h_tmp->text,conf->files[i]); + if ( conf->mplp_data[i]->bam_id<0 ) + { + // no usable readgroups in this bam, it can be skipped + sam_close(conf->mplp_data[i]->fp); + free(conf->mplp_data[i]); + bam_hdr_destroy(h_tmp); + free(conf->files[i]); + if ( i+1nfiles ) memmove(&conf->files[i],&conf->files[i+1],sizeof(*conf->files)*(conf->nfiles-i-1)); + conf->nfiles--; + i--; + continue; + } if (conf->reg) { hts_idx_t *idx = sam_index_load(conf->mplp_data[i]->fp, conf->files[i]); if (idx == NULL) { @@ -491,7 +449,7 @@ static int mpileup(mplp_conf_t *conf) conf->mplp_data[i]->idx = idx; } - if (i == 0) hdr = h_tmp; /* save the header of first file in list */ + if ( !hdr ) hdr = h_tmp; /* save the header of first file in list */ else { // FIXME: check consistency between h and h_tmp bam_hdr_destroy(h_tmp); @@ -502,12 +460,12 @@ static int mpileup(mplp_conf_t *conf) } } // allocate data storage proportionate to number of samples being studied sm->n - conf->gplp->n = conf->smpl->n; - conf->gplp->n_plp = (int*) calloc(conf->smpl->n, sizeof(int)); - conf->gplp->m_plp = (int*) calloc(conf->smpl->n, sizeof(int)); - conf->gplp->plp = (bam_pileup1_t**) calloc(conf->smpl->n, sizeof(bam_pileup1_t*)); + bam_smpl_get_samples(conf->bsmpl, &conf->gplp->n); + conf->gplp->n_plp = (int*) calloc(conf->gplp->n, sizeof(int)); + conf->gplp->m_plp = (int*) calloc(conf->gplp->n, sizeof(int)); + conf->gplp->plp = (bam_pileup1_t**) calloc(conf->gplp->n, sizeof(bam_pileup1_t*)); - fprintf(stderr, "[%s] %d samples in %d input files\n", __func__, conf->smpl->n, conf->nfiles); + fprintf(stderr, "[%s] %d samples in %d input files\n", __func__, conf->gplp->n, conf->nfiles); // write the VCF header conf->bcf_fp = hts_open(conf->output_fname?conf->output_fname:"-", hts_bcf_wmode(conf->output_type)); if (conf->bcf_fp == NULL) { @@ -597,32 +555,33 @@ static int mpileup(mplp_conf_t *conf) if ( conf->gvcf ) gvcf_update_header(conf->gvcf, conf->bcf_hdr); - for (i=0; ismpl->n; i++) - bcf_hdr_add_sample(conf->bcf_hdr, conf->smpl->smpl[i]); - bcf_hdr_add_sample(conf->bcf_hdr, NULL); + int nsmpl; + const char **smpl = bam_smpl_get_samples(conf->bsmpl, &nsmpl); + for (i=0; ibcf_hdr, smpl[i]); bcf_hdr_write(conf->bcf_fp, conf->bcf_hdr); conf->bca = bcf_call_init(-1., conf->min_baseQ); - conf->bcr = (bcf_callret1_t*) calloc(conf->smpl->n, sizeof(bcf_callret1_t)); + conf->bcr = (bcf_callret1_t*) calloc(nsmpl, sizeof(bcf_callret1_t)); conf->bca->openQ = conf->openQ, conf->bca->extQ = conf->extQ, conf->bca->tandemQ = conf->tandemQ; conf->bca->min_frac = conf->min_frac; conf->bca->min_support = conf->min_support; conf->bca->per_sample_flt = conf->flag & MPLP_PER_SAMPLE; conf->bc.bcf_hdr = conf->bcf_hdr; - conf->bc.n = conf->smpl->n; - conf->bc.PL = (int32_t*) malloc(15 * conf->smpl->n * sizeof(*conf->bc.PL)); + conf->bc.n = nsmpl; + conf->bc.PL = (int32_t*) malloc(15 * nsmpl * sizeof(*conf->bc.PL)); if (conf->fmt_flag) { assert( sizeof(float)==sizeof(int32_t) ); - conf->bc.DP4 = (int32_t*) malloc(conf->smpl->n * sizeof(int32_t) * 4); - conf->bc.fmt_arr = (uint8_t*) malloc(conf->smpl->n * sizeof(float)); // all fmt_flag fields, float and int32 + conf->bc.DP4 = (int32_t*) malloc(nsmpl * sizeof(int32_t) * 4); + conf->bc.fmt_arr = (uint8_t*) malloc(nsmpl * sizeof(float)); // all fmt_flag fields, float and int32 if ( conf->fmt_flag&(B2B_INFO_DPR|B2B_FMT_DPR|B2B_INFO_AD|B2B_INFO_ADF|B2B_INFO_ADR|B2B_FMT_AD|B2B_FMT_ADF|B2B_FMT_ADR) ) { // first B2B_MAX_ALLELES fields for total numbers, the rest per-sample - conf->bc.ADR = (int32_t*) malloc((conf->smpl->n+1)*B2B_MAX_ALLELES*sizeof(int32_t)); - conf->bc.ADF = (int32_t*) malloc((conf->smpl->n+1)*B2B_MAX_ALLELES*sizeof(int32_t)); - for (i=0; ismpl->n; i++) + conf->bc.ADR = (int32_t*) malloc((nsmpl+1)*B2B_MAX_ALLELES*sizeof(int32_t)); + conf->bc.ADF = (int32_t*) malloc((nsmpl+1)*B2B_MAX_ALLELES*sizeof(int32_t)); + for (i=0; ibcr[i].ADR = conf->bc.ADR + (i+1)*B2B_MAX_ALLELES; conf->bcr[i].ADF = conf->bc.ADF + (i+1)*B2B_MAX_ALLELES; @@ -633,14 +592,14 @@ static int mpileup(mplp_conf_t *conf) // init mpileup conf->iter = bam_mplp_init(conf->nfiles, mplp_func, (void**)conf->mplp_data); if ( conf->flag & MPLP_SMART_OVERLAPS ) bam_mplp_init_overlaps(conf->iter); - if ( conf->max_depth * conf->smpl->n > 1<<20) + if ( conf->max_depth * nsmpl > 1<<20) fprintf(stderr, "(%s) Max depth is above 1M. Potential memory hog!\n", __func__); - if ( conf->max_depth * conf->smpl->n < 8000) { - conf->max_depth = 8000 / conf->smpl->n; + if ( conf->max_depth * nsmpl < 8000) { + conf->max_depth = 8000 / nsmpl; fprintf(stderr, "<%s> Set max per-file depth to %d\n", __func__, conf->max_depth); } bam_mplp_set_maxcnt(conf->iter, conf->max_depth); - conf->max_indel_depth = conf->max_indel_depth * conf->smpl->n; + conf->max_indel_depth = conf->max_indel_depth * nsmpl; conf->bcf_rec = bcf_init1(); // Run mpileup for multiple regions @@ -697,7 +656,7 @@ static int mpileup(mplp_conf_t *conf) free(conf->bcr); } if ( conf->gvcf ) gvcf_destroy(conf->gvcf); - bam_smpl_destroy(conf->smpl); free(conf->buf.s); + free(conf->buf.s); for (i = 0; i < conf->gplp->n; ++i) free(conf->gplp->plp[i]); free(conf->gplp->plp); free(conf->gplp->n_plp); free(conf->gplp->m_plp); free(conf->gplp); bam_mplp_destroy(conf->iter); @@ -706,11 +665,9 @@ static int mpileup(mplp_conf_t *conf) if ( nregs>1 ) hts_idx_destroy(conf->mplp_data[i]->idx); sam_close(conf->mplp_data[i]->fp); if ( conf->mplp_data[i]->iter) hts_itr_destroy(conf->mplp_data[i]->iter); - if ( conf->mplp_data[i]->rghash_inc ) khash_str2int_destroy_free(conf->mplp_data[i]->rghash_inc); free(conf->mplp_data[i]); } free(conf->mplp_data); free(conf->plp); free(conf->n_plp); - if ( samples_list ) khash_str2int_destroy_free(samples_list); free(mp_ref.ref[0]); free(mp_ref.ref[1]); return 0; @@ -853,7 +810,7 @@ static void print_usage(FILE *fp, const mplp_conf_t *mplp) fprintf(fp, " -E, --redo-BAQ recalculate BAQ on the fly, ignore existing BQs\n" " -f, --fasta-ref FILE faidx indexed reference sequence file\n" -" -G, --exclude-RG FILE exclude read groups listed in FILE\n" +" -G, --read-groups FILE select or exclude read groups listed in the file\n" " -q, --min-MQ INT skip alignments with mapQ smaller than INT [%d]\n", mplp->min_mq); fprintf(fp, " -Q, --min-BQ INT skip bases with baseQ/BAQ smaller than INT [%d]\n", mplp->min_baseQ); @@ -926,6 +883,7 @@ int bam_mpileup(int argc, char *argv[]) mplp.output_type = FT_VCF; mplp.record_cmd_line = 1; mplp.n_threads = 0; + mplp.bsmpl = bam_smpl_init(); static const struct option lopts[] = { @@ -951,8 +909,7 @@ int bam_mpileup(int argc, char *argv[]) {"redo-BAQ", no_argument, NULL, 'E'}, {"redo-baq", no_argument, NULL, 'E'}, {"fasta-ref", required_argument, NULL, 'f'}, - {"exclude-RG", required_argument, NULL, 'G'}, - {"exclude-rg", required_argument, NULL, 'G'}, + {"read-groups", required_argument, NULL, 'G'}, {"region", required_argument, NULL, 'r'}, {"regions", required_argument, NULL, 'r'}, {"regions-file", required_argument, NULL, 'R'}, @@ -991,7 +948,7 @@ int bam_mpileup(int argc, char *argv[]) break; case 3 : mplp.output_fname = optarg; break; case 4 : mplp.openQ = atoi(optarg); break; - case 5 : mplp.flag |= MPLP_IGNORE_RG; break; + case 5 : bam_smpl_ignore_readgroups(mplp.bsmpl); break; case 'g': mplp.gvcf = gvcf_init(optarg); if ( !mplp.gvcf ) error("Could not parse: --gvcf %s\n", optarg); @@ -1031,11 +988,8 @@ int bam_mpileup(int argc, char *argv[]) case 'I': mplp.flag |= MPLP_NO_INDEL; break; case 'E': mplp.flag |= MPLP_REDO_BAQ; break; case '6': mplp.flag |= MPLP_ILLUMINA13; break; - case 's': mplp.samples_list = optarg; break; - case 'S': - mplp.samples_list = optarg; - mplp.sample_is_file = 1; - break; + case 's': if ( bam_smpl_add_samples(mplp.bsmpl,optarg,0)<0 ) error("Could not read samples: %s\n",optarg); break; + case 'S': if ( bam_smpl_add_samples(mplp.bsmpl,optarg,1)<0 ) error("Could not read samples: %s\n",optarg); break; case 'O': switch (optarg[0]) { case 'b': mplp.output_type = FT_BCF_GZ; break; @@ -1063,17 +1017,7 @@ int bam_mpileup(int argc, char *argv[]) case 'F': mplp.min_frac = atof(optarg); break; case 'm': mplp.min_support = atoi(optarg); break; case 'L': mplp.max_indel_depth = atoi(optarg); break; - case 'G': { - FILE *fp_rg; - char buf[1024]; - mplp.rghash_exc = khash_str2int_init(); - if ((fp_rg = fopen(optarg, "r")) == NULL) - fprintf(stderr, "(%s) Fail to open file %s. Continue anyway.\n", __func__, optarg); - while (!feof(fp_rg) && fscanf(fp_rg, "%s", buf) > 0) // this is not a good style, but forgive me... - khash_str2int_inc(mplp.rghash_exc, strdup(buf)); - fclose(fp_rg); - } - break; + case 'G': bam_smpl_add_readgroups(mplp.bsmpl, optarg, 1); break; case 'a': if (optarg[0]=='?') { list_annotations(stderr); @@ -1116,26 +1060,27 @@ int bam_mpileup(int argc, char *argv[]) print_usage(stderr, &mplp); return 1; } - int ret; + int ret,i; if (file_list) { if ( read_file_list(file_list,&nfiles,&fn) ) return 1; mplp.files = fn; mplp.nfiles = nfiles; - ret = mpileup(&mplp); - for (c=0; c +##contig= +##ALT= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##FORMAT= +#CHROM POS ID REF ALT QUAL FILTER INFO FORMAT SAMPLE1b HG00100 SAMPLE1a SAMPLE2 SAMPLE3 +17 100 . C <*> 0 . DP=16;I16=15,0,0,0,609,26637,0,0,838,48482,0,0,310,7132,0,0;QS=5,0;MQ0F=0 PL 0,3,19 0,6,78 0,12,128 0,9,108 0,15,134 +17 101 . C <*> 0 . DP=16;I16=15,0,0,0,587,25433,0,0,838,48482,0,0,309,7011,0,0;QS=5,0;MQ0F=0 PL 0,3,22 0,6,79 0,12,123 0,9,99 0,15,132 +17 102 . C <*> 0 . DP=16;I16=15,0,0,0,621,27715,0,0,838,48482,0,0,308,6904,0,0;QS=5,0;MQ0F=0 PL 0,3,20 0,6,78 0,12,129 0,9,111 0,15,139 +17 103 . T <*> 0 . DP=16;I16=14,0,0,0,612,28790,0,0,809,47641,0,0,301,6775,0,0;QS=4,0;MQ0F=0 PL 0,0,0 0,6,79 0,12,131 0,9,108 0,15,147 +17 104 . G <*> 0 . DP=16;I16=13,0,0,0,546,24526,0,0,780,46800,0,0,273,6009,0,0;QS=4,0;MQ0F=0 PL 0,0,0 0,6,78 0,12,123 0,6,89 0,15,133 +17 105 . G <*> 0 . DP=17;I16=15,0,0,0,542,21886,0,0,869,51241,0,0,295,6507,0,0;QS=5,0;MQ0F=0 PL 0,3,26 0,6,77 0,12,106 0,9,97 0,15,125 +17 106 . G <*> 0 . DP=17;I16=15,0,0,0,570,23834,0,0,869,51241,0,0,277,5851,0,0;QS=5,0;MQ0F=0 PL 0,6,43 0,6,75 0,12,130 0,6,85 0,15,124 +17 107 . C <*> 0 . DP=17;I16=15,0,0,0,614,26864,0,0,869,51241,0,0,291,6299,0,0;QS=5,0;MQ0F=0 PL 0,3,30 0,6,77 0,12,130 0,9,108 0,15,136 +17 108 . C <*> 0 . DP=17;I16=15,0,0,0,615,27183,0,0,869,51241,0,0,288,6170,0,0;QS=5,0;MQ0F=0 PL 0,3,30 0,6,78 0,12,128 0,9,108 0,15,135 +17 109 . T <*> 0 . DP=17;I16=15,0,0,0,664,31304,0,0,869,51241,0,0,285,6059,0,0;QS=5,0;MQ0F=0 PL 0,3,33 0,6,77 0,12,133 0,9,110 0,15,150 +17 110 . G <*> 0 . DP=17;I16=15,0,0,0,624,28074,0,0,869,51241,0,0,282,5966,0,0;QS=5,0;MQ0F=0 PL 0,3,35 0,6,78 0,12,130 0,9,104 0,15,136 +17 111 . G <*> 0 . DP=17;I16=14,0,0,0,514,21894,0,0,809,47641,0,0,250,5124,0,0;QS=5,0;MQ0F=0 PL 0,6,45 0,6,75 0,12,92 0,6,88 0,12,118 +17 112 . C <*> 0 . DP=17;I16=15,0,0,0,600,26654,0,0,869,51241,0,0,274,5738,0,0;QS=5,0;MQ0F=0 PL 0,3,30 0,6,77 0,12,129 0,9,95 0,15,135 +17 113 . A <*> 0 . DP=17;I16=14,0,0,0,575,25583,0,0,840,50400,0,0,244,4978,0,0;QS=5,0;MQ0F=0 PL 0,3,30 0,6,71 0,12,120 0,6,87 0,15,139 +17 114 . C <*> 0 . DP=17;I16=15,0,0,0,595,25667,0,0,869,51241,0,0,264,5486,0,0;QS=5,0;MQ0F=0 PL 0,3,33 0,6,75 0,12,118 0,9,103 0,15,133 +17 115 . C <*> 0 . DP=19;I16=16,0,0,0,635,27881,0,0,929,54841,0,0,252,5086,0,0;QS=5,0;MQ0F=0 PL 0,6,43 0,6,80 0,12,123 0,6,89 0,18,147 +17 116 . A <*> 0 . DP=19;I16=15,1,0,0,653,29009,0,0,929,54841,0,0,231,4637,0,0;QS=5,0;MQSB=1;MQ0F=0 PL 0,3,37 0,6,75 0,12,121 0,6,90 0,21,175 +17 117 . G <*> 0 . DP=19;I16=15,1,0,0,642,27956,0,0,929,54841,0,0,227,4535,0,0;QS=5,0;MQSB=1;MQ0F=0 PL 0,3,37 0,6,77 0,12,117 0,6,85 0,21,177 +17 118 . G <*> 0 . DP=19;I16=15,1,0,0,599,25205,0,0,898,52082,0,0,243,4897,0,0;QS=5,0;MQSB=1;MQ0F=0 PL 0,6,43 0,6,77 0,12,116 0,3,60 0,21,162 +17 119 . G <*> 0 . DP=18;I16=15,1,0,0,591,24995,0,0,898,52082,0,0,243,4977,0,0;QS=5,0;MQSB=1;MQ0F=0 PL 0,3,38 0,6,78 0,12,114 0,6,73 0,21,160 +17 120 . A <*> 0 . DP=18;I16=15,1,0,0,634,27744,0,0,898,52082,0,0,239,4893,0,0;QS=5,0;MQSB=1;MQ0F=0 PL 0,3,41 0,6,75 0,12,116 0,6,83 0,21,171 +17 121 . G <*> 0 . DP=18;I16=15,1,0,0,631,27499,0,0,898,52082,0,0,235,4829,0,0;QS=5,0;MQSB=1;MQ0F=0 PL 0,3,39 0,6,80 0,12,121 0,6,80 0,21,168 +17 122 . C <*> 0 . DP=19;I16=16,1,0,0,675,29543,0,0,958,55682,0,0,231,4785,0,0;QS=5,0;MQSB=1;MQ0F=0 PL 0,3,40 0,6,78 0,12,119 0,9,99 0,21,178 +17 123 . T <*> 0 . DP=17;I16=14,1,0,0,624,28628,0,0,838,48482,0,0,230,4760,0,0;QS=5,0;MQSB=1;MQ0F=0 PL 0,3,39 0,6,75 0,9,98 0,9,112 0,18,166 +17 124 . T <*> 0 . DP=17;I16=15,1,0,0,567,23061,0,0,867,49323,0,0,254,5378,0,0;QS=5,0;MQSB=1;MQ0F=0 PL 0,6,33 0,6,70 0,9,89 0,9,104 0,18,154 +17 125 . A <*> 0 . DP=16;I16=13,1,0,0,544,23440,0,0,778,44882,0,0,228,4714,0,0;QS=5,0;MQSB=1;MQ0F=0 PL 0,3,38 0,6,72 0,6,63 0,9,104 0,18,162 +17 126 . A <*> 0 . DP=16;I16=14,1,0,0,577,24833,0,0,807,45723,0,0,252,5318,0,0;QS=5,0;MQSB=1;MQ0F=0 PL 0,6,50 0,6,72 0,6,67 0,9,107 0,18,174 +17 127 . C <*> 0 . DP=16;I16=14,1,0,0,573,24303,0,0,807,45723,0,0,251,5315,0,0;QS=5,0;MQSB=1;MQ0F=0 PL 0,6,46 0,6,69 0,6,75 0,9,109 0,18,160 +17 128 . A <*> 0 . DP=16;I16=14,1,0,0,601,26205,0,0,807,45723,0,0,250,5330,0,0;QS=5,0;MQSB=1;MQ0F=0 PL 0,6,59 0,6,74 0,6,72 0,9,111 0,18,162 +17 129 . A <*> 0 . DP=15;I16=13,1,0,0,576,25510,0,0,747,42123,0,0,250,5362,0,0;QS=5,0;MQSB=1;MQ0F=0 PL 0,6,59 0,6,72 0,6,73 0,9,113 0,15,159 +17 130 . A <*> 0 . DP=15;I16=13,1,0,0,570,24774,0,0,747,42123,0,0,250,5410,0,0;QS=5,0;MQSB=1;MQ0F=0 PL 0,6,60 0,6,76 0,6,68 0,9,113 0,15,152 +17 131 . C <*> 0 . DP=14;I16=12,1,0,0,530,22844,0,0,718,41282,0,0,224,4798,0,0;QS=5,0;MQSB=1;MQ0F=0 PL 0,3,38 0,6,77 0,6,71 0,9,110 0,15,147 +17 132 . A <*> 0 . DP=14;I16=12,1,0,0,552,24766,0,0,718,41282,0,0,223,4825,0,0;QS=5,0;MQSB=1;MQ0F=0 PL 0,3,42 0,6,73 0,6,75 0,9,110 0,15,151 +17 133 . T <*> 0 . DP=13;I16=11,2,0,0,512,20224,0,0,718,41282,0,0,248,5490,0,0;QS=5,0;MQSB=0.590909;MQ0F=0 PL 0,3,38 0,6,74 0,6,71 0,9,105 0,15,150 +17 134 . C <*> 0 . DP=13;I16=11,2,0,0,526,21368,0,0,718,41282,0,0,248,5542,0,0;QS=5,0;MQSB=0.590909;MQ0F=0 PL 0,3,41 0,6,79 0,6,77 0,9,105 0,15,152 +17 135 . T <*> 0 . DP=13;I16=11,2,0,0,523,21213,0,0,718,41282,0,0,248,5606,0,0;QS=5,0;MQSB=0.590909;MQ0F=0 PL 0,3,40 0,6,78 0,6,77 0,9,106 0,15,156 +17 136 . G <*> 0 . DP=13;I16=11,2,0,0,495,19137,0,0,718,41282,0,0,249,5681,0,0;QS=5,0;MQSB=0.590909;MQ0F=0 PL 0,3,39 0,6,79 0,6,71 0,9,105 0,15,134 +17 137 . T <*> 0 . DP=13;I16=11,2,0,0,494,18984,0,0,718,41282,0,0,251,5767,0,0;QS=5,0;MQSB=0.590909;MQ0F=0 PL 0,3,39 0,6,73 0,6,69 0,9,104 0,15,139 +17 138 . C <*> 0 . DP=13;I16=11,2,0,0,504,19886,0,0,718,41282,0,0,252,5816,0,0;QS=5,0;MQSB=0.590909;MQ0F=0 PL 0,3,40 0,6,79 0,6,71 0,9,108 0,15,142 +17 139 . C <*> 0 . DP=13;I16=11,2,0,0,479,17977,0,0,718,41282,0,0,252,5830,0,0;QS=5,0;MQSB=0.590909;MQ0F=0 PL 0,3,37 0,6,76 0,6,62 0,9,106 0,15,143 +17 140 . A <*> 0 . DP=13;I16=11,2,0,0,509,20051,0,0,718,41282,0,0,251,5809,0,0;QS=5,0;MQSB=0.590909;MQ0F=0 PL 0,3,39 0,6,73 0,6,70 0,9,107 0,15,153 +17 141 . G <*> 0 . DP=12;I16=10,2,0,0,452,17388,0,0,658,37682,0,0,250,5750,0,0;QS=5,0;MQSB=0.6;MQ0F=0 PL 0,3,36 0,6,79 0,3,34 0,9,108 0,15,142 +17 142 . C <*> 0 . DP=12;I16=10,2,0,0,426,15624,0,0,658,37682,0,0,249,5701,0,0;QS=5,0;MQSB=0.6;MQ0F=0 PL 0,3,39 0,6,78 0,3,37 0,9,97 0,15,129 +17 143 . G <*> 0 . DP=12;I16=9,2,0,0,353,11735,0,0,598,34082,0,0,241,5613,0,0;QS=5,0;MQSB=0.611111;MQ0F=0 PL 0,3,33 0,6,60 0,3,36 0,9,95 0,12,97 +17 144 . A <*> 0 . DP=12;I16=10,2,0,0,443,16837,0,0,658,37682,0,0,246,5584,0,0;QS=5,0;MQSB=0.6;MQ0F=0 PL 0,3,33 0,6,75 0,3,41 0,9,105 0,15,129 +17 145 . A <*> 0 . DP=12;I16=10,2,0,0,451,17401,0,0,658,37682,0,0,244,5518,0,0;QS=5,0;MQSB=0.6;MQ0F=0 PL 0,3,42 0,6,74 0,3,34 0,9,106 0,15,138 +17 146 . T <*> 0 . DP=12;I16=10,2,0,0,439,16671,0,0,658,37682,0,0,242,5464,0,0;QS=5,0;MQSB=0.6;MQ0F=0 PL 0,3,37 0,6,73 0,3,41 0,9,103 0,15,128 +17 147 . A <*> 0 . DP=12;I16=10,2,0,0,444,16692,0,0,658,37682,0,0,240,5422,0,0;QS=5,0;MQSB=0.6;MQ0F=0 PL 0,3,40 0,6,70 0,3,41 0,9,99 0,15,140 +17 148 . C <*> 0 . DP=12;I16=10,2,0,0,465,18131,0,0,658,37682,0,0,237,5341,0,0;QS=5,0;MQSB=0.6;MQ0F=0 PL 0,3,39 0,6,77 0,3,41 0,9,106 0,15,146 +17 149 . C <*> 0 . DP=12;I16=10,2,0,0,433,16205,0,0,658,37682,0,0,233,5221,0,0;QS=5,0;MQSB=0.6;MQ0F=0 PL 0,3,38 0,6,77 0,3,18 0,9,109 0,15,140 +17 150 . T <*> 0 . DP=11;I16=9,2,0,0,436,17434,0,0,629,36841,0,0,230,5112,0,0;QS=5,0;MQSB=0.5;MQ0F=0 PL 0,3,36 0,6,76 0,3,40 0,6,84 0,15,152 diff --git a/test/mpileup/mpileup.9.out b/test/mpileup/mpileup.9.out new file mode 100644 index 000000000..56efb518b --- /dev/null +++ b/test/mpileup/mpileup.9.out @@ -0,0 +1,70 @@ +##fileformat=VCFv4.2 +##FILTER= +##contig= +##ALT= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##INFO= +##FORMAT= +#CHROM POS ID REF ALT QUAL FILTER INFO FORMAT SAMPLE1 SAMPLE2 +17 100 . C <*> 0 . DP=9;I16=8,0,0,0,338,15668,0,0,449,26041,0,0,173,4019,0,0;QS=2,0;MQ0F=0 PL 0,9,108 0,15,134 +17 101 . C <*> 0 . DP=9;I16=8,0,0,0,319,14829,0,0,449,26041,0,0,172,3954,0,0;QS=2,0;MQ0F=0 PL 0,9,99 0,15,132 +17 102 . C <*> 0 . DP=9;I16=8,0,0,0,346,16476,0,0,449,26041,0,0,171,3895,0,0;QS=2,0;MQ0F=0 PL 0,9,111 0,15,139 +17 103 . T <*> 0 . DP=9;I16=8,0,0,0,354,17694,0,0,449,26041,0,0,170,3842,0,0;QS=2,0;MQ0F=0 PL 0,9,108 0,15,147 +17 104 . G <*> 0 . DP=9;I16=7,0,0,0,301,14499,0,0,420,25200,0,0,143,3121,0,0;QS=2,0;MQ0F=0 PL 0,6,89 0,15,133 +17 105 . G <*> 0 . DP=9;I16=8,0,0,0,298,12944,0,0,449,26041,0,0,166,3658,0,0;QS=2,0;MQ0F=0 PL 0,9,97 0,15,125 +17 106 . G <*> 0 . DP=9;I16=7,0,0,0,273,12195,0,0,420,25200,0,0,139,2953,0,0;QS=2,0;MQ0F=0 PL 0,6,85 0,15,124 +17 107 . C <*> 0 . DP=9;I16=8,0,0,0,330,15206,0,0,449,26041,0,0,162,3506,0,0;QS=2,0;MQ0F=0 PL 0,9,108 0,15,136 +17 108 . C <*> 0 . DP=9;I16=8,0,0,0,334,15764,0,0,449,26041,0,0,159,3393,0,0;QS=2,0;MQ0F=0 PL 0,9,108 0,15,135 +17 109 . T <*> 0 . DP=9;I16=8,0,0,0,374,19190,0,0,449,26041,0,0,156,3290,0,0;QS=2,0;MQ0F=0 PL 0,9,110 0,15,150 +17 110 . G <*> 0 . DP=9;I16=8,0,0,0,335,16083,0,0,449,26041,0,0,153,3197,0,0;QS=2,0;MQ0F=0 PL 0,9,104 0,15,136 +17 111 . G <*> 0 . DP=9;I16=6,0,0,0,268,13602,0,0,360,21600,0,0,107,2151,0,0;QS=2,0;MQ0F=0 PL 0,6,88 0,12,118 +17 112 . C <*> 0 . DP=9;I16=8,0,0,0,318,15164,0,0,449,26041,0,0,145,2945,0,0;QS=2,0;MQ0F=0 PL 0,9,95 0,15,135 +17 113 . A <*> 0 . DP=9;I16=7,0,0,0,311,15545,0,0,420,25200,0,0,116,2212,0,0;QS=2,0;MQ0F=0 PL 0,6,87 0,15,139 +17 114 . C <*> 0 . DP=9;I16=8,0,0,0,327,15347,0,0,449,26041,0,0,137,2741,0,0;QS=2,0;MQ0F=0 PL 0,9,103 0,15,133 +17 115 . C <*> 0 . DP=11;I16=8,0,0,0,341,16381,0,0,480,28800,0,0,108,2032,0,0;QS=2,0;MQ0F=0 PL 0,6,89 0,18,147 +17 116 . A <*> 0 . DP=11;I16=8,1,0,0,376,18032,0,0,509,29641,0,0,107,1965,0,0;QS=2,0;MQSB=1;MQ0F=0 PL 0,6,90 0,21,175 +17 117 . G <*> 0 . DP=11;I16=8,1,0,0,370,17312,0,0,509,29641,0,0,105,1913,0,0;QS=2,0;MQSB=1;MQ0F=0 PL 0,6,85 0,21,177 +17 118 . G <*> 0 . DP=11;I16=7,1,0,0,319,14789,0,0,449,26041,0,0,102,1876,0,0;QS=2,0;MQSB=1;MQ0F=0 PL 0,3,60 0,21,162 +17 119 . G <*> 0 . DP=10;I16=8,1,0,0,321,14467,0,0,478,26882,0,0,125,2431,0,0;QS=2,0;MQSB=1;MQ0F=0 PL 0,6,73 0,21,160 +17 120 . A <*> 0 . DP=10;I16=8,1,0,0,361,17053,0,0,478,26882,0,0,123,2373,0,0;QS=2,0;MQSB=1;MQ0F=0 PL 0,6,83 0,21,171 +17 121 . G <*> 0 . DP=10;I16=8,1,0,0,347,15913,0,0,478,26882,0,0,121,2327,0,0;QS=2,0;MQSB=1;MQ0F=0 PL 0,6,80 0,21,168 +17 122 . C <*> 0 . DP=11;I16=9,1,0,0,396,18360,0,0,538,30482,0,0,119,2293,0,0;QS=2,0;MQSB=1;MQ0F=0 PL 0,9,99 0,21,178 +17 123 . T <*> 0 . DP=10;I16=8,1,0,0,387,19215,0,0,478,26882,0,0,119,2271,0,0;QS=2,0;MQSB=1;MQ0F=0 PL 0,9,112 0,18,166 +17 124 . T <*> 0 . DP=10;I16=8,1,0,0,350,15768,0,0,478,26882,0,0,119,2261,0,0;QS=2,0;MQSB=1;MQ0F=0 PL 0,9,104 0,18,154 +17 125 . A <*> 0 . DP=10;I16=8,1,0,0,358,16494,0,0,478,26882,0,0,118,2214,0,0;QS=2,0;MQSB=1;MQ0F=0 PL 0,9,104 0,18,162 +17 126 . A <*> 0 . DP=10;I16=8,1,0,0,373,17399,0,0,478,26882,0,0,117,2181,0,0;QS=2,0;MQSB=1;MQ0F=0 PL 0,9,107 0,18,174 +17 127 . C <*> 0 . DP=10;I16=8,1,0,0,366,16632,0,0,478,26882,0,0,116,2162,0,0;QS=2,0;MQSB=1;MQ0F=0 PL 0,9,109 0,18,160 +17 128 . A <*> 0 . DP=10;I16=8,1,0,0,378,17674,0,0,478,26882,0,0,115,2157,0,0;QS=2,0;MQSB=1;MQ0F=0 PL 0,9,111 0,18,162 +17 129 . A <*> 0 . DP=9;I16=7,1,0,0,354,17046,0,0,418,23282,0,0,115,2165,0,0;QS=2,0;MQSB=1;MQ0F=0 PL 0,9,113 0,15,159 +17 130 . A <*> 0 . DP=9;I16=7,1,0,0,349,16363,0,0,418,23282,0,0,115,2185,0,0;QS=2,0;MQSB=1;MQ0F=0 PL 0,9,113 0,15,152 +17 131 . C <*> 0 . DP=9;I16=7,1,0,0,330,14822,0,0,418,23282,0,0,115,2217,0,0;QS=2,0;MQSB=1;MQ0F=0 PL 0,9,110 0,15,147 +17 132 . A <*> 0 . DP=9;I16=7,1,0,0,348,16432,0,0,418,23282,0,0,115,2261,0,0;QS=2,0;MQSB=1;MQ0F=0 PL 0,9,110 0,15,151 +17 133 . T <*> 0 . DP=8;I16=6,2,0,0,315,12451,0,0,418,23282,0,0,141,2941,0,0;QS=2,0;MQSB=0.666667;MQ0F=0 PL 0,9,105 0,15,150 +17 134 . C <*> 0 . DP=8;I16=6,2,0,0,314,12374,0,0,418,23282,0,0,142,3006,0,0;QS=2,0;MQSB=0.666667;MQ0F=0 PL 0,9,105 0,15,152 +17 135 . T <*> 0 . DP=8;I16=6,2,0,0,314,12470,0,0,418,23282,0,0,143,3081,0,0;QS=2,0;MQSB=0.666667;MQ0F=0 PL 0,9,106 0,15,156 +17 136 . G <*> 0 . DP=8;I16=6,2,0,0,291,10787,0,0,418,23282,0,0,145,3165,0,0;QS=2,0;MQSB=0.666667;MQ0F=0 PL 0,9,105 0,15,134 +17 137 . T <*> 0 . DP=8;I16=6,2,0,0,300,11444,0,0,418,23282,0,0,148,3258,0,0;QS=2,0;MQSB=0.666667;MQ0F=0 PL 0,9,104 0,15,139 +17 138 . C <*> 0 . DP=8;I16=6,2,0,0,300,11542,0,0,418,23282,0,0,150,3312,0,0;QS=2,0;MQSB=0.666667;MQ0F=0 PL 0,9,108 0,15,142 +17 139 . C <*> 0 . DP=8;I16=6,2,0,0,291,10833,0,0,418,23282,0,0,152,3378,0,0;QS=2,0;MQSB=0.666667;MQ0F=0 PL 0,9,106 0,15,143 +17 140 . A <*> 0 . DP=8;I16=6,2,0,0,314,12410,0,0,418,23282,0,0,153,3405,0,0;QS=2,0;MQSB=0.666667;MQ0F=0 PL 0,9,107 0,15,153 +17 141 . G <*> 0 . DP=8;I16=6,2,0,0,295,11151,0,0,418,23282,0,0,153,3391,0,0;QS=2,0;MQSB=0.666667;MQ0F=0 PL 0,9,108 0,15,142 +17 142 . C <*> 0 . DP=8;I16=6,2,0,0,264,9036,0,0,418,23282,0,0,153,3385,0,0;QS=2,0;MQSB=0.666667;MQ0F=0 PL 0,9,97 0,15,129 +17 143 . G <*> 0 . DP=8;I16=5,2,0,0,218,7170,0,0,358,19682,0,0,146,3338,0,0;QS=2,0;MQSB=0.7;MQ0F=0 PL 0,9,95 0,12,97 +17 144 . A <*> 0 . DP=8;I16=6,2,0,0,287,10705,0,0,418,23282,0,0,153,3397,0,0;QS=2,0;MQSB=0.666667;MQ0F=0 PL 0,9,105 0,15,129 +17 145 . A <*> 0 . DP=8;I16=6,2,0,0,294,11200,0,0,418,23282,0,0,153,3415,0,0;QS=2,0;MQSB=0.666667;MQ0F=0 PL 0,9,106 0,15,138 +17 146 . T <*> 0 . DP=8;I16=6,2,0,0,281,10419,0,0,418,23282,0,0,153,3441,0,0;QS=2,0;MQSB=0.666667;MQ0F=0 PL 0,9,103 0,15,128 +17 147 . A <*> 0 . DP=8;I16=6,2,0,0,286,10442,0,0,418,23282,0,0,153,3475,0,0;QS=2,0;MQSB=0.666667;MQ0F=0 PL 0,9,99 0,15,140 +17 148 . C <*> 0 . DP=8;I16=6,2,0,0,301,11401,0,0,418,23282,0,0,152,3466,0,0;QS=2,0;MQSB=0.666667;MQ0F=0 PL 0,9,106 0,15,146 +17 149 . C <*> 0 . DP=8;I16=6,2,0,0,293,10907,0,0,418,23282,0,0,150,3414,0,0;QS=2,0;MQSB=0.666667;MQ0F=0 PL 0,9,109 0,15,140 +17 150 . T <*> 0 . DP=7;I16=5,2,0,0,277,11093,0,0,389,22441,0,0,149,3369,0,0;QS=2,0;MQSB=0.5;MQ0F=0 PL 0,6,84 0,15,152 diff --git a/test/mplp.10.samples b/test/mplp.10.samples new file mode 100644 index 000000000..5d8cc1377 --- /dev/null +++ b/test/mplp.10.samples @@ -0,0 +1,5 @@ +ERR162872 +ERR162875 SAMPLE1a +ERR013140 SAMPLE1b +ERR229776 SAMPLE2 +ERR229775 SAMPLE3 diff --git a/test/mplp.9.samples b/test/mplp.9.samples new file mode 100644 index 000000000..af6b516fe --- /dev/null +++ b/test/mplp.9.samples @@ -0,0 +1,2 @@ +HG00101 SAMPLE1 +HG00102 SAMPLE2 diff --git a/test/test.pl b/test/test.pl index 9c807d30e..4779cd271 100755 --- a/test/test.pl +++ b/test/test.pl @@ -261,7 +261,8 @@ test_mpileup($opts,in=>[qw(1 2 3)],out=>'mpileup/mpileup.7.out',args=>q[-r17:100-150 -S {PATH}/mplp.samples]); test_mpileup($opts,in=>[qw(1 2 3)],out=>'mpileup/mpileup.8.out',args=>q[-r17:100-150 -s ^HG00101,HG00102]); test_mpileup($opts,in=>[qw(1 2 3)],out=>'mpileup/mpileup.8.out',args=>q[-r17:100-150 -S ^{PATH}/mplp.samples]); -test_mpileup($opts,in=>[qw(1 2 3)],out=>'mpileup/mpileup.8.out',args=>q[-t17:100-150 -S ^{PATH}/mplp.samples]); +test_mpileup($opts,in=>[qw(1 2 3)],out=>'mpileup/mpileup.9.out',args=>q[-t17:100-150 -S {PATH}/mplp.9.samples]); +test_mpileup($opts,in=>[qw(1 2 3)],out=>'mpileup/mpileup.10.out',args=>q[-t17:100-150 -G {PATH}/mplp.10.samples]); print "\nNumber of tests:\n"; printf " total .. %d\n", $$opts{nok}+$$opts{nfailed}; From 251fe2afc26422e39b164a373ce93f22551f8261 Mon Sep 17 00:00:00 2001 From: James Bonfield Date: Tue, 12 Jul 2016 17:52:50 +0100 Subject: [PATCH 210/211] Make use of the pileup constructor/destructor interface. Our first foray into exploiting this is to cache the bam_smpl_get_sample_id return value. We compute this once in the constructor (the first time we see a new bam1_t) instead of for every pileup location in group_smpl. TO DO: Group_smpl itself could now become distributed perhaps. Rather than an N*M loop clustering all sample IDs together, each new bam could be added to sample struct on first appearance and removed when it goes out of sight. The slight caveat preventing this from being implemented immediately is that the constructor/destructors are called for every BAM overlapping the region rather than every filtered base that ultimately ends up in a pileup. Indeed sometimes we get constructors for reads entirely filtered out. --- mpileup.c | 15 ++++++++++++++- 1 file changed, 14 insertions(+), 1 deletion(-) diff --git a/mpileup.c b/mpileup.c index 8c2d4e147..01db650d8 100644 --- a/mpileup.c +++ b/mpileup.c @@ -243,6 +243,18 @@ static int mplp_func(void *data, bam1_t *b) return ret; } +// Called once per new bam added to the pileup. +// We cache sample information here so we don't have to keep recomputing this +// on each and every pileup column. +// +// Cd is an arbitrary block of data we can write into, which ends up in +// the pileup structures. We stash the sample ID there. +static int pileup_constructor(void *data, const bam1_t *b, bam_pileup_cd *cd) { + mplp_aux_t *ma = (mplp_aux_t *)data; + cd->i = bam_smpl_get_sample_id(ma->conf->bsmpl, ma->bam_id, (bam1_t *)b); + return 0; +} + static void group_smpl(mplp_pileup_t *m, bam_smpl_t *bsmpl, int n, int *n_plp, const bam_pileup1_t **plp) { int i, j; @@ -252,7 +264,7 @@ static void group_smpl(mplp_pileup_t *m, bam_smpl_t *bsmpl, int n, int *n_plp, c for (j = 0; j < n_plp[i]; ++j) // iterate over all reads available at this position { const bam_pileup1_t *p = plp[i] + j; - int id = bam_smpl_get_sample_id(bsmpl,i,p->b); + int id = p->cd.i; if (m->n_plp[id] == m->m_plp[id]) { m->m_plp[id] = m->m_plp[id]? m->m_plp[id]<<1 : 8; @@ -601,6 +613,7 @@ static int mpileup(mplp_conf_t *conf) bam_mplp_set_maxcnt(conf->iter, conf->max_depth); conf->max_indel_depth = conf->max_indel_depth * nsmpl; conf->bcf_rec = bcf_init1(); + bam_mplp_constructor(conf->iter, pileup_constructor); // Run mpileup for multiple regions if ( nregs ) From c333e8b45838109ebd206a1ef95a07901ccb86cc Mon Sep 17 00:00:00 2001 From: James Bonfield Date: Wed, 13 Jul 2016 11:34:10 +0100 Subject: [PATCH 211/211] Speed up of mpileup funcs. Mann Whitney test now uses a precomputed table instead of continually calculating the same values many times over. calc_mwu_bias now has short-cuts to compute the result faster when one or both of a[] and b[] hold zero values. --- bam2bcf.c | 32 +- mw.h | 1917 +++++++++++++++++++++++++++++++++++++++++++++++++++++ 2 files changed, 1941 insertions(+), 8 deletions(-) create mode 100644 mw.h diff --git a/bam2bcf.c b/bam2bcf.c index 8bb799ebd..b4fb7f1ef 100644 --- a/bam2bcf.c +++ b/bam2bcf.c @@ -350,11 +350,22 @@ double calc_chisq_bias(int *a, int *b, int n) return prob; } +static double mann_whitney_1947_(int n, int m, int U) +{ + if (U<0) return 0; + if (n==0||m==0) return U==0 ? 1 : 0; + return (double)n/(n+m)*mann_whitney_1947_(n-1,m,U-m) + (double)m/(n+m)*mann_whitney_1947_(n,m-1,U); +} + double mann_whitney_1947(int n, int m, int U) { - if (U<0) return 0; - if (n==0||m==0) return U==0 ? 1 : 0; - return (double)n/(n+m)*mann_whitney_1947(n-1,m,U-m) + (double)m/(n+m)*mann_whitney_1947(n,m-1,U); + #include "mw.h" + + assert(n >= 2 && m >= 2); + + return (n < 8 && m < 8 && U < 50) + ? mw[n-2][m-2][U] + : mann_whitney_1947_(n,m,U); } double mann_whitney_1947_cdf(int n, int m, int U) @@ -416,11 +427,16 @@ double calc_mwu_bias(int *a, int *b, int n) double U = 0, ties = 0; for (i=0; i + +double mann_whitney_1947(int n, int m, int U) +{ + if (U<0) return 0; + if (n==0||m==0) return U==0 ? 1 : 0; + return (double)n/(n+m)*mann_whitney_1947(n-1,m,U-m) + (double)m/(n+m)*mann_whitney_1947(n,m-1,U); +} + +int main(void) { + int i, j, k; + printf("static double mw[6][6][50] = // [2-7][2-7][0-49]\n{\n"); + for (i = 2; i < 8; i++) { + printf(" {\n"); + for (j = 2; j < 8; j++) { + printf(" {\n"); + for (k = 0; k < 50; k++) { + printf(" %.17f,\n", mann_whitney_1947(i,j,k)); + } + printf(" },\n"); + } + printf(" },\n"); + } + printf("};\n"); + return 0; +} +#endif + +static double mw[6][6][50] = // [2-7][2-7][0-49] +{ + { + { + 0.16666666666666666, + 0.16666666666666666, + 0.33333333333333331, + 0.16666666666666666, + 0.16666666666666666, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + }, + { + 0.09999999999999999, + 0.09999999999999999, + 0.19999999999999998, + 0.20000000000000001, + 0.20000000000000001, + 0.10000000000000001, + 0.10000000000000001, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + }, + { + 0.06666666666666665, + 0.06666666666666665, + 0.13333333333333330, + 0.13333333333333333, + 0.20000000000000001, + 0.13333333333333333, + 0.13333333333333333, + 0.06666666666666667, + 0.06666666666666667, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + }, + { + 0.04761904761904761, + 0.04761904761904761, + 0.09523809523809522, + 0.09523809523809523, + 0.14285714285714288, + 0.14285714285714285, + 0.14285714285714285, + 0.09523809523809523, + 0.09523809523809523, + 0.04761904761904762, + 0.04761904761904762, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + }, + { + 0.03571428571428571, + 0.03571428571428571, + 0.07142857142857141, + 0.07142857142857142, + 0.10714285714285715, + 0.10714285714285714, + 0.14285714285714285, + 0.10714285714285715, + 0.10714285714285715, + 0.07142857142857144, + 0.07142857142857142, + 0.03571428571428571, + 0.03571428571428571, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + }, + { + 0.02777777777777777, + 0.02777777777777777, + 0.05555555555555555, + 0.05555555555555555, + 0.08333333333333334, + 0.08333333333333333, + 0.11111111111111110, + 0.11111111111111113, + 0.11111111111111113, + 0.08333333333333334, + 0.08333333333333334, + 0.05555555555555556, + 0.05555555555555555, + 0.02777777777777778, + 0.02777777777777778, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + }, + }, + { + { + 0.10000000000000001, + 0.10000000000000001, + 0.20000000000000001, + 0.20000000000000001, + 0.19999999999999998, + 0.09999999999999999, + 0.09999999999999999, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + }, + { + 0.05000000000000000, + 0.05000000000000000, + 0.10000000000000001, + 0.14999999999999999, + 0.14999999999999999, + 0.14999999999999999, + 0.14999999999999999, + 0.10000000000000001, + 0.05000000000000000, + 0.05000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + }, + { + 0.02857142857142857, + 0.02857142857142857, + 0.05714285714285714, + 0.08571428571428570, + 0.11428571428571427, + 0.11428571428571427, + 0.14285714285714282, + 0.11428571428571428, + 0.11428571428571428, + 0.08571428571428572, + 0.05714285714285714, + 0.02857142857142857, + 0.02857142857142857, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + }, + { + 0.01785714285714286, + 0.01785714285714286, + 0.03571428571428571, + 0.05357142857142856, + 0.07142857142857142, + 0.08928571428571427, + 0.10714285714285711, + 0.10714285714285712, + 0.10714285714285714, + 0.10714285714285715, + 0.08928571428571427, + 0.07142857142857142, + 0.05357142857142857, + 0.03571428571428571, + 0.01785714285714286, + 0.01785714285714286, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + }, + { + 0.01190476190476190, + 0.01190476190476190, + 0.02380952380952381, + 0.03571428571428571, + 0.04761904761904762, + 0.05952380952380951, + 0.08333333333333330, + 0.08333333333333331, + 0.09523809523809523, + 0.09523809523809523, + 0.09523809523809523, + 0.08333333333333333, + 0.08333333333333333, + 0.05952380952380952, + 0.04761904761904762, + 0.03571428571428571, + 0.02380952380952381, + 0.01190476190476190, + 0.01190476190476190, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + }, + { + 0.00833333333333333, + 0.00833333333333333, + 0.01666666666666666, + 0.02499999999999999, + 0.03333333333333333, + 0.04166666666666666, + 0.05833333333333331, + 0.06666666666666665, + 0.07499999999999998, + 0.08333333333333331, + 0.08333333333333331, + 0.08333333333333333, + 0.08333333333333333, + 0.07500000000000000, + 0.06666666666666667, + 0.05833333333333333, + 0.04166666666666666, + 0.03333333333333333, + 0.02500000000000000, + 0.01666666666666667, + 0.00833333333333333, + 0.00833333333333333, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + }, + }, + { + { + 0.06666666666666667, + 0.06666666666666667, + 0.13333333333333333, + 0.13333333333333333, + 0.20000000000000001, + 0.13333333333333333, + 0.13333333333333330, + 0.06666666666666665, + 0.06666666666666665, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + }, + { + 0.02857142857142857, + 0.02857142857142857, + 0.05714285714285714, + 0.08571428571428572, + 0.11428571428571428, + 0.11428571428571428, + 0.14285714285714282, + 0.11428571428571427, + 0.11428571428571427, + 0.08571428571428570, + 0.05714285714285714, + 0.02857142857142857, + 0.02857142857142857, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + }, + { + 0.01428571428571429, + 0.01428571428571429, + 0.02857142857142857, + 0.04285714285714286, + 0.07142857142857142, + 0.07142857142857142, + 0.09999999999999998, + 0.09999999999999998, + 0.11428571428571427, + 0.09999999999999998, + 0.09999999999999998, + 0.07142857142857142, + 0.07142857142857142, + 0.04285714285714286, + 0.02857142857142857, + 0.01428571428571429, + 0.01428571428571429, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + }, + { + 0.00793650793650794, + 0.00793650793650794, + 0.01587301587301587, + 0.02380952380952381, + 0.03968253968253968, + 0.04761904761904762, + 0.06349206349206349, + 0.07142857142857142, + 0.08730158730158730, + 0.08730158730158730, + 0.09523809523809522, + 0.08730158730158728, + 0.08730158730158730, + 0.07142857142857142, + 0.06349206349206349, + 0.04761904761904761, + 0.03968253968253968, + 0.02380952380952381, + 0.01587301587301587, + 0.00793650793650794, + 0.00793650793650794, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + }, + { + 0.00476190476190476, + 0.00476190476190476, + 0.00952380952380952, + 0.01428571428571429, + 0.02380952380952381, + 0.02857142857142857, + 0.04285714285714286, + 0.04761904761904762, + 0.06190476190476190, + 0.06666666666666665, + 0.07619047619047617, + 0.07619047619047617, + 0.08571428571428569, + 0.07619047619047617, + 0.07619047619047620, + 0.06666666666666667, + 0.06190476190476191, + 0.04761904761904762, + 0.04285714285714286, + 0.02857142857142857, + 0.02380952380952381, + 0.01428571428571429, + 0.00952380952380952, + 0.00476190476190476, + 0.00476190476190476, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + }, + { + 0.00303030303030303, + 0.00303030303030303, + 0.00606060606060606, + 0.00909090909090909, + 0.01515151515151515, + 0.01818181818181818, + 0.02727272727272727, + 0.03333333333333333, + 0.04242424242424242, + 0.04848484848484847, + 0.05757575757575756, + 0.06060606060606059, + 0.06969696969696967, + 0.06969696969696967, + 0.07272727272727272, + 0.06969696969696969, + 0.06969696969696970, + 0.06060606060606059, + 0.05757575757575757, + 0.04848484848484848, + 0.04242424242424242, + 0.03333333333333333, + 0.02727272727272727, + 0.01818181818181818, + 0.01515151515151515, + 0.00909090909090909, + 0.00606060606060606, + 0.00303030303030303, + 0.00303030303030303, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + }, + }, + { + { + 0.04761904761904762, + 0.04761904761904762, + 0.09523809523809523, + 0.09523809523809523, + 0.14285714285714285, + 0.14285714285714285, + 0.14285714285714288, + 0.09523809523809523, + 0.09523809523809522, + 0.04761904761904761, + 0.04761904761904761, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + }, + { + 0.01785714285714286, + 0.01785714285714286, + 0.03571428571428571, + 0.05357142857142857, + 0.07142857142857142, + 0.08928571428571427, + 0.10714285714285715, + 0.10714285714285714, + 0.10714285714285712, + 0.10714285714285711, + 0.08928571428571427, + 0.07142857142857142, + 0.05357142857142856, + 0.03571428571428571, + 0.01785714285714286, + 0.01785714285714286, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + }, + { + 0.00793650793650794, + 0.00793650793650794, + 0.01587301587301587, + 0.02380952380952381, + 0.03968253968253968, + 0.04761904761904761, + 0.06349206349206349, + 0.07142857142857142, + 0.08730158730158730, + 0.08730158730158728, + 0.09523809523809522, + 0.08730158730158730, + 0.08730158730158730, + 0.07142857142857142, + 0.06349206349206349, + 0.04761904761904762, + 0.03968253968253968, + 0.02380952380952381, + 0.01587301587301587, + 0.00793650793650794, + 0.00793650793650794, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + }, + { + 0.00396825396825397, + 0.00396825396825397, + 0.00793650793650794, + 0.01190476190476190, + 0.01984126984126984, + 0.02777777777777777, + 0.03571428571428571, + 0.04365079365079365, + 0.05555555555555555, + 0.06349206349206349, + 0.07142857142857142, + 0.07539682539682539, + 0.07936507936507936, + 0.07936507936507936, + 0.07539682539682539, + 0.07142857142857142, + 0.06349206349206349, + 0.05555555555555555, + 0.04365079365079365, + 0.03571428571428571, + 0.02777777777777777, + 0.01984126984126984, + 0.01190476190476190, + 0.00793650793650794, + 0.00396825396825397, + 0.00396825396825397, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + }, + { + 0.00216450216450216, + 0.00216450216450216, + 0.00432900432900433, + 0.00649350649350649, + 0.01082251082251082, + 0.01515151515151515, + 0.02164502164502164, + 0.02597402597402597, + 0.03463203463203463, + 0.04112554112554112, + 0.04978354978354978, + 0.05411255411255411, + 0.06277056277056275, + 0.06493506493506493, + 0.06926406926406925, + 0.06926406926406925, + 0.06926406926406925, + 0.06493506493506492, + 0.06277056277056275, + 0.05411255411255410, + 0.04978354978354978, + 0.04112554112554112, + 0.03463203463203463, + 0.02597402597402597, + 0.02164502164502164, + 0.01515151515151515, + 0.01082251082251082, + 0.00649350649350649, + 0.00432900432900433, + 0.00216450216450216, + 0.00216450216450216, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + }, + { + 0.00126262626262626, + 0.00126262626262626, + 0.00252525252525253, + 0.00378787878787879, + 0.00631313131313131, + 0.00883838383838384, + 0.01262626262626262, + 0.01641414141414141, + 0.02146464646464646, + 0.02651515151515151, + 0.03282828282828283, + 0.03787878787878787, + 0.04419191919191919, + 0.04924242424242424, + 0.05429292929292929, + 0.05808080808080808, + 0.06060606060606059, + 0.06186868686868686, + 0.06186868686868686, + 0.06060606060606059, + 0.05808080808080807, + 0.05429292929292930, + 0.04924242424242424, + 0.04419191919191920, + 0.03787878787878787, + 0.03282828282828282, + 0.02651515151515152, + 0.02146464646464646, + 0.01641414141414142, + 0.01262626262626263, + 0.00883838383838384, + 0.00631313131313131, + 0.00378787878787879, + 0.00252525252525253, + 0.00126262626262626, + 0.00126262626262626, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + }, + }, + { + { + 0.03571428571428571, + 0.03571428571428571, + 0.07142857142857142, + 0.07142857142857144, + 0.10714285714285715, + 0.10714285714285715, + 0.14285714285714285, + 0.10714285714285714, + 0.10714285714285715, + 0.07142857142857142, + 0.07142857142857141, + 0.03571428571428571, + 0.03571428571428571, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + }, + { + 0.01190476190476190, + 0.01190476190476190, + 0.02380952380952381, + 0.03571428571428571, + 0.04761904761904762, + 0.05952380952380952, + 0.08333333333333333, + 0.08333333333333333, + 0.09523809523809523, + 0.09523809523809523, + 0.09523809523809523, + 0.08333333333333331, + 0.08333333333333330, + 0.05952380952380951, + 0.04761904761904762, + 0.03571428571428571, + 0.02380952380952381, + 0.01190476190476190, + 0.01190476190476190, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + }, + { + 0.00476190476190476, + 0.00476190476190476, + 0.00952380952380952, + 0.01428571428571429, + 0.02380952380952381, + 0.02857142857142857, + 0.04285714285714286, + 0.04761904761904762, + 0.06190476190476191, + 0.06666666666666667, + 0.07619047619047620, + 0.07619047619047617, + 0.08571428571428569, + 0.07619047619047617, + 0.07619047619047617, + 0.06666666666666665, + 0.06190476190476190, + 0.04761904761904762, + 0.04285714285714286, + 0.02857142857142857, + 0.02380952380952381, + 0.01428571428571429, + 0.00952380952380952, + 0.00476190476190476, + 0.00476190476190476, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + }, + { + 0.00216450216450216, + 0.00216450216450216, + 0.00432900432900433, + 0.00649350649350649, + 0.01082251082251082, + 0.01515151515151515, + 0.02164502164502164, + 0.02597402597402597, + 0.03463203463203463, + 0.04112554112554112, + 0.04978354978354978, + 0.05411255411255410, + 0.06277056277056275, + 0.06493506493506492, + 0.06926406926406925, + 0.06926406926406925, + 0.06926406926406925, + 0.06493506493506493, + 0.06277056277056275, + 0.05411255411255411, + 0.04978354978354978, + 0.04112554112554112, + 0.03463203463203463, + 0.02597402597402597, + 0.02164502164502164, + 0.01515151515151515, + 0.01082251082251082, + 0.00649350649350649, + 0.00432900432900433, + 0.00216450216450216, + 0.00216450216450216, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + }, + { + 0.00108225108225108, + 0.00108225108225108, + 0.00216450216450216, + 0.00324675324675325, + 0.00541125541125541, + 0.00757575757575758, + 0.01190476190476190, + 0.01406926406926407, + 0.01948051948051948, + 0.02380952380952381, + 0.03030303030303030, + 0.03463203463203463, + 0.04220779220779219, + 0.04545454545454544, + 0.05194805194805194, + 0.05519480519480519, + 0.05952380952380951, + 0.05952380952380952, + 0.06277056277056275, + 0.05952380952380952, + 0.05952380952380951, + 0.05519480519480519, + 0.05194805194805194, + 0.04545454545454544, + 0.04220779220779219, + 0.03463203463203463, + 0.03030303030303030, + 0.02380952380952381, + 0.01948051948051948, + 0.01406926406926407, + 0.01190476190476190, + 0.00757575757575758, + 0.00541125541125541, + 0.00324675324675325, + 0.00216450216450216, + 0.00108225108225108, + 0.00108225108225108, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + }, + { + 0.00058275058275058, + 0.00058275058275058, + 0.00116550116550117, + 0.00174825174825175, + 0.00291375291375291, + 0.00407925407925408, + 0.00641025641025641, + 0.00815850815850816, + 0.01107226107226107, + 0.01398601398601398, + 0.01806526806526806, + 0.02156177156177156, + 0.02680652680652679, + 0.03030303030303030, + 0.03554778554778554, + 0.03962703962703962, + 0.04428904428904428, + 0.04720279720279720, + 0.05128205128205127, + 0.05244755244755244, + 0.05477855477855477, + 0.05477855477855477, + 0.05477855477855477, + 0.05244755244755243, + 0.05128205128205127, + 0.04720279720279720, + 0.04428904428904428, + 0.03962703962703962, + 0.03554778554778555, + 0.03030303030303030, + 0.02680652680652681, + 0.02156177156177156, + 0.01806526806526806, + 0.01398601398601399, + 0.01107226107226107, + 0.00815850815850816, + 0.00641025641025641, + 0.00407925407925408, + 0.00291375291375291, + 0.00174825174825175, + 0.00116550116550117, + 0.00058275058275058, + 0.00058275058275058, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + }, + }, + { + { + 0.02777777777777778, + 0.02777777777777778, + 0.05555555555555555, + 0.05555555555555556, + 0.08333333333333334, + 0.08333333333333334, + 0.11111111111111113, + 0.11111111111111113, + 0.11111111111111110, + 0.08333333333333333, + 0.08333333333333334, + 0.05555555555555555, + 0.05555555555555555, + 0.02777777777777777, + 0.02777777777777777, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + }, + { + 0.00833333333333333, + 0.00833333333333333, + 0.01666666666666667, + 0.02500000000000000, + 0.03333333333333333, + 0.04166666666666666, + 0.05833333333333333, + 0.06666666666666667, + 0.07500000000000000, + 0.08333333333333333, + 0.08333333333333333, + 0.08333333333333331, + 0.08333333333333331, + 0.07499999999999998, + 0.06666666666666665, + 0.05833333333333331, + 0.04166666666666666, + 0.03333333333333333, + 0.02499999999999999, + 0.01666666666666666, + 0.00833333333333333, + 0.00833333333333333, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + }, + { + 0.00303030303030303, + 0.00303030303030303, + 0.00606060606060606, + 0.00909090909090909, + 0.01515151515151515, + 0.01818181818181818, + 0.02727272727272727, + 0.03333333333333333, + 0.04242424242424242, + 0.04848484848484848, + 0.05757575757575757, + 0.06060606060606059, + 0.06969696969696970, + 0.06969696969696969, + 0.07272727272727272, + 0.06969696969696967, + 0.06969696969696967, + 0.06060606060606059, + 0.05757575757575756, + 0.04848484848484847, + 0.04242424242424242, + 0.03333333333333333, + 0.02727272727272727, + 0.01818181818181818, + 0.01515151515151515, + 0.00909090909090909, + 0.00606060606060606, + 0.00303030303030303, + 0.00303030303030303, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + }, + { + 0.00126262626262626, + 0.00126262626262626, + 0.00252525252525253, + 0.00378787878787879, + 0.00631313131313131, + 0.00883838383838384, + 0.01262626262626263, + 0.01641414141414142, + 0.02146464646464646, + 0.02651515151515152, + 0.03282828282828282, + 0.03787878787878787, + 0.04419191919191920, + 0.04924242424242424, + 0.05429292929292930, + 0.05808080808080807, + 0.06060606060606059, + 0.06186868686868686, + 0.06186868686868686, + 0.06060606060606059, + 0.05808080808080808, + 0.05429292929292929, + 0.04924242424242424, + 0.04419191919191919, + 0.03787878787878787, + 0.03282828282828283, + 0.02651515151515151, + 0.02146464646464646, + 0.01641414141414141, + 0.01262626262626262, + 0.00883838383838384, + 0.00631313131313131, + 0.00378787878787879, + 0.00252525252525253, + 0.00126262626262626, + 0.00126262626262626, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + }, + { + 0.00058275058275058, + 0.00058275058275058, + 0.00116550116550117, + 0.00174825174825175, + 0.00291375291375291, + 0.00407925407925408, + 0.00641025641025641, + 0.00815850815850816, + 0.01107226107226107, + 0.01398601398601399, + 0.01806526806526806, + 0.02156177156177156, + 0.02680652680652681, + 0.03030303030303030, + 0.03554778554778555, + 0.03962703962703962, + 0.04428904428904428, + 0.04720279720279720, + 0.05128205128205127, + 0.05244755244755243, + 0.05477855477855477, + 0.05477855477855477, + 0.05477855477855477, + 0.05244755244755244, + 0.05128205128205127, + 0.04720279720279720, + 0.04428904428904428, + 0.03962703962703962, + 0.03554778554778554, + 0.03030303030303030, + 0.02680652680652679, + 0.02156177156177156, + 0.01806526806526806, + 0.01398601398601398, + 0.01107226107226107, + 0.00815850815850816, + 0.00641025641025641, + 0.00407925407925408, + 0.00291375291375291, + 0.00174825174825175, + 0.00116550116550117, + 0.00058275058275058, + 0.00058275058275058, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + 0.00000000000000000, + }, + { + 0.00029137529137529, + 0.00029137529137529, + 0.00058275058275058, + 0.00087412587412587, + 0.00145687645687646, + 0.00203962703962704, + 0.00320512820512821, + 0.00437062937062937, + 0.00582750582750583, + 0.00757575757575758, + 0.00990675990675991, + 0.01223776223776224, + 0.01544289044289044, + 0.01835664335664336, + 0.02185314685314686, + 0.02534965034965035, + 0.02913752913752913, + 0.03263403263403263, + 0.03642191142191141, + 0.03962703962703962, + 0.04254079254079253, + 0.04516317016317015, + 0.04720279720279719, + 0.04836829836829836, + 0.04924242424242423, + 0.04924242424242423, + 0.04836829836829836, + 0.04720279720279719, + 0.04516317016317015, + 0.04254079254079253, + 0.03962703962703962, + 0.03642191142191141, + 0.03263403263403263, + 0.02913752913752913, + 0.02534965034965035, + 0.02185314685314686, + 0.01835664335664336, + 0.01544289044289044, + 0.01223776223776224, + 0.00990675990675991, + 0.00757575757575758, + 0.00582750582750583, + 0.00437062937062937, + 0.00320512820512821, + 0.00203962703962704, + 0.00145687645687646, + 0.00087412587412587, + 0.00058275058275058, + 0.00029137529137529, + 0.00029137529137529, + }, + }, +};