diff --git a/nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/data_WM-PT.yaml b/nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/data_WM-PT.yaml new file mode 100644 index 0000000000..73ca4f121e --- /dev/null +++ b/nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/data_WM-PT.yaml @@ -0,0 +1,17 @@ +data_central: +- 1631.4 +- 4037.95 +- 2096.5 +- 835.16 +- 364.545 +- 1.71450500e+02 +- 86.63615 +- 46.0402 +- 20.23555 +- 7.2515 +- 2.977525 +- 1.335755 +- 0.62122 +- 0.33252 +- 0.121998 +- 2.82787000e-02 diff --git a/nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/data_WP-PT.yaml b/nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/data_WP-PT.yaml new file mode 100644 index 0000000000..576b18d49f --- /dev/null +++ b/nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/data_WP-PT.yaml @@ -0,0 +1,17 @@ +data_central: +- 2345.065 +- 5664.1 +- 2970.07 +- 1213.885 +- 5.35680000e+02 +- 255.967 +- 133.531 +- 73.187 +- 3.35522500e+01 +- 12.4881 +- 5.3465 +- 2.52222 +- 1.242785 +- 0.69372 +- 3.00397000e-01 +- 7.71570000e-02 diff --git a/nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/filter.py b/nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/filter.py new file mode 100644 index 0000000000..46955de7f2 --- /dev/null +++ b/nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/filter.py @@ -0,0 +1,63 @@ +''' +Filter script for ATLAS_WJ_8TEV + +Log: +- Central data and kinematics implemented from hepdata +- Central data and kinematics checked with legacy: passed +- The bin values in `uncertainties_legacy_WX-PT.yaml` and `uncertainties_legacy_WX-PT_sys_ATLAS.yaml` + are exactly the same (checked with notebook). The difference between + these two variants is in the definition of the uncertainties. See notebook for + differences. +- For the treatment of systematic uncertainties, refer to https://arxiv.org/pdf/2112.11266. + There are 50 sources of CORRELATED systematic uncertainty. + +29 / 11 / 2024 +- Implemented uncertaintiy definitions +- Construction of the uncertainty file is still missing. Remember that + for the symmetrised case you account for the shifts. +- Xq2 is missing (?) +''' + +import logging + +from filter_utils import Extractor +import numpy as np +import yaml + +logging.basicConfig(level=logging.INFO, format='[%(levelname)s] %(message)s') + + +def check_dat_with_legacy(observable, rtol=1e-03): + """ + Same as `check_unc_with_legacy`, but for central data points. + """ + logging.info( + f"Comparing the new central data implementation with the legacy version for {observable} using rtol = {rtol}." + ) + + with open('./data_' + observable + '.yaml', 'r') as file: + new_data = yaml.safe_load(file) + + with open('./data_legacy_' + observable + '.yaml', 'r') as file: + legacy_data = yaml.safe_load(file) + + for i, (new_val, legacy_val) in enumerate( + zip(new_data['data_central'], legacy_data['data_central']) + ): + try: + assert np.allclose(new_val, legacy_val, rtol=rtol) + except AssertionError as e: + logging.warning(f"Inconsistency, {new_val} != {legacy_val} in bin: {i+1}") + + +if __name__ == "__main__": + ATLAS_WP_8TEV_PT = Extractor("./metadata.yaml", "WP-PT") + _, _, _ = ATLAS_WP_8TEV_PT.generate_data(variant='default', save_to_yaml=True) + # _, _, _ = ATLAS_WP_8TEV_PT.generate_data(variant='CMS_prescription', save_to_yaml=True) + + ATLAS_WM_8TEV_PT = Extractor("./metadata.yaml", "WM-PT") + _, _, _ = ATLAS_WM_8TEV_PT.generate_data(variant='default', save_to_yaml=True) + # _, _, _ = ATLAS_WM_8TEV_PT.generate_data(variant='CMS_prescription', save_to_yaml=True) + + # check_dat_with_legacy('WP-PT', rtol=1e-4) + # check_dat_with_legacy('WM-PT', rtol=1e-4) diff --git a/nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/filter_utils.py b/nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/filter_utils.py new file mode 100644 index 0000000000..d7dd1b89f4 --- /dev/null +++ b/nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/filter_utils.py @@ -0,0 +1,481 @@ +import logging +import os + +import numpy as np +import pandas as pd +import yaml + +from nnpdf_data.filter_utils.utils import matlist_to_matrix, prettify_float, symmetrize_errors + +yaml.add_representer(float, prettify_float) + +SQRTS = 8000 +MW2 = 80.377**2 + +# List of systematic uncertainties that shuold +# be considered uncorrelated +UNCORR_SYS_UNC = ['UnfoldMCstat', 'UnfoldOtherGen', 'UnfoldReweight'] +STAT_ART_LABEL = 'art_stat_corr' + + +class Extractor: + """ + Extracts kinematics, central data, and uncertainties for a given dataset + + Parameters + ---------- + metadata_file: str + Path to the metadata file + observable: str + The name of the observable for which the data is extracted. The name must + be listed in the metadata file. + """ + + def __init__(self, metadata_file, observable, mult_factor=1): + + # Open metadata and select process + with open(metadata_file, 'r') as file: + metadata = yaml.safe_load(file) + self.metadata = next( + ( + md + for md in metadata["implemented_observables"] + if md['observable_name'] == observable + ), + None, + ) + if self.metadata is None: + raise Exception(f"{observable} is not listed in the metadata file.") + + # Initialise dict of tables + self.tables = {} + self.observable = observable + self.mult_factor = mult_factor + self.kin_labels = self.metadata['kinematic_coverage'] + self.ndata = self.metadata['ndata'] + + if self.observable == 'WM-PT': + self.observable_latex = 'W^-' + elif self.observable == 'WP-PT': + self.observable_latex = 'W^+' + else: + raise Exception(f'{self.observable} is an unknown observable.') + + # Collect diagonal absoulute uncertainties + self.diag_unc = self.__collect_diag_unc() + self.unc_labels = list(self.diag_unc[0].keys()) + self.unc_labels.pop(0) + + def __extract_kinematics(self, table: dict, tab_number: int): + """ + Extracts the kinematic variables of the single differential + distribution given a table. + + For each bin, it computes the max, min, and mid value of the transverse + momentum of the boson. + + Parameters + ---------- + table: dict + Dictionary containing the bins in the transverse momentum + tab_number: int + Index to select the range of the second kinematic variable + + Return + ------ + List of bins containing min, max, and mid values for each of the kinematic + observables listed in the `kinematic_coverage` of the metadata file. + + """ + data = table['independent_variables'][0] + label = self.kin_labels + kinematics = [] + for bin in data['values']: + pT_min = bin['low'] + pT_max = bin['high'] + kin_bin = { + label[0]: {'min': pT_min, 'mid': (pT_max + pT_min) / 2, 'max': pT_max}, + label[1]: {'min': None, 'mid': MW2, 'max': None}, + } + kinematics.append(kin_bin) + return kinematics + + def __retrieve_table(self, table_id): + """ + Implementation of the lazy loading for the tables. If the table + is loaded for the first time, it is stored into an internal + container of the class, so that it will not be loaded each time. + + When called, this functions checks if the table has already been stored + and, if that is the case, returns the stored table. + + Parameters + ---------- + table_id: int + Index that specifies the table + + Return + ------ + The table specified by `table_id`. If not previously loaded, it is also + stored into the internal container for future use. + """ + try: + table = self.tables[str(table_id)] + except KeyError: + logging.debug( + f'Table {table_id} has not already been used or stored.' f' Storing the table...' + ) + with open(f'./rawdata/data{table_id}.yaml', 'r') as tab: + tab_dict = yaml.safe_load(tab) + self.tables[str(table_id)] = tab_dict + table = tab_dict + return table + + def get_table(self, table_id): + return self.__retrieve_table(table_id) + + def generate_kinematics(self): + """ + Function that generates the kinematics by looping over all the + tables specified in the metadata file. The resulting kinematics + is then saved to a yaml file. It relies on the method + `__extract_kinematics`. + """ + + logging.info(f"Generating kinematics for ATLAS_{self.observable}...") + + # Initialise kinematics list + kinematics = [] + ndata = 0 + table = self.metadata["tables"][0] + tab_dict = self.__retrieve_table(table) + kin = self.__extract_kinematics(tab_dict, table) + kinematics = np.concatenate([kinematics, kin]) + ndata += len(kin) + + # Check number of data agrees with metadata + try: + assert self.metadata['ndata'] is not None + assert self.metadata['ndata'] == ndata + except AssertionError as e: + logging.warning( + f"The number of data in the metafile is either wrong or unspecified." + f" The correct number is {ndata}. Please, update the metafile." + ) + return + return kinematics.tolist() + + def generate_data_central(self): + """ + Same as `generate_kinematics`, but for central data points. + """ + logging.info(f"Generating central data for ATLAS_{self.observable}...") + dat_central = [] + table = self.metadata['tables'][0] + tab_dict = self.__retrieve_table(table) + + # Select the chosen combination + values = self.__select_bins_by_observable(tab_dict) + + data = [dat['value'] * self.mult_factor for dat in values] + dat_central = np.concatenate([dat_central, data]) + return dat_central + + def __build_stat_corrmat(self): + ndata = self.metadata['ndata'] + table_id = self.metadata['tables'][1] + with open(f'./rawdata/data{table_id}.yaml', 'r') as tab: + stat = yaml.load(tab, yaml.Loader) + matlist = [val['value'] for val in stat['dependent_variables'][0]['values']] + stat_cormat = np.zeros((ndata, ndata)) + for i in range(ndata): + for j in range(ndata): + stat_cormat[i, j] = matlist[i + ndata * j] # Col-major + return stat_cormat + + def __build_abs_stat_covmat(self): + """Builds the statistical covmat given the diagonal statistical uncertainties.""" + stat_cormat = self.__build_stat_corrmat() + # Retrieve statistical diagonal entries + abs_stat_diag = [float(d['Stat']['error']) for d in self.diag_unc] + statmat_abs = np.zeros_like(stat_cormat) + for i in range(stat_cormat.shape[0]): + for j in range(stat_cormat.shape[1]): + statmat_abs[i, j] = stat_cormat[i, j] * abs_stat_diag[i] * abs_stat_diag[j] + return statmat_abs + + def __collect_diag_unc(self): + """Collect the absolute values of the diagonal uncertainties""" + table_idx = self.metadata['tables'][0] + tab_dict = self.__retrieve_table(table_idx) + + # Select the chosen combination + bins = self.__select_bins_by_observable(tab_dict) + + abs_unc_by_bin = [] + for bin in bins: + bin_err = bin['errors'] + unc_dict = { + unc['label']: {'type': list(unc.keys())[1], 'error': list(unc.values())[1]} + for unc in bin_err + } + abs_unc_by_bin.append(unc_dict) + return abs_unc_by_bin + + def symmetrized_sys_unc(self): + """Symmetrise systematic uncertainties. Returns the symmetrized uncertainty + and the shift to the central data + """ + symmetrized_uncs = [] + for bin in self.diag_unc: + unc_dict = {} + for source in self.unc_labels: + if bin[source]['type'] == 'asymerror': + error = bin[source]['error'] + plus = error['plus'] + minus = error['minus'] + data_delta, sym_error = symmetrize_errors(plus, minus) + unc_dict[source] = {'shift': data_delta, 'sym_error': sym_error} + elif bin[source]['type'] == 'symerror': + unc_dict[source] = {'shift': 0.0, 'sym_error': bin[source]['error']} + symmetrized_uncs.append(unc_dict) + return symmetrized_uncs + + # TODO + # I was not able to reproduce the legacy implementation with this function + def __cms_sys_unc(self): + """In the legacy implementation, all systematic uncertainties (even for symmetric uncertanties), + are treated using the prescription outlined in eq. (6) of https://arxiv.org/pdf/1703.01630. + Specifically, positive and negative bounds are treated as follows + + C_{ij}^{sys} = \frac{1}{2} \sum_{k'}( C_{jk'}^{+} C_{ik'}^{+} + C_{jk'}^{-} C_{ik'}^{-}) + + With this prescription, asymmetric uncertainties are not symmetrized. + """ + modified_uncertainties = [] + deltas_from_lumi = [] + for bin in self.diag_unc: + unc_dict = {} + for source in self.unc_labels: + if bin[source]['type'] == 'asymerror': + error = bin[source]['error'] + plus = error['plus'] + minus = error['minus'] + if source == 'LumiUncert': + data_delta, sym_error = symmetrize_errors(plus, minus) + unc_dict[f'{source}'] = sym_error + data_delta = 0.0 + deltas_from_lumi.append(data_delta) + elif abs(plus) == abs(minus): + unc_dict[f'{source}_plus'] = abs(plus) / float(np.sqrt(2)) + unc_dict[f'{source}_minus'] = 0.0 # minus / float(np.sqrt(2)) + else: + unc_dict[f'{source}_plus'] = plus / float(np.sqrt(2)) + unc_dict[f'{source}_minus'] = minus / float(np.sqrt(2)) + elif bin[source]['type'] == 'symerror': + error = bin[source]['error'] + if source == 'LumiUncert': + unc_dict[f'{source}'] = error + elif source in UNCORR_SYS_UNC: + unc_dict[f'{source}_plus'] = error / float(np.sqrt(2)) + unc_dict[f'{source}_minus'] = -error / float(np.sqrt(2)) + else: + unc_dict[f'{source}_plus'] = error / float(np.sqrt(2)) + unc_dict[f'{source}_minus'] = -error / float(np.sqrt(2)) + modified_uncertainties.append(unc_dict) + return modified_uncertainties, deltas_from_lumi + + def get_diag_unc(self): + if hasattr(self, 'diag_unc'): + return self.diag_unc + else: + self.diag_unc = self.__collect_diag_unc() + return self.diag_unc + + def get_stat_covmat(self): + return self.__build_abs_stat_covmat() + + def get_stat_cormat(self): + return self.__build_stat_corrmat() + + def get_abs_stat_covmat(self): + if hasattr(self, 'abs_stat_covmat'): + return self.abs_stat_covmat + else: + self.abs_stat_covmat = self.__build_abs_stat_covmat() + return self.abs_stat_covmat + + def __select_bins_by_observable(self, tab_dict): + """This dataset colelcts differential xsecs for either W+ and W- in the + same yaml file. This function returns the part of this yaml file relevant + for the selected boson sign.""" + values = next( + ( + head['values'] + for head in tab_dict["dependent_variables"] + if self.observable_latex in head['header']['name'] + ), + 1, + ) + if values == 1: + logging.error( + f"{self.observable} not found in table under the LaTeX name {self.observable_latex}. The available options are:" + ) + for head in tab_dict["dependent_variables"]: + print(f" - {head['header']['name']}") + exit(-1) + else: + return values + + def __build_unc_definitions(self, variant='default'): + unc_definitions = {} + + # Statistical uncertainties are always the same + for idx in range(self.ndata): + unc_definitions[STAT_ART_LABEL + f'_{idx + 1}'] = { + 'description': f'Artificial statistical uncertainty {idx + 1}', + 'treatment': 'ADD', + 'type': 'CORR', + } + + if variant == 'default': + i = 1 + for label in self.unc_labels: + if label == 'LumiUncert': + unc_type = 'ATLASLUMI12' + elif label in UNCORR_SYS_UNC: + unc_type = 'UNCORR' + else: + unc_type = f'ATLASWJ{i}' + i += 1 + + unc_definitions[f'{label}'] = { + 'description': f'Systematic: {label}', + 'treatment': 'MULT', + 'type': unc_type, + } + + elif variant == 'CMS_prescription': + i = 1 + for label in self.unc_labels: + if label == 'LumiUncert': + unc_definitions[f'{label}'] = { + 'description': f'Systematic: {label}', + 'treatment': 'MULT', + 'type': 'ATLASLUMI12', + } + else: + if label in UNCORR_SYS_UNC: + unc_definitions[f'{label}_plus'] = { + 'description': f'Systematic upper unc.: {label}', + 'treatment': 'MULT', + 'type': 'UNCORR', + } + unc_definitions[f'{label}_minus'] = { + 'description': f'Systematic lower unc.: {label}', + 'treatment': 'MULT', + 'type': 'UNCORR', + } + else: + unc_definitions[f'{label}_plus'] = { + 'description': f'Systematic upper unc.: {label}', + 'treatment': 'MULT', + 'type': f'ATLASWJ{i}', + } + unc_definitions[f'{label}_minus'] = { + 'description': f'Systematic lower unc.: {label}', + 'treatment': 'MULT', + 'type': f'ATLASWJ{i+1}', + } + i += 2 + + elif variant == 'inter_sys': + raise ValueError(f'Not yet implemented') + else: + raise ValueError(f'The variant {variant} is not yet implemented or wrong.') + + return unc_definitions + + def generate_data(self, variant='default', save_to_yaml=False, path='./'): + # Get central data and kinematics + central_data = self.generate_data_central() + kinematics = self.generate_kinematics() + + # Uncertainty definitions + unc_definitions = self.__build_unc_definitions(variant=variant) + + # Get statistical (artidicial uncertainties) + stat_covmat = self.__build_abs_stat_covmat() + eigvals, eigvecs = np.linalg.eig(stat_covmat) + art_stat = np.sqrt(eigvals) * eigvecs + + sys_artificial = [] # Initialize vector of artificial uncertainties + + if variant == 'default': # Symmetrized uncs. + symmetrized_sys_uncs = self.symmetrized_sys_unc() + shifts = [] # Initialize vector of shifts + for data_idx, unc in enumerate(symmetrized_sys_uncs): + shift = 0 + # Add statistical uncertainties + unc_dict = { + STAT_ART_LABEL + f'_{idx + 1}': float(stat_art) + for idx, stat_art in enumerate(art_stat[data_idx, :]) + } + for key, value in unc.items(): + shift += value['shift'] + unc_dict[key] = value['sym_error'] + sys_artificial.append(unc_dict) + shifts.append(shift) + central_data = central_data + shifts + + elif variant == 'CMS_prescription': + raise NotImplementedError('This variant has a bug and will not produce any data file.') + cms_type_uncertainties, deltas = self.__cms_sys_unc() + central_data = central_data + deltas + for data_idx, unc in enumerate(cms_type_uncertainties): + # Add statistical uncertainties + unc_dict = { + STAT_ART_LABEL + f'_{idx + 1}': float(stat_art) + for idx, stat_art in enumerate(art_stat[data_idx, :]) + } + for key, value in unc.items(): + unc_dict[key] = value + sys_artificial.append(unc_dict) + + else: + raise ValueError(f'Variant `{variant}` is not implemented yet.') + + if save_to_yaml: + # Save kinematics into file + logging.info("Dumping kinematics to file...") + kinematics_yaml = {'bins': kinematics} + with open(path + self.metadata['kinematics']['file'], 'w') as kin_out_file: + yaml.dump(kinematics_yaml, kin_out_file, sort_keys=False) + logging.info("Done!") + + # Save central data into file + logging.info("Dumping kinematics to file...") + dat_central_yaml = {'data_central': central_data.tolist()} + file_name = ( + self.metadata['data_central'] + if variant == 'default' + else self.metadata['variants'][variant]['data_central'] + ) + with open(path + file_name, 'w') as dat_out_file: + yaml.dump(dat_central_yaml, dat_out_file, sort_keys=False) + logging.info("Done!") + + # Save unertainties + logging.info("Dumping kinematics to file...") + uncertainties_yaml = {'definitions': unc_definitions, 'bins': sys_artificial} + file_name = ( + self.metadata['data_uncertainties'][0] + if variant == 'default' + else self.metadata['variants'][variant]['data_uncertainties'][0] + ) + with open(path + file_name, 'w') as dat_out_file: + yaml.dump(uncertainties_yaml, dat_out_file, sort_keys=False) + logging.info("Done!") + return kinematics, central_data, sys_artificial + else: + return kinematics, central_data, sys_artificial diff --git a/nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/kinematics_WM-PT.yaml b/nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/kinematics_WM-PT.yaml index 8120562585..937355a666 100644 --- a/nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/kinematics_WM-PT.yaml +++ b/nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/kinematics_WM-PT.yaml @@ -1,193 +1,129 @@ bins: -- k1: - min: null +- pT: + min: 0.0 mid: 12.5 - max: null - k2: - min: null - mid: 0.0 - max: null - k3: + max: 25.0 + m_W2: min: null - mid: 8000.0 + mid: 6.46046213e+03 max: null -- k1: - min: null +- pT: + min: 25.0 mid: 37.5 - max: null - k2: - min: null - mid: 0.0 - max: null - k3: + max: 50.0 + m_W2: min: null - mid: 8000.0 + mid: 6.46046213e+03 max: null -- k1: - min: null +- pT: + min: 50.0 mid: 62.5 - max: null - k2: - min: null - mid: 0.0 - max: null - k3: + max: 75.0 + m_W2: min: null - mid: 8000.0 + mid: 6.46046213e+03 max: null -- k1: - min: null +- pT: + min: 75.0 mid: 87.5 - max: null - k2: - min: null - mid: 0.0 - max: null - k3: + max: 100.0 + m_W2: min: null - mid: 8000.0 + mid: 6.46046213e+03 max: null -- k1: - min: null +- pT: + min: 100.0 mid: 112.5 - max: null - k2: - min: null - mid: 0.0 - max: null - k3: + max: 125.0 + m_W2: min: null - mid: 8000.0 + mid: 6.46046213e+03 max: null -- k1: - min: null +- pT: + min: 125.0 mid: 137.5 - max: null - k2: - min: null - mid: 0.0 - max: null - k3: + max: 150.0 + m_W2: min: null - mid: 8000.0 + mid: 6.46046213e+03 max: null -- k1: - min: null +- pT: + min: 150.0 mid: 162.5 - max: null - k2: - min: null - mid: 0.0 - max: null - k3: + max: 175.0 + m_W2: min: null - mid: 8000.0 + mid: 6.46046213e+03 max: null -- k1: - min: null +- pT: + min: 175.0 mid: 187.5 - max: null - k2: - min: null - mid: 0.0 - max: null - k3: + max: 200.0 + m_W2: min: null - mid: 8000.0 + mid: 6.46046213e+03 max: null -- k1: - min: null +- pT: + min: 200.0 mid: 225.0 - max: null - k2: - min: null - mid: 0.0 - max: null - k3: + max: 250.0 + m_W2: min: null - mid: 8000.0 + mid: 6.46046213e+03 max: null -- k1: - min: null +- pT: + min: 250.0 mid: 275.0 - max: null - k2: - min: null - mid: 0.0 - max: null - k3: + max: 300.0 + m_W2: min: null - mid: 8000.0 + mid: 6.46046213e+03 max: null -- k1: - min: null +- pT: + min: 300.0 mid: 325.0 - max: null - k2: - min: null - mid: 0.0 - max: null - k3: + max: 350.0 + m_W2: min: null - mid: 8000.0 + mid: 6.46046213e+03 max: null -- k1: - min: null +- pT: + min: 350.0 mid: 375.0 - max: null - k2: - min: null - mid: 0.0 - max: null - k3: + max: 400.0 + m_W2: min: null - mid: 8000.0 + mid: 6.46046213e+03 max: null -- k1: - min: null +- pT: + min: 400.0 mid: 425.0 - max: null - k2: - min: null - mid: 0.0 - max: null - k3: + max: 450.0 + m_W2: min: null - mid: 8000.0 + mid: 6.46046213e+03 max: null -- k1: - min: null +- pT: + min: 450.0 mid: 475.0 - max: null - k2: - min: null - mid: 0.0 - max: null - k3: + max: 500.0 + m_W2: min: null - mid: 8000.0 + mid: 6.46046213e+03 max: null -- k1: - min: null +- pT: + min: 500.0 mid: 550.0 - max: null - k2: - min: null - mid: 0.0 - max: null - k3: + max: 600.0 + m_W2: min: null - mid: 8000.0 + mid: 6.46046213e+03 max: null -- k1: - min: null +- pT: + min: 600.0 mid: 700.0 - max: null - k2: - min: null - mid: 0.0 - max: null - k3: + max: 800.0 + m_W2: min: null - mid: 8000.0 + mid: 6.46046213e+03 max: null diff --git a/nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/kinematics_WP-PT.yaml b/nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/kinematics_WP-PT.yaml index 8120562585..937355a666 100644 --- a/nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/kinematics_WP-PT.yaml +++ b/nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/kinematics_WP-PT.yaml @@ -1,193 +1,129 @@ bins: -- k1: - min: null +- pT: + min: 0.0 mid: 12.5 - max: null - k2: - min: null - mid: 0.0 - max: null - k3: + max: 25.0 + m_W2: min: null - mid: 8000.0 + mid: 6.46046213e+03 max: null -- k1: - min: null +- pT: + min: 25.0 mid: 37.5 - max: null - k2: - min: null - mid: 0.0 - max: null - k3: + max: 50.0 + m_W2: min: null - mid: 8000.0 + mid: 6.46046213e+03 max: null -- k1: - min: null +- pT: + min: 50.0 mid: 62.5 - max: null - k2: - min: null - mid: 0.0 - max: null - k3: + max: 75.0 + m_W2: min: null - mid: 8000.0 + mid: 6.46046213e+03 max: null -- k1: - min: null +- pT: + min: 75.0 mid: 87.5 - max: null - k2: - min: null - mid: 0.0 - max: null - k3: + max: 100.0 + m_W2: min: null - mid: 8000.0 + mid: 6.46046213e+03 max: null -- k1: - min: null +- pT: + min: 100.0 mid: 112.5 - max: null - k2: - min: null - mid: 0.0 - max: null - k3: + max: 125.0 + m_W2: min: null - mid: 8000.0 + mid: 6.46046213e+03 max: null -- k1: - min: null +- pT: + min: 125.0 mid: 137.5 - max: null - k2: - min: null - mid: 0.0 - max: null - k3: + max: 150.0 + m_W2: min: null - mid: 8000.0 + mid: 6.46046213e+03 max: null -- k1: - min: null +- pT: + min: 150.0 mid: 162.5 - max: null - k2: - min: null - mid: 0.0 - max: null - k3: + max: 175.0 + m_W2: min: null - mid: 8000.0 + mid: 6.46046213e+03 max: null -- k1: - min: null +- pT: + min: 175.0 mid: 187.5 - max: null - k2: - min: null - mid: 0.0 - max: null - k3: + max: 200.0 + m_W2: min: null - mid: 8000.0 + mid: 6.46046213e+03 max: null -- k1: - min: null +- pT: + min: 200.0 mid: 225.0 - max: null - k2: - min: null - mid: 0.0 - max: null - k3: + max: 250.0 + m_W2: min: null - mid: 8000.0 + mid: 6.46046213e+03 max: null -- k1: - min: null +- pT: + min: 250.0 mid: 275.0 - max: null - k2: - min: null - mid: 0.0 - max: null - k3: + max: 300.0 + m_W2: min: null - mid: 8000.0 + mid: 6.46046213e+03 max: null -- k1: - min: null +- pT: + min: 300.0 mid: 325.0 - max: null - k2: - min: null - mid: 0.0 - max: null - k3: + max: 350.0 + m_W2: min: null - mid: 8000.0 + mid: 6.46046213e+03 max: null -- k1: - min: null +- pT: + min: 350.0 mid: 375.0 - max: null - k2: - min: null - mid: 0.0 - max: null - k3: + max: 400.0 + m_W2: min: null - mid: 8000.0 + mid: 6.46046213e+03 max: null -- k1: - min: null +- pT: + min: 400.0 mid: 425.0 - max: null - k2: - min: null - mid: 0.0 - max: null - k3: + max: 450.0 + m_W2: min: null - mid: 8000.0 + mid: 6.46046213e+03 max: null -- k1: - min: null +- pT: + min: 450.0 mid: 475.0 - max: null - k2: - min: null - mid: 0.0 - max: null - k3: + max: 500.0 + m_W2: min: null - mid: 8000.0 + mid: 6.46046213e+03 max: null -- k1: - min: null +- pT: + min: 500.0 mid: 550.0 - max: null - k2: - min: null - mid: 0.0 - max: null - k3: + max: 600.0 + m_W2: min: null - mid: 8000.0 + mid: 6.46046213e+03 max: null -- k1: - min: null +- pT: + min: 600.0 mid: 700.0 - max: null - k2: - min: null - mid: 0.0 - max: null - k3: + max: 800.0 + m_W2: min: null - mid: 8000.0 + mid: 6.46046213e+03 max: null diff --git a/nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/metadata.yaml b/nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/metadata.yaml index 1354e02e41..6cd7bf5af6 100644 --- a/nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/metadata.yaml +++ b/nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/metadata.yaml @@ -1,121 +1,128 @@ setname: ATLAS_WJ_8TEV -version: 1 -version_comment: Port of old commondata + nnpdf_metadata: nnpdf31_process: DY CC experiment: ATLAS + arXiv: url: https://arxiv.org/abs/1711.03296 - journal: JHEP 05 (2018) 077 + journal: JHEP 05 (2018) 07, JHEP 10 (2020) 048 (Erratum) iNSPIRE: - url: '' + url: https://inspirehep.net/literature/1635273 hepdata: - url: '' - version: -1 + url: https://www.hepdata.net/record/ins1635273 + version: 2 + +version: 2 +version_comment: Implementation in the new format + implemented_observables: - observable_name: WM-PT observable: description: Jet Transverse Momentum Distribution label: ATLAS $W^-$+jet 8 TeV - units: '' - process_type: EWJ_PT - tables: [] - npoints: [] + units: '[fb]' + process_type: DY_CC_PT + tables: [13, 15] ndata: 16 plotting: - kinematics_override: ewj_pt_sqrt_scale + kinematics_override: identity dataset_label: ATLAS $W^-$+jet 8 TeV x_label: $p_T^{W^-}$ (GeV) y_label: $d\sigma/dp_T^{W^-}$ (fb/GeV) y_scale: log - plot_x: k1 - kinematic_coverage: - - k1 - - k2 - - k3 + plot_x: pT + kinematic_coverage: [pT, m_W2] kinematics: variables: - k1: - description: Variable k1 - label: k1 - units: '' - k2: - description: Variable k2 - label: k2 - units: '' - k3: - description: Variable k3 - label: k3 - units: '' + pT: + description: Transverse momentum of the W boson + label: $p_T^{W^{-}}$ + units: GeV + m_W2: + description: W boson mass squared + label: $M_W^2$ + units: GeV$^2$ file: kinematics_WM-PT.yaml - theory: - conversion_factor: 1.0 - operation: 'null' - FK_tables: - - - ATLAS_WM_JET_8TEV_PT-atlas-atlas-wjets-arxiv-1711.03296-xsec003 - data_uncertainties: [] + data_central: data_WM-PT.yaml + data_uncertainties: [uncertainties_WM-PT.yaml] variants: + #CMS_prescription: + # data_uncertainties: + # - uncertainties_WM-PT_cms.yaml + # data_central: data_WM-PT_cms.yaml legacy: + # Corresponds to CMS prescription data_uncertainties: - uncertainties_legacy_WM-PT.yaml + data_central: data_legacy_WM-PT.yaml legacy_NP: + # Corresponds to CMS prescription + non-perturbative corrections data_uncertainties: - - uncertainties_WM-PT_sys_NP.yaml + - uncertainties_legacy_WM-PT_sys_NP.yaml + data_central: data_legacy_WM-PT.yaml legacy_ATLAS: + # Corresponds to CMS prescription + inter-experiment correlations data_uncertainties: - - uncertainties_WM-PT_sys_ATLAS.yaml - data_central: data_legacy_WM-PT.yaml - ported_from: ATLAS_WM_JET_8TEV_PT + - uncertainties_legacy_WM-PT_sys_ATLAS.yaml + data_central: data_legacy_WM-PT.yaml + theory: + conversion_factor: 1.0 + operation: 'null' + FK_tables: + - - ATLAS_WM_JET_8TEV_PT-atlas-atlas-wjets-arxiv-1711.03296-xsec003 + - observable_name: WP-PT observable: description: Jet Transverse Momentum Distribution label: ATLAS $W^+$+jet 8 TeV - units: '' - process_type: EWJ_PT - tables: [] - npoints: [] + units: '[fb]' + process_type: DY_CC_PT + tables: [13, 14] ndata: 16 plotting: - kinematics_override: ewj_pt_sqrt_scale + kinematics_override: identity dataset_label: ATLAS $W^+$+jet 8 TeV x_label: $p_T^{W^+}$ (GeV) y_label: $d\sigma/dp_T^{W^+}$ (fb/GeV) y_scale: log - plot_x: k1 - kinematic_coverage: - - k1 - - k2 - - k3 + plot_x: pT + kinematic_coverage: [pT, m_W2] kinematics: variables: - k1: - description: Variable k1 - label: k1 - units: '' - k2: - description: Variable k2 - label: k2 - units: '' - k3: - description: Variable k3 - label: k3 - units: '' + pT: + description: Transverse momentum of the W boson + label: $p_T^{W^{+}}$ + units: GeV + m_W2: + description: W boson mass squared + label: $M_W^2$ + units: GeV$^2$ file: kinematics_WP-PT.yaml - theory: - conversion_factor: 1.0 - operation: 'null' - FK_tables: - - - ATLAS_WP_JET_8TEV_PT-atlas-atlas-wjets-arxiv-1711.03296-xsec002 - data_uncertainties: [] + data_central: data_WP-PT.yaml + data_uncertainties: [uncertainties_WP-PT.yaml] variants: + #CMS_prescription: + # data_uncertainties: + # - uncertainties_WP-PT_cms.yaml + # data_central: data_WP-PT_cms.yaml legacy: + # Corresponds to CMS prescription data_uncertainties: - uncertainties_legacy_WP-PT.yaml + data_central: data_legacy_WP-PT.yaml legacy_NP: + # Corresponds to CMS prescription + non-perturbative corrections data_uncertainties: - - uncertainties_WP-PT_sys_NP.yaml + - uncertainties_legacy_WP-PT_sys_NP.yaml + data_central: data_legacy_WP-PT.yaml legacy_ATLAS: + # Corresponds to CMS prescription + inter-experiment correlations data_uncertainties: - - uncertainties_WP-PT_sys_ATLAS.yaml - data_central: data_legacy_WP-PT.yaml - ported_from: ATLAS_WP_JET_8TEV_PT + - uncertainties_legacy_WP-PT_sys_ATLAS.yaml + data_central: data_legacy_WP-PT.yaml + theory: + conversion_factor: 1.0 + operation: 'null' + FK_tables: + - - ATLAS_WP_JET_8TEV_PT-atlas-atlas-wjets-arxiv-1711.03296-xsec002 diff --git a/nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/rawdata/data13.yaml b/nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/rawdata/data13.yaml new file mode 100644 index 0000000000..351821bce2 --- /dev/null +++ b/nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/rawdata/data13.yaml @@ -0,0 +1,2786 @@ +dependent_variables: +- header: {name: '$d\sigma^{W^+}/dp_\text{T}^\text{W}\text{ [fb/GeV]}$'} + qualifiers: + - {name: 'Cross section', value: 'W+ (electron channel)'} + - {name: 'ABS(ETARAP(ELECTRON))', value: '< 2.5'} + - {name: 'ABS(YRAP(JET))', value: '< 4.4'} + - {name: 'PT(JET)', units: 'GEV', value: '> 30'} + - {name: 'PT(LEPTON)', units: 'GEV', value: '> 25'} + - {name: 'RE', value: 'P P --> W JET(S) X'} + - {name: 'SQRT(S)', units: 'GEV', value: '8000.0'} + values: + - errors: + - {label: 'Stat', symerror: 2} + - {label: 'JetScaleEff1', asymerror: {plus: 126, minus: -125}} + - {label: 'JetScaleEff2', asymerror: {plus: -31, minus: 32}} + - {label: 'JetScaleEff3', asymerror: {plus: 5, minus: -4}} + - {label: 'JetScaleEff4', asymerror: {plus: 0.4, minus: 0.2}} + - {label: 'JetScaleEff5', asymerror: {plus: -4, minus: 6}} + - {label: 'JetScaleEff6', asymerror: {plus: 8, minus: -7}} + - {label: 'JetScaleEta1', asymerror: {plus: 67, minus: -64}} + - {label: 'JetScaleEta2', asymerror: {plus: 33, minus: -31}} + - {label: 'JetScaleHighPt', asymerror: {plus: 0.2, minus: 0.2}} + - {label: 'JetScaleMC', asymerror: {plus: 0.3, minus: 0.3}} + - {label: 'JetScalePileup1', asymerror: {plus: 5, minus: -2}} + - {label: 'JetScalePileup2', asymerror: {plus: -13, minus: 17}} + - {label: 'JetScalePileup3', asymerror: {plus: 3, minus: -3}} + - {label: 'JetScalePileup4', asymerror: {plus: 84, minus: -83}} + - {label: 'JetScaleFlav1Known', asymerror: {plus: 26, minus: -25}} + - {label: 'JetScaleFlav2', asymerror: {plus: -101, minus: 102}} + - {label: 'JetScaleBjet', asymerror: {plus: 0.3, minus: 0.2}} + - {label: 'JetScalepunchT', asymerror: {plus: 0.2, minus: 0.3}} + - {label: 'JetResolution10', symerror: 214} + - {label: 'JetSFBeff', asymerror: {plus: -6, minus: 7}} + - {label: 'JetSFCeff', asymerror: {plus: -3, minus: 4}} + - {label: 'JetSFLmistag', asymerror: {plus: -4, minus: 4}} + - {label: 'JetSFHighPt', asymerror: {plus: 0.2, minus: 0.2}} + - {label: 'JetJVFcut', asymerror: {plus: -23, minus: 14}} + - {label: 'ElScaleR12', asymerror: {plus: -2, minus: 2}} + - {label: 'ElScaleZee', asymerror: {plus: 20, minus: -23}} + - {label: 'ElScalePS', asymerror: {plus: -0.5, minus: 0.5}} + - {label: 'ElResolution', symerror: -3} + - {label: 'ElSFReco', asymerror: {plus: 5, minus: -5}} + - {label: 'ElSFId', asymerror: {plus: 18, minus: -17}} + - {label: 'ElSFTrigger', asymerror: {plus: 14, minus: -14}} + - {label: 'ElSFIso', asymerror: {plus: 4, minus: -4}} + - {label: 'ElSFChargeMisID', asymerror: {plus: 0.03, minus: 0.1}} + - {label: 'METScale', asymerror: {plus: 6, minus: 1}} + - {label: 'METResLong', symerror: 20} + - {label: 'METResTrans', symerror: 11} + - {label: 'PileupWeight', asymerror: {plus: 17, minus: -16}} + - {label: 'QCDlowRange', asymerror: {plus: -4, minus: 29}} + - {label: 'QCDhighRange', asymerror: {plus: 3, minus: -3}} + - {label: 'QCDvarIso', symerror: 3} + - {label: 'QCDvarElID', symerror: 48} + - {label: 'QCDfitUncert', symerror: 5} + - {label: 'QCDotherGen', symerror: 4} + - {label: 'QCDfitRebin', symerror: -1} + - {label: 'XsecZ', asymerror: {plus: -6, minus: 6}} + - {label: 'XsecTop', asymerror: {plus: 3, minus: -3}} + - {label: 'XsecDibos', asymerror: {plus: 1, minus: -1}} + - {label: 'BkgTtbarNorm', symerror: -2} + - {label: 'BkgMCstat', symerror: -2} + - {label: 'WHFmodel', symerror: -13} + - {label: 'LumiUncert', asymerror: {plus: 47, minus: -49}} + - {label: 'UnfoldMCstat', symerror: -4} + - {label: 'UnfoldOtherGen', symerror: 40} + - {label: 'UnfoldReweight', symerror: 48} + value: 2322.0 + - errors: + - {label: 'Stat', symerror: 1} + - {label: 'JetScaleEff1', asymerror: {plus: 277, minus: -281}} + - {label: 'JetScaleEff2', asymerror: {plus: -69, minus: 70}} + - {label: 'JetScaleEff3', asymerror: {plus: 10, minus: -9}} + - {label: 'JetScaleEff4', asymerror: {plus: 5, minus: -4}} + - {label: 'JetScaleEff5', asymerror: {plus: -11, minus: 13}} + - {label: 'JetScaleEff6', asymerror: {plus: 17, minus: -16}} + - {label: 'JetScaleEta1', asymerror: {plus: 140, minus: -136}} + - {label: 'JetScaleEta2', asymerror: {plus: 71, minus: -69}} + - {label: 'JetScaleHighPt', asymerror: {plus: 0.4, minus: 1}} + - {label: 'JetScaleMC', asymerror: {plus: 1, minus: 1}} + - {label: 'JetScalePileup1', asymerror: {plus: 8, minus: -4}} + - {label: 'JetScalePileup2', asymerror: {plus: -30, minus: 38}} + - {label: 'JetScalePileup3', asymerror: {plus: 8, minus: -7}} + - {label: 'JetScalePileup4', asymerror: {plus: 183, minus: -185}} + - {label: 'JetScaleFlav1Known', asymerror: {plus: 56, minus: -56}} + - {label: 'JetScaleFlav2', asymerror: {plus: -223, minus: 222}} + - {label: 'JetScaleBjet', asymerror: {plus: 1, minus: 1}} + - {label: 'JetScalepunchT', asymerror: {plus: 0.5, minus: 1}} + - {label: 'JetResolution10', symerror: 496} + - {label: 'JetSFBeff', asymerror: {plus: -10, minus: 11}} + - {label: 'JetSFCeff', asymerror: {plus: -7, minus: 9}} + - {label: 'JetSFLmistag', asymerror: {plus: -8, minus: 9}} + - {label: 'JetSFHighPt', asymerror: {plus: 1, minus: 1}} + - {label: 'JetJVFcut', asymerror: {plus: -47, minus: 31}} + - {label: 'ElScaleR12', asymerror: {plus: 4, minus: -4}} + - {label: 'ElScaleZee', asymerror: {plus: 52, minus: -56}} + - {label: 'ElScalePS', asymerror: {plus: -1, minus: 1}} + - {label: 'ElResolution', symerror: -8} + - {label: 'ElSFReco', asymerror: {plus: 14, minus: -13}} + - {label: 'ElSFId', asymerror: {plus: 44, minus: -44}} + - {label: 'ElSFTrigger', asymerror: {plus: 34, minus: -35}} + - {label: 'ElSFIso', asymerror: {plus: 10, minus: -10}} + - {label: 'ElSFChargeMisID', asymerror: {plus: 0.1, minus: 0.2}} + - {label: 'METScale', asymerror: {plus: -106, minus: 99}} + - {label: 'METResLong', symerror: -99} + - {label: 'METResTrans', symerror: -95} + - {label: 'PileupWeight', asymerror: {plus: 33, minus: -30}} + - {label: 'QCDlowRange', asymerror: {plus: -4, minus: 42}} + - {label: 'QCDhighRange', asymerror: {plus: 4, minus: -5}} + - {label: 'QCDvarIso', symerror: -4} + - {label: 'QCDvarElID', symerror: 19} + - {label: 'QCDfitUncert', symerror: 7} + - {label: 'QCDotherGen', symerror: 8} + - {label: 'QCDfitRebin', symerror: -1} + - {label: 'XsecZ', asymerror: {plus: -4, minus: 4}} + - {label: 'XsecTop', asymerror: {plus: 5, minus: -5}} + - {label: 'XsecDibos', asymerror: {plus: 2, minus: -2}} + - {label: 'BkgTtbarNorm', symerror: -3} + - {label: 'BkgMCstat', symerror: -2} + - {label: 'WHFmodel', symerror: 13} + - {label: 'LumiUncert', asymerror: {plus: 113, minus: -117}} + - {label: 'UnfoldMCstat', symerror: -7} + - {label: 'UnfoldOtherGen', symerror: 463} + - {label: 'UnfoldReweight', symerror: -29} + value: 5644.0 + - errors: + - {label: 'Stat', symerror: 1} + - {label: 'JetScaleEff1', asymerror: {plus: 126, minus: -131}} + - {label: 'JetScaleEff2', asymerror: {plus: -25, minus: 25}} + - {label: 'JetScaleEff3', asymerror: {plus: -3, minus: 2}} + - {label: 'JetScaleEff4', asymerror: {plus: 15, minus: -15}} + - {label: 'JetScaleEff5', asymerror: {plus: -5, minus: 5}} + - {label: 'JetScaleEff6', asymerror: {plus: 7, minus: -7}} + - {label: 'JetScaleEta1', asymerror: {plus: 59, minus: -58}} + - {label: 'JetScaleEta2', asymerror: {plus: 29, minus: -29}} + - {label: 'JetScaleHighPt', asymerror: {plus: 0.2, minus: 0.3}} + - {label: 'JetScaleMC', asymerror: {plus: 0.4, minus: 0.3}} + - {label: 'JetScalePileup1', asymerror: {plus: 3, minus: -2}} + - {label: 'JetScalePileup2', asymerror: {plus: -12, minus: 14}} + - {label: 'JetScalePileup3', asymerror: {plus: 7, minus: -7}} + - {label: 'JetScalePileup4', asymerror: {plus: 78, minus: -80}} + - {label: 'JetScaleFlav1Known', asymerror: {plus: 21, minus: -22}} + - {label: 'JetScaleFlav2', asymerror: {plus: -103, minus: 100}} + - {label: 'JetScaleBjet', asymerror: {plus: 0.4, minus: 0.3}} + - {label: 'JetScalepunchT', asymerror: {plus: 0.2, minus: 0.3}} + - {label: 'JetResolution10', symerror: 225} + - {label: 'JetSFBeff', asymerror: {plus: -8, minus: 9}} + - {label: 'JetSFCeff', asymerror: {plus: -5, minus: 5}} + - {label: 'JetSFLmistag', asymerror: {plus: -5, minus: 5}} + - {label: 'JetSFHighPt', asymerror: {plus: 0.3, minus: 0.3}} + - {label: 'JetJVFcut', asymerror: {plus: -15, minus: 5}} + - {label: 'ElScaleR12', asymerror: {plus: 6, minus: -6}} + - {label: 'ElScaleZee', asymerror: {plus: 26, minus: -28}} + - {label: 'ElScalePS', asymerror: {plus: -1, minus: 1}} + - {label: 'ElResolution', symerror: -2} + - {label: 'ElSFReco', asymerror: {plus: 8, minus: -8}} + - {label: 'ElSFId', asymerror: {plus: 24, minus: -24}} + - {label: 'ElSFTrigger', asymerror: {plus: 18, minus: -18}} + - {label: 'ElSFIso', asymerror: {plus: 6, minus: -6}} + - {label: 'ElSFChargeMisID', asymerror: {plus: 0.04, minus: 0.1}} + - {label: 'METScale', asymerror: {plus: -85, minus: 80}} + - {label: 'METResLong', symerror: -76} + - {label: 'METResTrans', symerror: -76} + - {label: 'PileupWeight', asymerror: {plus: 18, minus: -17}} + - {label: 'QCDlowRange', asymerror: {plus: -2, minus: 18}} + - {label: 'QCDhighRange', asymerror: {plus: 2, minus: -2}} + - {label: 'QCDvarIso', symerror: -7} + - {label: 'QCDvarElID', symerror: 10} + - {label: 'QCDfitUncert', symerror: 3} + - {label: 'QCDotherGen', symerror: 3} + - {label: 'QCDfitRebin', symerror: -0.3} + - {label: 'XsecZ', asymerror: {plus: 0.3, minus: -0.3}} + - {label: 'XsecTop', asymerror: {plus: 4, minus: -4}} + - {label: 'XsecDibos', asymerror: {plus: 2, minus: -2}} + - {label: 'BkgTtbarNorm', symerror: -3} + - {label: 'BkgMCstat', symerror: -1} + - {label: 'WHFmodel', symerror: 16} + - {label: 'LumiUncert', asymerror: {plus: 61, minus: -63}} + - {label: 'UnfoldMCstat', symerror: -4} + - {label: 'UnfoldOtherGen', symerror: 58} + - {label: 'UnfoldReweight', symerror: -7} + value: 2973.0 + - errors: + - {label: 'Stat', symerror: 1} + - {label: 'JetScaleEff1', asymerror: {plus: 42, minus: -42}} + - {label: 'JetScaleEff2', asymerror: {plus: -4, minus: 4}} + - {label: 'JetScaleEff3', asymerror: {plus: -3, minus: 4}} + - {label: 'JetScaleEff4', asymerror: {plus: 8, minus: -8}} + - {label: 'JetScaleEff5', asymerror: {plus: -2, minus: 2}} + - {label: 'JetScaleEff6', asymerror: {plus: 3, minus: -3}} + - {label: 'JetScaleEta1', asymerror: {plus: 20, minus: -19}} + - {label: 'JetScaleEta2', asymerror: {plus: 10, minus: -9}} + - {label: 'JetScaleHighPt', asymerror: {plus: 0.1, minus: 0.1}} + - {label: 'JetScaleMC', asymerror: {plus: 0.2, minus: 0.1}} + - {label: 'JetScalePileup1', asymerror: {plus: 1, minus: -1}} + - {label: 'JetScalePileup2', asymerror: {plus: -3, minus: 4}} + - {label: 'JetScalePileup3', asymerror: {plus: 4, minus: -3}} + - {label: 'JetScalePileup4', asymerror: {plus: 25, minus: -25}} + - {label: 'JetScaleFlav1Known', asymerror: {plus: 6, minus: -6}} + - {label: 'JetScaleFlav2', asymerror: {plus: -35, minus: 35}} + - {label: 'JetScaleBjet', asymerror: {plus: 0.2, minus: 0.1}} + - {label: 'JetScalepunchT', asymerror: {plus: 0.1, minus: 0.1}} + - {label: 'JetResolution10', symerror: 58} + - {label: 'JetSFBeff', asymerror: {plus: -6, minus: 6}} + - {label: 'JetSFCeff', asymerror: {plus: -2, minus: 2}} + - {label: 'JetSFLmistag', asymerror: {plus: -2, minus: 2}} + - {label: 'JetSFHighPt', asymerror: {plus: 0.1, minus: 0.1}} + - {label: 'JetJVFcut', asymerror: {plus: -3, minus: -2}} + - {label: 'ElScaleR12', asymerror: {plus: 3, minus: -3}} + - {label: 'ElScaleZee', asymerror: {plus: 9, minus: -9}} + - {label: 'ElScalePS', asymerror: {plus: -0.2, minus: 0.2}} + - {label: 'ElResolution', symerror: -1} + - {label: 'ElSFReco', asymerror: {plus: 4, minus: -4}} + - {label: 'ElSFId', asymerror: {plus: 11, minus: -11}} + - {label: 'ElSFTrigger', asymerror: {plus: 7, minus: -7}} + - {label: 'ElSFIso', asymerror: {plus: 3, minus: -2}} + - {label: 'ElSFChargeMisID', asymerror: {plus: 0.02, minus: 0.05}} + - {label: 'METScale', asymerror: {plus: -29, minus: 31}} + - {label: 'METResLong', symerror: -23} + - {label: 'METResTrans', symerror: -26} + - {label: 'PileupWeight', asymerror: {plus: 6, minus: -6}} + - {label: 'QCDlowRange', asymerror: {plus: -1, minus: 5}} + - {label: 'QCDhighRange', asymerror: {plus: 1, minus: -0.5}} + - {label: 'QCDvarIso', symerror: -4} + - {label: 'QCDvarElID', symerror: -2} + - {label: 'QCDfitUncert', symerror: 1} + - {label: 'QCDotherGen', symerror: 1} + - {label: 'QCDfitRebin', symerror: -0.04} + - {label: 'XsecZ', asymerror: {plus: 0.2, minus: -0.2}} + - {label: 'XsecTop', asymerror: {plus: 3, minus: -3}} + - {label: 'XsecDibos', asymerror: {plus: 1, minus: -1}} + - {label: 'BkgTtbarNorm', symerror: -2} + - {label: 'BkgMCstat', symerror: -1} + - {label: 'WHFmodel', symerror: 8} + - {label: 'LumiUncert', asymerror: {plus: 25, minus: -26}} + - {label: 'UnfoldMCstat', symerror: -2} + - {label: 'UnfoldOtherGen', symerror: 29} + - {label: 'UnfoldReweight', symerror: -3} + value: 1210.0 + - errors: + - {label: 'Stat', symerror: 0.7} + - {label: 'JetScaleEff1', asymerror: {plus: 15.5, minus: -15.8}} + - {label: 'JetScaleEff2', asymerror: {plus: 1.2, minus: -1.0}} + - {label: 'JetScaleEff3', asymerror: {plus: -2.3, minus: 2.3}} + - {label: 'JetScaleEff4', asymerror: {plus: 3.0, minus: -3.0}} + - {label: 'JetScaleEff5', asymerror: {plus: -0.9, minus: 0.9}} + - {label: 'JetScaleEff6', asymerror: {plus: 1.6, minus: -1.7}} + - {label: 'JetScaleEta1', asymerror: {plus: 7.3, minus: -7.1}} + - {label: 'JetScaleEta2', asymerror: {plus: 3.6, minus: -3.6}} + - {label: 'JetScaleHighPt', asymerror: {plus: 0.04, minus: 0.1}} + - {label: 'JetScaleMC', asymerror: {plus: 0.1, minus: 0.1}} + - {label: 'JetScalePileup1', asymerror: {plus: 0.6, minus: -0.4}} + - {label: 'JetScalePileup2', asymerror: {plus: -1.1, minus: 1.1}} + - {label: 'JetScalePileup3', asymerror: {plus: 1.6, minus: -1.7}} + - {label: 'JetScalePileup4', asymerror: {plus: 9.3, minus: -9.6}} + - {label: 'JetScaleFlav1Known', asymerror: {plus: 2.4, minus: -2.3}} + - {label: 'JetScaleFlav2', asymerror: {plus: -14.9, minus: 14.4}} + - {label: 'JetScaleBjet', asymerror: {plus: 0.1, minus: 0.05}} + - {label: 'JetScalepunchT', asymerror: {plus: 0.04, minus: 0.1}} + - {label: 'JetResolution10', symerror: 15.5} + - {label: 'JetSFBeff', asymerror: {plus: -3.7, minus: 3.8}} + - {label: 'JetSFCeff', asymerror: {plus: -1.3, minus: 1.0}} + - {label: 'JetSFLmistag', asymerror: {plus: -1.2, minus: 1.0}} + - {label: 'JetSFHighPt', asymerror: {plus: 0.1, minus: 0.1}} + - {label: 'JetJVFcut', asymerror: {plus: -1.6, minus: -1.9}} + - {label: 'ElScaleR12', asymerror: {plus: 1.6, minus: -1.6}} + - {label: 'ElScaleZee', asymerror: {plus: 3.0, minus: -3.1}} + - {label: 'ElScalePS', asymerror: {plus: -0.1, minus: 0.1}} + - {label: 'ElResolution', symerror: -0.4} + - {label: 'ElSFReco', asymerror: {plus: 2.0, minus: -2.1}} + - {label: 'ElSFId', asymerror: {plus: 5.4, minus: -5.6}} + - {label: 'ElSFTrigger', asymerror: {plus: 2.9, minus: -3.0}} + - {label: 'ElSFIso', asymerror: {plus: 1.3, minus: -1.4}} + - {label: 'ElSFChargeMisID', asymerror: {plus: 0.01, minus: 0.02}} + - {label: 'METScale', asymerror: {plus: -8.7, minus: 9.6}} + - {label: 'METResLong', symerror: -6.9} + - {label: 'METResTrans', symerror: -7.9} + - {label: 'PileupWeight', asymerror: {plus: 1.1, minus: -1.2}} + - {label: 'QCDlowRange', asymerror: {plus: -0.4, minus: 1.4}} + - {label: 'QCDhighRange', asymerror: {plus: 0.2, minus: -0.1}} + - {label: 'QCDvarIso', symerror: -1.5} + - {label: 'QCDvarElID', symerror: -3.1} + - {label: 'QCDfitUncert', symerror: 0.4} + - {label: 'QCDotherGen', symerror: 0.2} + - {label: 'QCDfitRebin', symerror: 0.004} + - {label: 'XsecZ', asymerror: {plus: 0.1, minus: -0.1}} + - {label: 'XsecTop', asymerror: {plus: 1.9, minus: -1.9}} + - {label: 'XsecDibos', asymerror: {plus: 0.4, minus: -0.4}} + - {label: 'BkgTtbarNorm', symerror: -1.7} + - {label: 'BkgMCstat', symerror: -0.5} + - {label: 'WHFmodel', symerror: 3.9} + - {label: 'LumiUncert', asymerror: {plus: 11.2, minus: -11.7}} + - {label: 'UnfoldMCstat', symerror: -1.4} + - {label: 'UnfoldOtherGen', symerror: 18.6} + - {label: 'UnfoldReweight', symerror: -1.5} + value: 537.1 + - errors: + - {label: 'Stat', symerror: 0.5} + - {label: 'JetScaleEff1', asymerror: {plus: 6.5, minus: -6.8}} + - {label: 'JetScaleEff2', asymerror: {plus: 1.3, minus: -1.4}} + - {label: 'JetScaleEff3', asymerror: {plus: -1.3, minus: 1.2}} + - {label: 'JetScaleEff4', asymerror: {plus: 0.8, minus: -0.9}} + - {label: 'JetScaleEff5', asymerror: {plus: -0.4, minus: 0.5}} + - {label: 'JetScaleEff6', asymerror: {plus: 0.8, minus: -0.9}} + - {label: 'JetScaleEta1', asymerror: {plus: 3.0, minus: -3.1}} + - {label: 'JetScaleEta2', asymerror: {plus: 1.6, minus: -1.7}} + - {label: 'JetScaleHighPt', asymerror: {plus: 0.02, minus: 0.02}} + - {label: 'JetScaleMC', asymerror: {plus: 0.03, minus: 0.03}} + - {label: 'JetScalePileup1', asymerror: {plus: 0.3, minus: -0.2}} + - {label: 'JetScalePileup2', asymerror: {plus: -0.5, minus: 0.5}} + - {label: 'JetScalePileup3', asymerror: {plus: 0.8, minus: -1.0}} + - {label: 'JetScalePileup4', asymerror: {plus: 3.9, minus: -4.1}} + - {label: 'JetScaleFlav1Known', asymerror: {plus: 1.1, minus: -1.2}} + - {label: 'JetScaleFlav2', asymerror: {plus: -6.9, minus: 6.6}} + - {label: 'JetScaleBjet', asymerror: {plus: 0.03, minus: 0.02}} + - {label: 'JetScalepunchT', asymerror: {plus: 0.02, minus: 0.03}} + - {label: 'JetResolution10', symerror: 5.1} + - {label: 'JetSFBeff', asymerror: {plus: -2.3, minus: 2.4}} + - {label: 'JetSFCeff', asymerror: {plus: -0.7, minus: 0.6}} + - {label: 'JetSFLmistag', asymerror: {plus: -0.6, minus: 0.5}} + - {label: 'JetSFHighPt', asymerror: {plus: 0.02, minus: 0.03}} + - {label: 'JetJVFcut', asymerror: {plus: -1.1, minus: -1.1}} + - {label: 'ElScaleR12', asymerror: {plus: 0.8, minus: -0.8}} + - {label: 'ElScaleZee', asymerror: {plus: 1.2, minus: -1.4}} + - {label: 'ElScalePS', asymerror: {plus: -0.1, minus: 0.1}} + - {label: 'ElResolution', symerror: -0.2} + - {label: 'ElSFReco', asymerror: {plus: 1.1, minus: -1.2}} + - {label: 'ElSFId', asymerror: {plus: 2.8, minus: -2.9}} + - {label: 'ElSFTrigger', asymerror: {plus: 1.4, minus: -1.5}} + - {label: 'ElSFIso', asymerror: {plus: 0.6, minus: -0.7}} + - {label: 'ElSFChargeMisID', asymerror: {plus: 0.004, minus: 0.01}} + - {label: 'METScale', asymerror: {plus: -3.1, minus: 2.9}} + - {label: 'METResLong', symerror: -2.6} + - {label: 'METResTrans', symerror: -2.7} + - {label: 'PileupWeight', asymerror: {plus: 0.5, minus: -0.6}} + - {label: 'QCDlowRange', asymerror: {plus: -0.2, minus: 0.5}} + - {label: 'QCDhighRange', asymerror: {plus: 0.1, minus: -0.03}} + - {label: 'QCDvarIso', symerror: -0.9} + - {label: 'QCDvarElID', symerror: -1.0} + - {label: 'QCDfitUncert', symerror: 0.2} + - {label: 'QCDotherGen', symerror: 0.1} + - {label: 'QCDfitRebin', symerror: 0.01} + - {label: 'XsecZ', asymerror: {plus: 0.1, minus: -0.1}} + - {label: 'XsecTop', asymerror: {plus: 1.2, minus: -1.2}} + - {label: 'XsecDibos', asymerror: {plus: 0.2, minus: -0.2}} + - {label: 'BkgTtbarNorm', symerror: -1.1} + - {label: 'BkgMCstat', symerror: -0.3} + - {label: 'WHFmodel', symerror: 1.5} + - {label: 'LumiUncert', asymerror: {plus: 5.5, minus: -5.7}} + - {label: 'UnfoldMCstat', symerror: -0.9} + - {label: 'UnfoldOtherGen', symerror: 4.3} + - {label: 'UnfoldReweight', symerror: -0.7} + value: 258.1 + - errors: + - {label: 'Stat', symerror: 0.5} + - {label: 'JetScaleEff1', asymerror: {plus: 3.5, minus: -3.6}} + - {label: 'JetScaleEff2', asymerror: {plus: 1.1, minus: -1.2}} + - {label: 'JetScaleEff3', asymerror: {plus: -0.9, minus: 0.6}} + - {label: 'JetScaleEff4', asymerror: {plus: 0.4, minus: -0.5}} + - {label: 'JetScaleEff5', asymerror: {plus: -0.2, minus: -0.5}} + - {label: 'JetScaleEff6', asymerror: {plus: 0.4, minus: -0.5}} + - {label: 'JetScaleEta1', asymerror: {plus: 1.6, minus: -1.6}} + - {label: 'JetScaleEta2', asymerror: {plus: 1.0, minus: -1.1}} + - {label: 'JetScaleHighPt', asymerror: {plus: 0.01, minus: 0.01}} + - {label: 'JetScaleMC', asymerror: {plus: 0.02, minus: 0.01}} + - {label: 'JetScalePileup1', asymerror: {plus: 0.2, minus: -0.1}} + - {label: 'JetScalePileup2', asymerror: {plus: -0.3, minus: 0.3}} + - {label: 'JetScalePileup3', asymerror: {plus: 0.5, minus: -0.5}} + - {label: 'JetScalePileup4', asymerror: {plus: 2.2, minus: -2.2}} + - {label: 'JetScaleFlav1Known', asymerror: {plus: 0.6, minus: -0.6}} + - {label: 'JetScaleFlav2', asymerror: {plus: -3.7, minus: 3.6}} + - {label: 'JetScaleBjet', asymerror: {plus: 0.02, minus: 0.01}} + - {label: 'JetScalepunchT', asymerror: {plus: 0.01, minus: 0.01}} + - {label: 'JetResolution10', symerror: 2.4} + - {label: 'JetSFBeff', asymerror: {plus: -1.4, minus: 1.4}} + - {label: 'JetSFCeff', asymerror: {plus: -0.4, minus: 0.3}} + - {label: 'JetSFLmistag', asymerror: {plus: -0.3, minus: 0.2}} + - {label: 'JetSFHighPt', asymerror: {plus: 0.01, minus: 0.01}} + - {label: 'JetJVFcut', asymerror: {plus: -0.6, minus: -0.6}} + - {label: 'ElScaleR12', asymerror: {plus: 0.4, minus: -0.4}} + - {label: 'ElScaleZee', asymerror: {plus: 0.6, minus: -0.6}} + - {label: 'ElScalePS', asymerror: {plus: -0.03, minus: 0.03}} + - {label: 'ElResolution', symerror: -0.1} + - {label: 'ElSFReco', asymerror: {plus: 0.6, minus: -0.6}} + - {label: 'ElSFId', asymerror: {plus: 1.5, minus: -1.6}} + - {label: 'ElSFTrigger', asymerror: {plus: 0.8, minus: -0.8}} + - {label: 'ElSFIso', asymerror: {plus: 0.3, minus: -0.4}} + - {label: 'ElSFChargeMisID', asymerror: {plus: 0.002, minus: 0.01}} + - {label: 'METScale', asymerror: {plus: -1.3, minus: 1.3}} + - {label: 'METResLong', symerror: -0.9} + - {label: 'METResTrans', symerror: -1.1} + - {label: 'PileupWeight', asymerror: {plus: 0.3, minus: -0.3}} + - {label: 'QCDlowRange', asymerror: {plus: -0.1, minus: 0.2}} + - {label: 'QCDhighRange', asymerror: {plus: 0.04, minus: -0.01}} + - {label: 'QCDvarIso', symerror: -0.6} + - {label: 'QCDvarElID', symerror: -0.5} + - {label: 'QCDfitUncert', symerror: 0.1} + - {label: 'QCDotherGen', symerror: 0.1} + - {label: 'QCDfitRebin', symerror: 0.01} + - {label: 'XsecZ', asymerror: {plus: 0.03, minus: -0.03}} + - {label: 'XsecTop', asymerror: {plus: 0.7, minus: -0.7}} + - {label: 'XsecDibos', asymerror: {plus: 0.1, minus: -0.1}} + - {label: 'BkgTtbarNorm', symerror: -0.7} + - {label: 'BkgMCstat', symerror: -0.2} + - {label: 'WHFmodel', symerror: 0.8} + - {label: 'LumiUncert', asymerror: {plus: 2.9, minus: -3.0}} + - {label: 'UnfoldMCstat', symerror: -0.6} + - {label: 'UnfoldOtherGen', symerror: 2.6} + - {label: 'UnfoldReweight', symerror: -0.4} + value: 135.0 + - errors: + - {label: 'Stat', symerror: 0.36} + - {label: 'JetScaleEff1', asymerror: {plus: 2.03, minus: -1.93}} + - {label: 'JetScaleEff2', asymerror: {plus: 0.80, minus: -0.77}} + - {label: 'JetScaleEff3', asymerror: {plus: -0.53, minus: 0.59}} + - {label: 'JetScaleEff4', asymerror: {plus: 0.24, minus: -0.26}} + - {label: 'JetScaleEff5', asymerror: {plus: -0.12, minus: -0.29}} + - {label: 'JetScaleEff6', asymerror: {plus: 0.24, minus: -0.25}} + - {label: 'JetScaleEta1', asymerror: {plus: 0.81, minus: -0.77}} + - {label: 'JetScaleEta2', asymerror: {plus: 0.54, minus: -0.51}} + - {label: 'JetScaleHighPt', asymerror: {plus: 0.01, minus: 0.01}} + - {label: 'JetScaleMC', asymerror: {plus: 0.01, minus: 0.01}} + - {label: 'JetScalePileup1', asymerror: {plus: 0.08, minus: -0.05}} + - {label: 'JetScalePileup2', asymerror: {plus: -0.15, minus: 0.15}} + - {label: 'JetScalePileup3', asymerror: {plus: 0.29, minus: -0.27}} + - {label: 'JetScalePileup4', asymerror: {plus: 1.19, minus: -1.10}} + - {label: 'JetScaleFlav1Known', asymerror: {plus: 0.30, minus: -0.34}} + - {label: 'JetScaleFlav2', asymerror: {plus: -1.93, minus: 2.03}} + - {label: 'JetScaleBjet', asymerror: {plus: 0.01, minus: 0.01}} + - {label: 'JetScalepunchT', asymerror: {plus: 0.01, minus: 0.01}} + - {label: 'JetResolution10', symerror: 1.28} + - {label: 'JetSFBeff', asymerror: {plus: -0.78, minus: 0.79}} + - {label: 'JetSFCeff', asymerror: {plus: -0.21, minus: 0.18}} + - {label: 'JetSFLmistag', asymerror: {plus: -0.18, minus: 0.13}} + - {label: 'JetSFHighPt', asymerror: {plus: 0.01, minus: 0.01}} + - {label: 'JetJVFcut', asymerror: {plus: -0.41, minus: -0.40}} + - {label: 'ElScaleR12', asymerror: {plus: 0.23, minus: -0.22}} + - {label: 'ElScaleZee', asymerror: {plus: 0.32, minus: -0.32}} + - {label: 'ElScalePS', asymerror: {plus: -0.01, minus: 0.02}} + - {label: 'ElResolution', symerror: -0.06} + - {label: 'ElSFReco', asymerror: {plus: 0.32, minus: -0.35}} + - {label: 'ElSFId', asymerror: {plus: 0.86, minus: -0.86}} + - {label: 'ElSFTrigger', asymerror: {plus: 0.44, minus: -0.45}} + - {label: 'ElSFIso', asymerror: {plus: 0.18, minus: -0.20}} + - {label: 'ElSFChargeMisID', asymerror: {plus: 0.001, minus: 0.003}} + - {label: 'METScale', asymerror: {plus: -0.52, minus: 0.58}} + - {label: 'METResLong', symerror: -0.45} + - {label: 'METResTrans', symerror: -0.45} + - {label: 'PileupWeight', asymerror: {plus: 0.14, minus: -0.16}} + - {label: 'QCDlowRange', asymerror: {plus: -0.05, minus: 0.13}} + - {label: 'QCDhighRange', asymerror: {plus: 0.02, minus: -0.01}} + - {label: 'QCDvarIso', symerror: -0.30} + - {label: 'QCDvarElID', symerror: -0.30} + - {label: 'QCDfitUncert', symerror: 0.06} + - {label: 'QCDotherGen', symerror: 0.03} + - {label: 'QCDfitRebin', symerror: 0.01} + - {label: 'XsecZ', asymerror: {plus: 0.01, minus: -0.01}} + - {label: 'XsecTop', asymerror: {plus: 0.40, minus: -0.40}} + - {label: 'XsecDibos', asymerror: {plus: 0.06, minus: -0.06}} + - {label: 'BkgTtbarNorm', symerror: -0.39} + - {label: 'BkgMCstat', symerror: -0.14} + - {label: 'WHFmodel', symerror: 0.36} + - {label: 'LumiUncert', asymerror: {plus: 1.57, minus: -1.63}} + - {label: 'UnfoldMCstat', symerror: -0.46} + - {label: 'UnfoldOtherGen', symerror: 1.41} + - {label: 'UnfoldReweight', symerror: -0.20} + value: 73.55 + - errors: + - {label: 'Stat', symerror: 0.21} + - {label: 'JetScaleEff1', asymerror: {plus: 0.94, minus: -0.91}} + - {label: 'JetScaleEff2', asymerror: {plus: 0.49, minus: -0.41}} + - {label: 'JetScaleEff3', asymerror: {plus: -0.24, minus: 0.29}} + - {label: 'JetScaleEff4', asymerror: {plus: 0.11, minus: -0.12}} + - {label: 'JetScaleEff5', asymerror: {plus: -0.05, minus: -0.13}} + - {label: 'JetScaleEff6', asymerror: {plus: 0.11, minus: -0.11}} + - {label: 'JetScaleEta1', asymerror: {plus: 0.31, minus: -0.31}} + - {label: 'JetScaleEta2', asymerror: {plus: 0.25, minus: -0.23}} + - {label: 'JetScaleHighPt', asymerror: {plus: 0.003, minus: 0.003}} + - {label: 'JetScaleMC', asymerror: {plus: 0.004, minus: 0.004}} + - {label: 'JetScalePileup1', asymerror: {plus: 0.04, minus: -0.02}} + - {label: 'JetScalePileup2', asymerror: {plus: -0.07, minus: 0.07}} + - {label: 'JetScalePileup3', asymerror: {plus: 0.13, minus: -0.13}} + - {label: 'JetScalePileup4', asymerror: {plus: 0.43, minus: -0.46}} + - {label: 'JetScaleFlav1Known', asymerror: {plus: 0.14, minus: -0.16}} + - {label: 'JetScaleFlav2', asymerror: {plus: -0.86, minus: 0.89}} + - {label: 'JetScaleBjet', asymerror: {plus: 0.004, minus: 0.003}} + - {label: 'JetScalepunchT', asymerror: {plus: 0.003, minus: 0.004}} + - {label: 'JetResolution10', symerror: 0.40} + - {label: 'JetSFBeff', asymerror: {plus: -0.37, minus: 0.37}} + - {label: 'JetSFCeff', asymerror: {plus: -0.10, minus: 0.08}} + - {label: 'JetSFLmistag', asymerror: {plus: -0.08, minus: 0.06}} + - {label: 'JetSFHighPt', asymerror: {plus: 0.003, minus: 0.003}} + - {label: 'JetJVFcut', asymerror: {plus: -0.19, minus: -0.18}} + - {label: 'ElScaleR12', asymerror: {plus: 0.10, minus: -0.10}} + - {label: 'ElScaleZee', asymerror: {plus: 0.15, minus: -0.15}} + - {label: 'ElScalePS', asymerror: {plus: -0.01, minus: 0.01}} + - {label: 'ElResolution', symerror: -0.03} + - {label: 'ElSFReco', asymerror: {plus: 0.15, minus: -0.16}} + - {label: 'ElSFId', asymerror: {plus: 0.40, minus: -0.39}} + - {label: 'ElSFTrigger', asymerror: {plus: 0.20, minus: -0.21}} + - {label: 'ElSFIso', asymerror: {plus: 0.08, minus: -0.09}} + - {label: 'ElSFChargeMisID', asymerror: {plus: 0.0005, minus: 0.001}} + - {label: 'METScale', asymerror: {plus: -0.24, minus: 0.27}} + - {label: 'METResLong', symerror: -0.21} + - {label: 'METResTrans', symerror: -0.21} + - {label: 'PileupWeight', asymerror: {plus: 0.07, minus: -0.07}} + - {label: 'QCDlowRange', asymerror: {plus: -0.02, minus: 0.06}} + - {label: 'QCDhighRange', asymerror: {plus: 0.01, minus: -0.001}} + - {label: 'QCDvarIso', symerror: -0.14} + - {label: 'QCDvarElID', symerror: -0.14} + - {label: 'QCDfitUncert', symerror: 0.03} + - {label: 'QCDotherGen', symerror: 0.01} + - {label: 'QCDfitRebin', symerror: 0.003} + - {label: 'XsecZ', asymerror: {plus: 0.002, minus: -0.002}} + - {label: 'XsecTop', asymerror: {plus: 0.19, minus: -0.19}} + - {label: 'XsecDibos', asymerror: {plus: 0.03, minus: -0.03}} + - {label: 'BkgTtbarNorm', symerror: -0.19} + - {label: 'BkgMCstat', symerror: -0.08} + - {label: 'WHFmodel', symerror: 0.11} + - {label: 'LumiUncert', asymerror: {plus: 0.72, minus: -0.75}} + - {label: 'UnfoldMCstat', symerror: -0.24} + - {label: 'UnfoldOtherGen', symerror: 0.68} + - {label: 'UnfoldReweight', symerror: -0.09} + value: 33.73 + - errors: + - {label: 'Stat', symerror: 0.13} + - {label: 'JetScaleEff1', asymerror: {plus: 0.32, minus: -0.34}} + - {label: 'JetScaleEff2', asymerror: {plus: 0.22, minus: -0.22}} + - {label: 'JetScaleEff3', asymerror: {plus: -0.09, minus: 0.11}} + - {label: 'JetScaleEff4', asymerror: {plus: 0.04, minus: -0.04}} + - {label: 'JetScaleEff5', asymerror: {plus: -0.02, minus: -0.05}} + - {label: 'JetScaleEff6', asymerror: {plus: 0.04, minus: -0.04}} + - {label: 'JetScaleEta1', asymerror: {plus: 0.11, minus: -0.12}} + - {label: 'JetScaleEta2', asymerror: {plus: 0.09, minus: -0.09}} + - {label: 'JetScaleHighPt', asymerror: {plus: 0.001, minus: 0.001}} + - {label: 'JetScaleMC', asymerror: {plus: 0.002, minus: 0.001}} + - {label: 'JetScalePileup1', asymerror: {plus: 0.01, minus: -0.01}} + - {label: 'JetScalePileup2', asymerror: {plus: -0.03, minus: 0.03}} + - {label: 'JetScalePileup3', asymerror: {plus: 0.05, minus: -0.05}} + - {label: 'JetScalePileup4', asymerror: {plus: 0.15, minus: -0.15}} + - {label: 'JetScaleFlav1Known', asymerror: {plus: 0.05, minus: -0.06}} + - {label: 'JetScaleFlav2', asymerror: {plus: -0.28, minus: 0.30}} + - {label: 'JetScaleBjet', asymerror: {plus: 0.002, minus: 0.001}} + - {label: 'JetScalepunchT', asymerror: {plus: 0.001, minus: 0.001}} + - {label: 'JetResolution10', symerror: 0.16} + - {label: 'JetSFBeff', asymerror: {plus: -0.14, minus: 0.14}} + - {label: 'JetSFCeff', asymerror: {plus: -0.04, minus: 0.03}} + - {label: 'JetSFLmistag', asymerror: {plus: -0.03, minus: 0.02}} + - {label: 'JetSFHighPt', asymerror: {plus: 0.001, minus: 0.001}} + - {label: 'JetJVFcut', asymerror: {plus: -0.07, minus: -0.07}} + - {label: 'ElScaleR12', asymerror: {plus: 0.04, minus: -0.04}} + - {label: 'ElScaleZee', asymerror: {plus: 0.06, minus: -0.05}} + - {label: 'ElScalePS', asymerror: {plus: -0.002, minus: 0.003}} + - {label: 'ElResolution', symerror: -0.01} + - {label: 'ElSFReco', asymerror: {plus: 0.05, minus: -0.06}} + - {label: 'ElSFId', asymerror: {plus: 0.16, minus: -0.16}} + - {label: 'ElSFTrigger', asymerror: {plus: 0.07, minus: -0.08}} + - {label: 'ElSFIso', asymerror: {plus: 0.03, minus: -0.03}} + - {label: 'ElSFChargeMisID', asymerror: {plus: 0.0002, minus: 0.001}} + - {label: 'METScale', asymerror: {plus: -0.09, minus: 0.10}} + - {label: 'METResLong', symerror: -0.08} + - {label: 'METResTrans', symerror: -0.08} + - {label: 'PileupWeight', asymerror: {plus: 0.02, minus: -0.03}} + - {label: 'QCDlowRange', asymerror: {plus: -0.01, minus: 0.02}} + - {label: 'QCDhighRange', asymerror: {plus: 0.004, minus: -0.002}} + - {label: 'QCDvarIso', symerror: -0.05} + - {label: 'QCDvarElID', symerror: -0.05} + - {label: 'QCDfitUncert', symerror: 0.01} + - {label: 'QCDotherGen', symerror: 0.01} + - {label: 'QCDfitRebin', symerror: 0.001} + - {label: 'XsecZ', asymerror: {plus: -0.001, minus: 0.001}} + - {label: 'XsecTop', asymerror: {plus: 0.07, minus: -0.07}} + - {label: 'XsecDibos', asymerror: {plus: 0.01, minus: -0.01}} + - {label: 'BkgTtbarNorm', symerror: -0.07} + - {label: 'BkgMCstat', symerror: -0.06} + - {label: 'WHFmodel', symerror: 0.08} + - {label: 'LumiUncert', asymerror: {plus: 0.27, minus: -0.28}} + - {label: 'UnfoldMCstat', symerror: -0.13} + - {label: 'UnfoldOtherGen', symerror: 0.35} + - {label: 'UnfoldReweight', symerror: -0.03} + value: 12.6 + - errors: + - {label: 'Stat', symerror: 0.082} + - {label: 'JetScaleEff1', asymerror: {plus: 0.139, minus: -0.164}} + - {label: 'JetScaleEff2', asymerror: {plus: 0.095, minus: -0.096}} + - {label: 'JetScaleEff3', asymerror: {plus: -0.039, minus: 0.046}} + - {label: 'JetScaleEff4', asymerror: {plus: 0.018, minus: -0.019}} + - {label: 'JetScaleEff5', asymerror: {plus: -0.009, minus: -0.021}} + - {label: 'JetScaleEff6', asymerror: {plus: 0.017, minus: -0.018}} + - {label: 'JetScaleEta1', asymerror: {plus: 0.049, minus: -0.050}} + - {label: 'JetScaleEta2', asymerror: {plus: 0.039, minus: -0.037}} + - {label: 'JetScaleHighPt', asymerror: {plus: 0.0004, minus: 0.001}} + - {label: 'JetScaleMC', asymerror: {plus: 0.001, minus: 0.001}} + - {label: 'JetScalePileup1', asymerror: {plus: 0.006, minus: -0.004}} + - {label: 'JetScalePileup2', asymerror: {plus: -0.011, minus: 0.011}} + - {label: 'JetScalePileup3', asymerror: {plus: 0.021, minus: -0.020}} + - {label: 'JetScalePileup4', asymerror: {plus: 0.065, minus: -0.062}} + - {label: 'JetScaleFlav1Known', asymerror: {plus: 0.022, minus: -0.025}} + - {label: 'JetScaleFlav2', asymerror: {plus: -0.120, minus: 0.110}} + - {label: 'JetScaleBjet', asymerror: {plus: 0.001, minus: 0.001}} + - {label: 'JetScalepunchT', asymerror: {plus: 0.0004, minus: 0.001}} + - {label: 'JetResolution10', symerror: 0.067} + - {label: 'JetSFBeff', asymerror: {plus: -0.059, minus: 0.059}} + - {label: 'JetSFCeff', asymerror: {plus: -0.015, minus: 0.013}} + - {label: 'JetSFLmistag', asymerror: {plus: -0.013, minus: 0.010}} + - {label: 'JetSFHighPt', asymerror: {plus: 0.001, minus: 0.001}} + - {label: 'JetJVFcut', asymerror: {plus: -0.030, minus: -0.030}} + - {label: 'ElScaleR12', asymerror: {plus: 0.017, minus: -0.016}} + - {label: 'ElScaleZee', asymerror: {plus: 0.024, minus: -0.023}} + - {label: 'ElScalePS', asymerror: {plus: -0.001, minus: 0.001}} + - {label: 'ElResolution', symerror: -0.004} + - {label: 'ElSFReco', asymerror: {plus: 0.023, minus: -0.026}} + - {label: 'ElSFId', asymerror: {plus: 0.067, minus: -0.067}} + - {label: 'ElSFTrigger', asymerror: {plus: 0.032, minus: -0.033}} + - {label: 'ElSFIso', asymerror: {plus: 0.013, minus: -0.015}} + - {label: 'ElSFChargeMisID', asymerror: {plus: 0.0001, minus: 0.0002}} + - {label: 'METScale', asymerror: {plus: -0.038, minus: 0.043}} + - {label: 'METResLong', symerror: -0.033} + - {label: 'METResTrans', symerror: -0.033} + - {label: 'PileupWeight', asymerror: {plus: 0.011, minus: -0.012}} + - {label: 'QCDlowRange', asymerror: {plus: -0.004, minus: 0.008}} + - {label: 'QCDhighRange', asymerror: {plus: 0.001, minus: -0.0001}} + - {label: 'QCDvarIso', symerror: -0.022} + - {label: 'QCDvarElID', symerror: -0.022} + - {label: 'QCDfitUncert', symerror: 0.005} + - {label: 'QCDotherGen', symerror: 0.004} + - {label: 'QCDfitRebin', symerror: 0.001} + - {label: 'XsecZ', asymerror: {plus: 0.0001, minus: -0.0001}} + - {label: 'XsecTop', asymerror: {plus: 0.027, minus: -0.027}} + - {label: 'XsecDibos', asymerror: {plus: 0.005, minus: -0.005}} + - {label: 'BkgTtbarNorm', symerror: -0.026} + - {label: 'BkgMCstat', symerror: -0.030} + - {label: 'WHFmodel', symerror: 0.017} + - {label: 'LumiUncert', asymerror: {plus: 0.115, minus: -0.120}} + - {label: 'UnfoldMCstat', symerror: -0.083} + - {label: 'UnfoldOtherGen', symerror: 0.148} + - {label: 'UnfoldReweight', symerror: -0.015} + value: 5.403 + - errors: + - {label: 'Stat', symerror: 0.055} + - {label: 'JetScaleEff1', asymerror: {plus: 0.074, minus: -0.067}} + - {label: 'JetScaleEff2', asymerror: {plus: 0.045, minus: -0.066}} + - {label: 'JetScaleEff3', asymerror: {plus: -0.018, minus: 0.022}} + - {label: 'JetScaleEff4', asymerror: {plus: 0.008, minus: -0.009}} + - {label: 'JetScaleEff5', asymerror: {plus: -0.004, minus: -0.010}} + - {label: 'JetScaleEff6', asymerror: {plus: 0.008, minus: -0.009}} + - {label: 'JetScaleEta1', asymerror: {plus: 0.023, minus: -0.024}} + - {label: 'JetScaleEta2', asymerror: {plus: 0.019, minus: -0.018}} + - {label: 'JetScaleHighPt', asymerror: {plus: 0.0002, minus: 0.0002}} + - {label: 'JetScaleMC', asymerror: {plus: 0.0003, minus: 0.0003}} + - {label: 'JetScalePileup1', asymerror: {plus: 0.003, minus: -0.002}} + - {label: 'JetScalePileup2', asymerror: {plus: -0.005, minus: 0.005}} + - {label: 'JetScalePileup3', asymerror: {plus: 0.010, minus: -0.009}} + - {label: 'JetScalePileup4', asymerror: {plus: 0.031, minus: -0.029}} + - {label: 'JetScaleFlav1Known', asymerror: {plus: 0.010, minus: -0.012}} + - {label: 'JetScaleFlav2', asymerror: {plus: -0.057, minus: 0.052}} + - {label: 'JetScaleBjet', asymerror: {plus: 0.0003, minus: 0.0002}} + - {label: 'JetScalepunchT', asymerror: {plus: 0.0002, minus: 0.0003}} + - {label: 'JetResolution10', symerror: 0.031} + - {label: 'JetSFBeff', asymerror: {plus: -0.028, minus: 0.028}} + - {label: 'JetSFCeff', asymerror: {plus: -0.007, minus: 0.006}} + - {label: 'JetSFLmistag', asymerror: {plus: -0.006, minus: 0.005}} + - {label: 'JetSFHighPt', asymerror: {plus: 0.0002, minus: 0.0003}} + - {label: 'JetJVFcut', asymerror: {plus: -0.014, minus: -0.014}} + - {label: 'ElScaleR12', asymerror: {plus: 0.008, minus: -0.007}} + - {label: 'ElScaleZee', asymerror: {plus: 0.011, minus: -0.011}} + - {label: 'ElScalePS', asymerror: {plus: -0.001, minus: 0.001}} + - {label: 'ElResolution', symerror: -0.002} + - {label: 'ElSFReco', asymerror: {plus: 0.011, minus: -0.012}} + - {label: 'ElSFId', asymerror: {plus: 0.032, minus: -0.031}} + - {label: 'ElSFTrigger', asymerror: {plus: 0.015, minus: -0.016}} + - {label: 'ElSFIso', asymerror: {plus: 0.006, minus: -0.007}} + - {label: 'ElSFChargeMisID', asymerror: {plus: 0.00004, minus: 0.0001}} + - {label: 'METScale', asymerror: {plus: -0.018, minus: 0.020}} + - {label: 'METResLong', symerror: -0.016} + - {label: 'METResTrans', symerror: -0.016} + - {label: 'PileupWeight', asymerror: {plus: 0.005, minus: -0.006}} + - {label: 'QCDlowRange', asymerror: {plus: -0.002, minus: 0.004}} + - {label: 'QCDhighRange', asymerror: {plus: 0.001, minus: -0.0002}} + - {label: 'QCDvarIso', symerror: -0.010} + - {label: 'QCDvarElID', symerror: -0.010} + - {label: 'QCDfitUncert', symerror: 0.002} + - {label: 'QCDotherGen', symerror: 0.002} + - {label: 'QCDfitRebin', symerror: 0.0002} + - {label: 'XsecZ', asymerror: {plus: 0.0002, minus: -0.0002}} + - {label: 'XsecTop', asymerror: {plus: 0.011, minus: -0.011}} + - {label: 'XsecDibos', asymerror: {plus: 0.002, minus: -0.002}} + - {label: 'BkgTtbarNorm', symerror: -0.011} + - {label: 'BkgMCstat', symerror: -0.020} + - {label: 'WHFmodel', symerror: 0.012} + - {label: 'LumiUncert', asymerror: {plus: 0.054, minus: -0.056}} + - {label: 'UnfoldMCstat', symerror: -0.058} + - {label: 'UnfoldOtherGen', symerror: 0.070} + - {label: 'UnfoldReweight', symerror: -0.007} + value: 2.55 + - errors: + - {label: 'Stat', symerror: 0.037} + - {label: 'JetScaleEff1', asymerror: {plus: 0.036, minus: -0.033}} + - {label: 'JetScaleEff2', asymerror: {plus: 0.042, minus: -0.033}} + - {label: 'JetScaleEff3', asymerror: {plus: -0.009, minus: 0.011}} + - {label: 'JetScaleEff4', asymerror: {plus: 0.004, minus: -0.004}} + - {label: 'JetScaleEff5', asymerror: {plus: -0.002, minus: -0.005}} + - {label: 'JetScaleEff6', asymerror: {plus: 0.004, minus: -0.004}} + - {label: 'JetScaleEta1', asymerror: {plus: 0.011, minus: -0.012}} + - {label: 'JetScaleEta2', asymerror: {plus: 0.009, minus: -0.009}} + - {label: 'JetScaleHighPt', asymerror: {plus: 0.0001, minus: 0.0001}} + - {label: 'JetScaleMC', asymerror: {plus: 0.0002, minus: 0.0001}} + - {label: 'JetScalePileup1', asymerror: {plus: 0.001, minus: -0.001}} + - {label: 'JetScalePileup2', asymerror: {plus: -0.003, minus: 0.003}} + - {label: 'JetScalePileup3', asymerror: {plus: 0.005, minus: -0.005}} + - {label: 'JetScalePileup4', asymerror: {plus: 0.015, minus: -0.014}} + - {label: 'JetScaleFlav1Known', asymerror: {plus: 0.005, minus: -0.006}} + - {label: 'JetScaleFlav2', asymerror: {plus: -0.028, minus: 0.025}} + - {label: 'JetScaleBjet', asymerror: {plus: 0.0002, minus: 0.0001}} + - {label: 'JetScalepunchT', asymerror: {plus: 0.0001, minus: 0.0001}} + - {label: 'JetResolution10', symerror: 0.015} + - {label: 'JetSFBeff', asymerror: {plus: -0.014, minus: 0.014}} + - {label: 'JetSFCeff', asymerror: {plus: -0.004, minus: 0.003}} + - {label: 'JetSFLmistag', asymerror: {plus: -0.003, minus: 0.002}} + - {label: 'JetSFHighPt', asymerror: {plus: 0.0001, minus: 0.0001}} + - {label: 'JetJVFcut', asymerror: {plus: -0.007, minus: -0.007}} + - {label: 'ElScaleR12', asymerror: {plus: 0.004, minus: -0.004}} + - {label: 'ElScaleZee', asymerror: {plus: 0.006, minus: -0.005}} + - {label: 'ElScalePS', asymerror: {plus: -0.0002, minus: 0.0003}} + - {label: 'ElResolution', symerror: -0.001} + - {label: 'ElSFReco', asymerror: {plus: 0.005, minus: -0.006}} + - {label: 'ElSFId', asymerror: {plus: 0.015, minus: -0.015}} + - {label: 'ElSFTrigger', asymerror: {plus: 0.007, minus: -0.008}} + - {label: 'ElSFIso', asymerror: {plus: 0.003, minus: -0.003}} + - {label: 'ElSFChargeMisID', asymerror: {plus: 0.00002, minus: 0.00005}} + - {label: 'METScale', asymerror: {plus: -0.009, minus: 0.010}} + - {label: 'METResLong', symerror: -0.008} + - {label: 'METResTrans', symerror: -0.008} + - {label: 'PileupWeight', asymerror: {plus: 0.002, minus: -0.003}} + - {label: 'QCDlowRange', asymerror: {plus: -0.001, minus: 0.002}} + - {label: 'QCDhighRange', asymerror: {plus: 0.0004, minus: -0.0002}} + - {label: 'QCDvarIso', symerror: -0.005} + - {label: 'QCDvarElID', symerror: -0.005} + - {label: 'QCDfitUncert', symerror: 0.001} + - {label: 'QCDotherGen', symerror: 0.0003} + - {label: 'QCDfitRebin', symerror: -0.000004} + - {label: 'XsecZ', asymerror: {plus: 0.001, minus: -0.001}} + - {label: 'XsecTop', asymerror: {plus: 0.005, minus: -0.005}} + - {label: 'XsecDibos', asymerror: {plus: 0.001, minus: -0.001}} + - {label: 'BkgTtbarNorm', symerror: -0.005} + - {label: 'BkgMCstat', symerror: -0.016} + - {label: 'WHFmodel', symerror: 0.014} + - {label: 'LumiUncert', asymerror: {plus: 0.027, minus: -0.028}} + - {label: 'UnfoldMCstat', symerror: -0.040} + - {label: 'UnfoldOtherGen', symerror: -0.127} + - {label: 'UnfoldReweight', symerror: -0.003} + value: 1.249 + - errors: + - {label: 'Stat', symerror: 0.0280} + - {label: 'JetScaleEff1', asymerror: {plus: 0.0201, minus: -0.0182}} + - {label: 'JetScaleEff2', asymerror: {plus: 0.0232, minus: -0.0181}} + - {label: 'JetScaleEff3', asymerror: {plus: -0.0050, minus: 0.0059}} + - {label: 'JetScaleEff4', asymerror: {plus: 0.0023, minus: -0.0025}} + - {label: 'JetScaleEff5', asymerror: {plus: -0.0011, minus: -0.0027}} + - {label: 'JetScaleEff6', asymerror: {plus: 0.0022, minus: -0.0023}} + - {label: 'JetScaleEta1', asymerror: {plus: 0.0063, minus: -0.0065}} + - {label: 'JetScaleEta2', asymerror: {plus: 0.0051, minus: -0.0048}} + - {label: 'JetScaleHighPt', asymerror: {plus: 0.0001, minus: 0.0001}} + - {label: 'JetScaleMC', asymerror: {plus: 0.0001, minus: 0.0001}} + - {label: 'JetScalePileup1', asymerror: {plus: 0.0008, minus: -0.0005}} + - {label: 'JetScalePileup2', asymerror: {plus: -0.0015, minus: 0.0014}} + - {label: 'JetScalePileup3', asymerror: {plus: 0.0027, minus: -0.0026}} + - {label: 'JetScalePileup4', asymerror: {plus: 0.0083, minus: -0.0080}} + - {label: 'JetScaleFlav1Known', asymerror: {plus: 0.0028, minus: -0.0032}} + - {label: 'JetScaleFlav2', asymerror: {plus: -0.0155, minus: 0.0142}} + - {label: 'JetScaleBjet', asymerror: {plus: 0.0001, minus: 0.0001}} + - {label: 'JetScalepunchT', asymerror: {plus: 0.0001, minus: 0.0001}} + - {label: 'JetResolution10', symerror: 0.0086} + - {label: 'JetSFBeff', asymerror: {plus: -0.0076, minus: 0.0077}} + - {label: 'JetSFCeff', asymerror: {plus: -0.0020, minus: 0.0017}} + - {label: 'JetSFLmistag', asymerror: {plus: -0.0017, minus: 0.0013}} + - {label: 'JetSFHighPt', asymerror: {plus: 0.0001, minus: 0.0001}} + - {label: 'JetJVFcut', asymerror: {plus: -0.0039, minus: -0.0038}} + - {label: 'ElScaleR12', asymerror: {plus: 0.0022, minus: -0.0020}} + - {label: 'ElScaleZee', asymerror: {plus: 0.0031, minus: -0.0030}} + - {label: 'ElScalePS', asymerror: {plus: -0.0001, minus: 0.0001}} + - {label: 'ElResolution', symerror: -0.0006} + - {label: 'ElSFReco', asymerror: {plus: 0.0030, minus: -0.0033}} + - {label: 'ElSFId', asymerror: {plus: 0.0086, minus: -0.0086}} + - {label: 'ElSFTrigger', asymerror: {plus: 0.0041, minus: -0.0042}} + - {label: 'ElSFIso', asymerror: {plus: 0.0017, minus: -0.0019}} + - {label: 'ElSFChargeMisID', asymerror: {plus: 0.00001, minus: 0.00003}} + - {label: 'METScale', asymerror: {plus: -0.0049, minus: 0.0055}} + - {label: 'METResLong', symerror: -0.0043} + - {label: 'METResTrans', symerror: -0.0043} + - {label: 'PileupWeight', asymerror: {plus: 0.0014, minus: -0.0015}} + - {label: 'QCDlowRange', asymerror: {plus: -0.0001, minus: 0.0004}} + - {label: 'QCDhighRange', asymerror: {plus: 0.0001, minus: -0.0001}} + - {label: 'QCDvarIso', symerror: -0.0028} + - {label: 'QCDvarElID', symerror: -0.0028} + - {label: 'QCDfitUncert', symerror: 0.0001} + - {label: 'QCDotherGen', symerror: 0.0001} + - {label: 'QCDfitRebin', symerror: -0.00003} + - {label: 'XsecZ', asymerror: {plus: 0.0001, minus: -0.0001}} + - {label: 'XsecTop', asymerror: {plus: 0.0026, minus: -0.0026}} + - {label: 'XsecDibos', asymerror: {plus: 0.0006, minus: -0.0006}} + - {label: 'BkgTtbarNorm', symerror: -0.0024} + - {label: 'BkgMCstat', symerror: -0.0073} + - {label: 'WHFmodel', symerror: 0.0063} + - {label: 'LumiUncert', asymerror: {plus: 0.0146, minus: -0.0152}} + - {label: 'UnfoldMCstat', symerror: -0.0321} + - {label: 'UnfoldOtherGen', symerror: 0.0821} + - {label: 'UnfoldReweight', symerror: -0.0019} + value: 0.696 + - errors: + - {label: 'Stat', symerror: 0.0151} + - {label: 'JetScaleEff1', asymerror: {plus: 0.0087, minus: -0.0079}} + - {label: 'JetScaleEff2', asymerror: {plus: 0.0100, minus: -0.0078}} + - {label: 'JetScaleEff3', asymerror: {plus: -0.0022, minus: 0.0026}} + - {label: 'JetScaleEff4', asymerror: {plus: 0.0010, minus: -0.0011}} + - {label: 'JetScaleEff5', asymerror: {plus: -0.0005, minus: -0.0012}} + - {label: 'JetScaleEff6', asymerror: {plus: 0.0010, minus: -0.0010}} + - {label: 'JetScaleEta1', asymerror: {plus: 0.0027, minus: -0.0028}} + - {label: 'JetScaleEta2', asymerror: {plus: 0.0022, minus: -0.0021}} + - {label: 'JetScaleHighPt', asymerror: {plus: 0.00002, minus: 0.00003}} + - {label: 'JetScaleMC', asymerror: {plus: 0.00004, minus: 0.00003}} + - {label: 'JetScalePileup1', asymerror: {plus: 0.0003, minus: -0.0002}} + - {label: 'JetScalePileup2', asymerror: {plus: -0.0006, minus: 0.0006}} + - {label: 'JetScalePileup3', asymerror: {plus: 0.0012, minus: -0.0011}} + - {label: 'JetScalePileup4', asymerror: {plus: 0.0036, minus: -0.0035}} + - {label: 'JetScaleFlav1Known', asymerror: {plus: 0.0012, minus: -0.0014}} + - {label: 'JetScaleFlav2', asymerror: {plus: -0.0067, minus: 0.0061}} + - {label: 'JetScaleBjet', asymerror: {plus: 0.00004, minus: 0.00003}} + - {label: 'JetScalepunchT', asymerror: {plus: 0.00002, minus: 0.00003}} + - {label: 'JetResolution10', symerror: 0.0037} + - {label: 'JetSFBeff', asymerror: {plus: -0.0033, minus: 0.0033}} + - {label: 'JetSFCeff', asymerror: {plus: -0.0009, minus: 0.0007}} + - {label: 'JetSFLmistag', asymerror: {plus: -0.0007, minus: 0.0005}} + - {label: 'JetSFHighPt', asymerror: {plus: 0.00003, minus: 0.00003}} + - {label: 'JetJVFcut', asymerror: {plus: -0.0017, minus: -0.0017}} + - {label: 'ElScaleR12', asymerror: {plus: 0.0009, minus: -0.0009}} + - {label: 'ElScaleZee', asymerror: {plus: 0.0013, minus: -0.0013}} + - {label: 'ElScalePS', asymerror: {plus: -0.0001, minus: 0.0001}} + - {label: 'ElResolution', symerror: -0.0002} + - {label: 'ElSFReco', asymerror: {plus: 0.0013, minus: -0.0014}} + - {label: 'ElSFId', asymerror: {plus: 0.0037, minus: -0.0037}} + - {label: 'ElSFTrigger', asymerror: {plus: 0.0018, minus: -0.0018}} + - {label: 'ElSFIso', asymerror: {plus: 0.0007, minus: -0.0008}} + - {label: 'ElSFChargeMisID', asymerror: {plus: 0.000004, minus: 0.00001}} + - {label: 'METScale', asymerror: {plus: -0.0021, minus: 0.0024}} + - {label: 'METResLong', symerror: -0.0019} + - {label: 'METResTrans', symerror: -0.0019} + - {label: 'PileupWeight', asymerror: {plus: 0.0006, minus: -0.0007}} + - {label: 'QCDlowRange', asymerror: {plus: -0.0001, minus: 0.0003}} + - {label: 'QCDhighRange', asymerror: {plus: 0.0001, minus: -0.00002}} + - {label: 'QCDvarIso', symerror: -0.0012} + - {label: 'QCDvarElID', symerror: -0.0012} + - {label: 'QCDfitUncert', symerror: 0.0001} + - {label: 'QCDotherGen', symerror: 0.0001} + - {label: 'QCDfitRebin', symerror: 0.00001} + - {label: 'XsecZ', asymerror: {plus: -0.00004, minus: 0.00004}} + - {label: 'XsecTop', asymerror: {plus: 0.0013, minus: -0.0013}} + - {label: 'XsecDibos', asymerror: {plus: 0.0003, minus: -0.0003}} + - {label: 'BkgTtbarNorm', symerror: -0.0009} + - {label: 'BkgMCstat', symerror: -0.0065} + - {label: 'WHFmodel', symerror: 0.0036} + - {label: 'LumiUncert', asymerror: {plus: 0.0066, minus: -0.0069}} + - {label: 'UnfoldMCstat', symerror: -0.0147} + - {label: 'UnfoldOtherGen', symerror: 0.0465} + - {label: 'UnfoldReweight', symerror: -0.0008} + value: 0.3016 + - errors: + - {label: 'Stat', symerror: 0.00597} + - {label: 'JetScaleEff1', asymerror: {plus: 0.00224, minus: -0.00203}} + - {label: 'JetScaleEff2', asymerror: {plus: 0.00258, minus: -0.00201}} + - {label: 'JetScaleEff3', asymerror: {plus: -0.00055, minus: 0.00066}} + - {label: 'JetScaleEff4', asymerror: {plus: 0.00025, minus: -0.00027}} + - {label: 'JetScaleEff5', asymerror: {plus: -0.00012, minus: -0.00030}} + - {label: 'JetScaleEff6', asymerror: {plus: 0.00025, minus: -0.00026}} + - {label: 'JetScaleEta1', asymerror: {plus: 0.00070, minus: -0.00072}} + - {label: 'JetScaleEta2', asymerror: {plus: 0.00056, minus: -0.00053}} + - {label: 'JetScaleHighPt', asymerror: {plus: 0.00001, minus: 0.00001}} + - {label: 'JetScaleMC', asymerror: {plus: 0.00001, minus: 0.00001}} + - {label: 'JetScalePileup1', asymerror: {plus: 0.00009, minus: -0.00005}} + - {label: 'JetScalePileup2', asymerror: {plus: -0.00016, minus: 0.00016}} + - {label: 'JetScalePileup3', asymerror: {plus: 0.00030, minus: -0.00029}} + - {label: 'JetScalePileup4', asymerror: {plus: 0.00093, minus: -0.00089}} + - {label: 'JetScaleFlav1Known', asymerror: {plus: 0.00032, minus: -0.00036}} + - {label: 'JetScaleFlav2', asymerror: {plus: -0.00172, minus: 0.00157}} + - {label: 'JetScaleBjet', asymerror: {plus: 0.00001, minus: 0.00001}} + - {label: 'JetScalepunchT', asymerror: {plus: 0.00001, minus: 0.00001}} + - {label: 'JetResolution10', symerror: 0.00095} + - {label: 'JetSFBeff', asymerror: {plus: -0.00085, minus: 0.00085}} + - {label: 'JetSFCeff', asymerror: {plus: -0.00022, minus: 0.00019}} + - {label: 'JetSFLmistag', asymerror: {plus: -0.00019, minus: 0.00014}} + - {label: 'JetSFHighPt', asymerror: {plus: 0.00001, minus: 0.00001}} + - {label: 'JetJVFcut', asymerror: {plus: -0.00043, minus: -0.00042}} + - {label: 'ElScaleR12', asymerror: {plus: 0.00024, minus: -0.00023}} + - {label: 'ElScaleZee', asymerror: {plus: 0.00034, minus: -0.00033}} + - {label: 'ElScalePS', asymerror: {plus: -0.00002, minus: 0.00002}} + - {label: 'ElResolution', symerror: -0.00006} + - {label: 'ElSFReco', asymerror: {plus: 0.00034, minus: -0.00037}} + - {label: 'ElSFId', asymerror: {plus: 0.00096, minus: -0.00095}} + - {label: 'ElSFTrigger', asymerror: {plus: 0.00046, minus: -0.00047}} + - {label: 'ElSFIso', asymerror: {plus: 0.00019, minus: -0.00021}} + - {label: 'ElSFChargeMisID', asymerror: {plus: 0.000001, minus: 0.000003}} + - {label: 'METScale', asymerror: {plus: -0.00055, minus: 0.00061}} + - {label: 'METResLong', symerror: -0.00048} + - {label: 'METResTrans', symerror: -0.00048} + - {label: 'PileupWeight', asymerror: {plus: 0.00015, minus: -0.00017}} + - {label: 'QCDlowRange', asymerror: {plus: -0.00003, minus: 0.00006}} + - {label: 'QCDhighRange', asymerror: {plus: 0.00002, minus: -0.00001}} + - {label: 'QCDvarIso', symerror: -0.00032} + - {label: 'QCDvarElID', symerror: -0.00031} + - {label: 'QCDfitUncert', symerror: 0.00004} + - {label: 'QCDotherGen', symerror: 0.00006} + - {label: 'QCDfitRebin', symerror: -0.000004} + - {label: 'XsecZ', asymerror: {plus: -0.00003, minus: 0.00003}} + - {label: 'XsecTop', asymerror: {plus: 0.00027, minus: -0.00027}} + - {label: 'XsecDibos', asymerror: {plus: 0.00008, minus: -0.00008}} + - {label: 'BkgTtbarNorm', symerror: -0.00020} + - {label: 'BkgMCstat', symerror: -0.00184} + - {label: 'WHFmodel', symerror: 0.00085} + - {label: 'LumiUncert', asymerror: {plus: 0.00161, minus: -0.00167}} + - {label: 'UnfoldMCstat', symerror: -0.00652} + - {label: 'UnfoldOtherGen', symerror: 0.01194} + - {label: 'UnfoldReweight', symerror: -0.00021} + value: 0.0774 +- header: {name: '$d\sigma^{W^-}/dp_\text{T}^\text{W}\text{ [fb/GeV]}$'} + qualifiers: + - {name: 'Cross section', value: 'W- (electron channel)'} + - {name: 'ABS(ETARAP(ELECTRON))', value: '< 2.5'} + - {name: 'ABS(YRAP(JET))', value: '< 4.4'} + - {name: 'PT(JET)', units: 'GEV', value: '> 30'} + - {name: 'PT(LEPTON)', units: 'GEV', value: '> 25'} + - {name: 'RE', value: 'P P --> W JET(S) X'} + - {name: 'SQRT(S)', units: 'GEV', value: '8000.0'} + values: + - errors: + - {label: 'Stat', symerror: 1} + - {label: 'JetScaleEff1', asymerror: {plus: 96, minus: -94}} + - {label: 'JetScaleEff2', asymerror: {plus: -21, minus: 22}} + - {label: 'JetScaleEff3', asymerror: {plus: 3, minus: -3}} + - {label: 'JetScaleEff4', asymerror: {plus: 1, minus: -1}} + - {label: 'JetScaleEff5', asymerror: {plus: -3, minus: 3}} + - {label: 'JetScaleEff6', asymerror: {plus: 6, minus: -6}} + - {label: 'JetScaleEta1', asymerror: {plus: 49, minus: -48}} + - {label: 'JetScaleEta2', asymerror: {plus: 25, minus: -24}} + - {label: 'JetScaleHighPt', asymerror: {plus: -0.2, minus: -0.2}} + - {label: 'JetScaleMC', asymerror: {plus: -0.3, minus: -0.3}} + - {label: 'JetScalePileup1', asymerror: {plus: 5, minus: -1}} + - {label: 'JetScalePileup2', asymerror: {plus: -11, minus: 12}} + - {label: 'JetScalePileup3', asymerror: {plus: 3, minus: -2}} + - {label: 'JetScalePileup4', asymerror: {plus: 63, minus: -62}} + - {label: 'JetScaleFlav1Known', asymerror: {plus: 20, minus: -18}} + - {label: 'JetScaleFlav2', asymerror: {plus: -76, minus: 79}} + - {label: 'JetScaleBjet', asymerror: {plus: 0.1, minus: 0.03}} + - {label: 'JetScalepunchT', asymerror: {plus: 0.1, minus: 0.1}} + - {label: 'JetResolution10', symerror: 171} + - {label: 'JetSFBeff', asymerror: {plus: -6, minus: 6}} + - {label: 'JetSFCeff', asymerror: {plus: -4, minus: 3}} + - {label: 'JetSFLmistag', asymerror: {plus: -3, minus: 3}} + - {label: 'JetSFHighPt', asymerror: {plus: -0.2, minus: -0.1}} + - {label: 'JetJVFcut', asymerror: {plus: -18, minus: 9}} + - {label: 'ElScaleR12', asymerror: {plus: -1, minus: 1}} + - {label: 'ElScaleZee', asymerror: {plus: 16, minus: -17}} + - {label: 'ElScalePS', asymerror: {plus: -0.4, minus: 0.3}} + - {label: 'ElResolution', symerror: -1} + - {label: 'ElSFReco', asymerror: {plus: 3, minus: -3}} + - {label: 'ElSFId', asymerror: {plus: 11, minus: -11}} + - {label: 'ElSFTrigger', asymerror: {plus: 9, minus: -9}} + - {label: 'ElSFIso', asymerror: {plus: 3, minus: -3}} + - {label: 'ElSFChargeMisID', asymerror: {plus: -0.03, minus: -0.1}} + - {label: 'METScale', asymerror: {plus: -8, minus: 12}} + - {label: 'METResLong', symerror: 4} + - {label: 'METResTrans', symerror: -4} + - {label: 'PileupWeight', asymerror: {plus: 15, minus: -14}} + - {label: 'QCDlowRange', asymerror: {plus: -7, minus: 28}} + - {label: 'QCDhighRange', asymerror: {plus: 2, minus: -4}} + - {label: 'QCDvarIso', symerror: 6} + - {label: 'QCDvarElID', symerror: 52} + - {label: 'QCDfitUncert', symerror: 5} + - {label: 'QCDotherGen', symerror: 37} + - {label: 'QCDfitRebin', symerror: -0.5} + - {label: 'XsecZ', asymerror: {plus: -6, minus: 6}} + - {label: 'XsecTop', asymerror: {plus: 3, minus: -3}} + - {label: 'XsecDibos', asymerror: {plus: 1, minus: -1}} + - {label: 'BkgTtbarNorm', symerror: -2} + - {label: 'BkgMCstat', symerror: -2} + - {label: 'WHFmodel', symerror: -4} + - {label: 'LumiUncert', asymerror: {plus: 33, minus: -35}} + - {label: 'UnfoldMCstat', symerror: -4} + - {label: 'UnfoldOtherGen', symerror: 29} + - {label: 'UnfoldReweight', symerror: 51} + value: 1618.0 + - errors: + - {label: 'Stat', symerror: 1} + - {label: 'JetScaleEff1', asymerror: {plus: 203, minus: -204}} + - {label: 'JetScaleEff2', asymerror: {plus: -49, minus: 47}} + - {label: 'JetScaleEff3', asymerror: {plus: 5, minus: -7}} + - {label: 'JetScaleEff4', asymerror: {plus: 2, minus: -4}} + - {label: 'JetScaleEff5', asymerror: {plus: -9, minus: 7}} + - {label: 'JetScaleEff6', asymerror: {plus: 11, minus: -13}} + - {label: 'JetScaleEta1', asymerror: {plus: 100, minus: -98}} + - {label: 'JetScaleEta2', asymerror: {plus: 49, minus: -52}} + - {label: 'JetScaleHighPt', asymerror: {plus: -1, minus: -1}} + - {label: 'JetScaleMC', asymerror: {plus: -1, minus: -1}} + - {label: 'JetScalePileup1', asymerror: {plus: 9, minus: -2}} + - {label: 'JetScalePileup2', asymerror: {plus: -21, minus: 24}} + - {label: 'JetScalePileup3', asymerror: {plus: 5, minus: -5}} + - {label: 'JetScalePileup4', asymerror: {plus: 134, minus: -132}} + - {label: 'JetScaleFlav1Known', asymerror: {plus: 41, minus: -40}} + - {label: 'JetScaleFlav2', asymerror: {plus: -161, minus: 164}} + - {label: 'JetScaleBjet', asymerror: {plus: 0.2, minus: 0.1}} + - {label: 'JetScalepunchT', asymerror: {plus: 0.3, minus: 0.2}} + - {label: 'JetResolution10', symerror: 378} + - {label: 'JetSFBeff', asymerror: {plus: -9, minus: 9}} + - {label: 'JetSFCeff', asymerror: {plus: -8, minus: 7}} + - {label: 'JetSFLmistag', asymerror: {plus: -6, minus: 6}} + - {label: 'JetSFHighPt', asymerror: {plus: -0.4, minus: -0.2}} + - {label: 'JetJVFcut', asymerror: {plus: -39, minus: 19}} + - {label: 'ElScaleR12', asymerror: {plus: 6, minus: -6}} + - {label: 'ElScaleZee', asymerror: {plus: 41, minus: -44}} + - {label: 'ElScalePS', asymerror: {plus: -1, minus: 1}} + - {label: 'ElResolution', symerror: -3} + - {label: 'ElSFReco', asymerror: {plus: 9, minus: -10}} + - {label: 'ElSFId', asymerror: {plus: 29, minus: -31}} + - {label: 'ElSFTrigger', asymerror: {plus: 22, minus: -23}} + - {label: 'ElSFIso', asymerror: {plus: 7, minus: -7}} + - {label: 'ElSFChargeMisID', asymerror: {plus: -0.1, minus: -0.2}} + - {label: 'METScale', asymerror: {plus: -88, minus: 87}} + - {label: 'METResLong', symerror: -86} + - {label: 'METResTrans', symerror: -80} + - {label: 'PileupWeight', asymerror: {plus: 27, minus: -25}} + - {label: 'QCDlowRange', asymerror: {plus: -6, minus: 41}} + - {label: 'QCDhighRange', asymerror: {plus: 2, minus: -5}} + - {label: 'QCDvarIso', symerror: -2} + - {label: 'QCDvarElID', symerror: 34} + - {label: 'QCDfitUncert', symerror: 7} + - {label: 'QCDotherGen', symerror: 48} + - {label: 'QCDfitRebin', symerror: -1} + - {label: 'XsecZ', asymerror: {plus: -4, minus: 4}} + - {label: 'XsecTop', asymerror: {plus: 4, minus: -4}} + - {label: 'XsecDibos', asymerror: {plus: 2, minus: -2}} + - {label: 'BkgTtbarNorm', symerror: -4} + - {label: 'BkgMCstat', symerror: -2} + - {label: 'WHFmodel', symerror: 21} + - {label: 'LumiUncert', asymerror: {plus: 82, minus: -85}} + - {label: 'UnfoldMCstat', symerror: -6} + - {label: 'UnfoldOtherGen', symerror: 306} + - {label: 'UnfoldReweight', symerror: -40} + value: 4037.0 + - errors: + - {label: 'Stat', symerror: 1} + - {label: 'JetScaleEff1', asymerror: {plus: 91, minus: -92}} + - {label: 'JetScaleEff2', asymerror: {plus: -18, minus: 17}} + - {label: 'JetScaleEff3', asymerror: {plus: -2, minus: 2}} + - {label: 'JetScaleEff4', asymerror: {plus: 10, minus: -11}} + - {label: 'JetScaleEff5', asymerror: {plus: -4, minus: 3}} + - {label: 'JetScaleEff6', asymerror: {plus: 5, minus: -5}} + - {label: 'JetScaleEta1', asymerror: {plus: 41, minus: -40}} + - {label: 'JetScaleEta2', asymerror: {plus: 20, minus: -21}} + - {label: 'JetScaleHighPt', asymerror: {plus: -0.3, minus: -0.3}} + - {label: 'JetScaleMC', asymerror: {plus: -0.4, minus: -0.4}} + - {label: 'JetScalePileup1', asymerror: {plus: 3, minus: -1}} + - {label: 'JetScalePileup2', asymerror: {plus: -7, minus: 10}} + - {label: 'JetScalePileup3', asymerror: {plus: 5, minus: -4}} + - {label: 'JetScalePileup4', asymerror: {plus: 56, minus: -56}} + - {label: 'JetScaleFlav1Known', asymerror: {plus: 16, minus: -15}} + - {label: 'JetScaleFlav2', asymerror: {plus: -72, minus: 73}} + - {label: 'JetScaleBjet', asymerror: {plus: 0.1, minus: 0.04}} + - {label: 'JetScalepunchT', asymerror: {plus: 0.2, minus: 0.1}} + - {label: 'JetResolution10', symerror: 170} + - {label: 'JetSFBeff', asymerror: {plus: -7, minus: 7}} + - {label: 'JetSFCeff', asymerror: {plus: -5, minus: 5}} + - {label: 'JetSFLmistag', asymerror: {plus: -3, minus: 4}} + - {label: 'JetSFHighPt', asymerror: {plus: -0.2, minus: -0.1}} + - {label: 'JetJVFcut', asymerror: {plus: -13, minus: 2}} + - {label: 'ElScaleR12', asymerror: {plus: 7, minus: -6}} + - {label: 'ElScaleZee', asymerror: {plus: 20, minus: -21}} + - {label: 'ElScalePS', asymerror: {plus: -1, minus: 0.4}} + - {label: 'ElResolution', symerror: -1} + - {label: 'ElSFReco', asymerror: {plus: 6, minus: -6}} + - {label: 'ElSFId', asymerror: {plus: 17, minus: -17}} + - {label: 'ElSFTrigger', asymerror: {plus: 12, minus: -12}} + - {label: 'ElSFIso', asymerror: {plus: 4, minus: -4}} + - {label: 'ElSFChargeMisID', asymerror: {plus: -0.03, minus: -0.1}} + - {label: 'METScale', asymerror: {plus: -67, minus: 65}} + - {label: 'METResLong', symerror: -61} + - {label: 'METResTrans', symerror: -59} + - {label: 'PileupWeight', asymerror: {plus: 15, minus: -14}} + - {label: 'QCDlowRange', asymerror: {plus: -3, minus: 16}} + - {label: 'QCDhighRange', asymerror: {plus: 1, minus: -2}} + - {label: 'QCDvarIso', symerror: -6} + - {label: 'QCDvarElID', symerror: 3} + - {label: 'QCDfitUncert', symerror: 3} + - {label: 'QCDotherGen', symerror: 21} + - {label: 'QCDfitRebin', symerror: -0.3} + - {label: 'XsecZ', asymerror: {plus: -0.03, minus: 0.02}} + - {label: 'XsecTop', asymerror: {plus: 4, minus: -4}} + - {label: 'XsecDibos', asymerror: {plus: 1, minus: -1}} + - {label: 'BkgTtbarNorm', symerror: -3} + - {label: 'BkgMCstat', symerror: -1} + - {label: 'WHFmodel', symerror: 11} + - {label: 'LumiUncert', asymerror: {plus: 43, minus: -45}} + - {label: 'UnfoldMCstat', symerror: -3} + - {label: 'UnfoldOtherGen', symerror: 31} + - {label: 'UnfoldReweight', symerror: -13} + value: 2096.0 + - errors: + - {label: 'Stat', symerror: 0.7} + - {label: 'JetScaleEff1', asymerror: {plus: 30.2, minus: -30.1}} + - {label: 'JetScaleEff2', asymerror: {plus: -2.5, minus: 1.8}} + - {label: 'JetScaleEff3', asymerror: {plus: -2.5, minus: 2.7}} + - {label: 'JetScaleEff4', asymerror: {plus: 5.9, minus: -5.7}} + - {label: 'JetScaleEff5', asymerror: {plus: -1.5, minus: 1.3}} + - {label: 'JetScaleEff6', asymerror: {plus: 2.4, minus: -2.3}} + - {label: 'JetScaleEta1', asymerror: {plus: 13.0, minus: -12.4}} + - {label: 'JetScaleEta2', asymerror: {plus: 6.7, minus: -6.7}} + - {label: 'JetScaleHighPt', asymerror: {plus: -0.1, minus: -0.1}} + - {label: 'JetScaleMC', asymerror: {plus: -0.2, minus: -0.1}} + - {label: 'JetScalePileup1', asymerror: {plus: 1.3, minus: -0.5}} + - {label: 'JetScalePileup2', asymerror: {plus: -2.0, minus: 2.7}} + - {label: 'JetScalePileup3', asymerror: {plus: 2.5, minus: -2.5}} + - {label: 'JetScalePileup4', asymerror: {plus: 18.1, minus: -18.0}} + - {label: 'JetScaleFlav1Known', asymerror: {plus: 4.5, minus: -4.6}} + - {label: 'JetScaleFlav2', asymerror: {plus: -25.1, minus: 25.4}} + - {label: 'JetScaleBjet', asymerror: {plus: 0.04, minus: 0.02}} + - {label: 'JetScalepunchT', asymerror: {plus: 0.1, minus: 0.04}} + - {label: 'JetResolution10', symerror: 44.8} + - {label: 'JetSFBeff', asymerror: {plus: -4.8, minus: 5.1}} + - {label: 'JetSFCeff', asymerror: {plus: -2.2, minus: 2.4}} + - {label: 'JetSFLmistag', asymerror: {plus: -1.5, minus: 1.7}} + - {label: 'JetSFHighPt', asymerror: {plus: -0.1, minus: -0.03}} + - {label: 'JetJVFcut', asymerror: {plus: -3.1, minus: -2.5}} + - {label: 'ElScaleR12', asymerror: {plus: 3.7, minus: -3.3}} + - {label: 'ElScaleZee', asymerror: {plus: 7.0, minus: -6.6}} + - {label: 'ElScalePS', asymerror: {plus: -0.2, minus: 0.9}} + - {label: 'ElResolution', symerror: -0.6} + - {label: 'ElSFReco', asymerror: {plus: 3.0, minus: -2.9}} + - {label: 'ElSFId', asymerror: {plus: 8.0, minus: -7.9}} + - {label: 'ElSFTrigger', asymerror: {plus: 4.5, minus: -4.3}} + - {label: 'ElSFIso', asymerror: {plus: 1.8, minus: -1.7}} + - {label: 'ElSFChargeMisID', asymerror: {plus: -0.01, minus: -0.04}} + - {label: 'METScale', asymerror: {plus: -23.6, minus: 24.9}} + - {label: 'METResLong', symerror: -19.7} + - {label: 'METResTrans', symerror: -21.1} + - {label: 'PileupWeight', asymerror: {plus: 4.8, minus: -4.4}} + - {label: 'QCDlowRange', asymerror: {plus: -1.5, minus: 4.3}} + - {label: 'QCDhighRange', asymerror: {plus: 0.2, minus: -0.5}} + - {label: 'QCDvarIso', symerror: -2.9} + - {label: 'QCDvarElID', symerror: 1.4} + - {label: 'QCDfitUncert', symerror: 1.1} + - {label: 'QCDotherGen', symerror: 6.5} + - {label: 'QCDfitRebin', symerror: -0.1} + - {label: 'XsecZ', asymerror: {plus: 0.2, minus: -0.2}} + - {label: 'XsecTop', asymerror: {plus: 2.6, minus: -2.6}} + - {label: 'XsecDibos', asymerror: {plus: 0.7, minus: -0.7}} + - {label: 'BkgTtbarNorm', symerror: -2.3} + - {label: 'BkgMCstat', symerror: -0.6} + - {label: 'WHFmodel', symerror: 2.3} + - {label: 'LumiUncert', asymerror: {plus: 17.6, minus: -18.2}} + - {label: 'UnfoldMCstat', symerror: -1.8} + - {label: 'UnfoldOtherGen', symerror: 13.5} + - {label: 'UnfoldReweight', symerror: -1.7} + value: 834.0 + - errors: + - {label: 'Stat', symerror: 0.5} + - {label: 'JetScaleEff1', asymerror: {plus: 11.1, minus: -11.1}} + - {label: 'JetScaleEff2', asymerror: {plus: 0.8, minus: 0.8}} + - {label: 'JetScaleEff3', asymerror: {plus: -1.6, minus: 1.8}} + - {label: 'JetScaleEff4', asymerror: {plus: 2.3, minus: -2.0}} + - {label: 'JetScaleEff5', asymerror: {plus: -0.7, minus: 0.6}} + - {label: 'JetScaleEff6', asymerror: {plus: 1.2, minus: -1.1}} + - {label: 'JetScaleEta1', asymerror: {plus: 4.8, minus: -4.5}} + - {label: 'JetScaleEta2', asymerror: {plus: 2.6, minus: -2.4}} + - {label: 'JetScaleHighPt', asymerror: {plus: -0.05, minus: -0.1}} + - {label: 'JetScaleMC', asymerror: {plus: -0.1, minus: -0.1}} + - {label: 'JetScalePileup1', asymerror: {plus: 0.6, minus: -0.2}} + - {label: 'JetScalePileup2', asymerror: {plus: -0.7, minus: 1.1}} + - {label: 'JetScalePileup3', asymerror: {plus: 1.4, minus: -1.0}} + - {label: 'JetScalePileup4', asymerror: {plus: 6.9, minus: -6.6}} + - {label: 'JetScaleFlav1Known', asymerror: {plus: 1.7, minus: -1.6}} + - {label: 'JetScaleFlav2', asymerror: {plus: -10.2, minus: 10.3}} + - {label: 'JetScaleBjet', asymerror: {plus: 0.02, minus: 0.01}} + - {label: 'JetScalepunchT', asymerror: {plus: 0.03, minus: 0.02}} + - {label: 'JetResolution10', symerror: 12.5} + - {label: 'JetSFBeff', asymerror: {plus: -3.1, minus: 3.4}} + - {label: 'JetSFCeff', asymerror: {plus: -1.0, minus: 1.2}} + - {label: 'JetSFLmistag', asymerror: {plus: -0.7, minus: 0.9}} + - {label: 'JetSFHighPt', asymerror: {plus: -0.03, minus: -0.01}} + - {label: 'JetJVFcut', asymerror: {plus: -1.4, minus: -1.7}} + - {label: 'ElScaleR12', asymerror: {plus: 1.7, minus: -1.3}} + - {label: 'ElScaleZee', asymerror: {plus: 2.5, minus: -2.1}} + - {label: 'ElScalePS', asymerror: {plus: -0.1, minus: 0.4}} + - {label: 'ElResolution', symerror: -0.2} + - {label: 'ElSFReco', asymerror: {plus: 1.7, minus: -1.5}} + - {label: 'ElSFId', asymerror: {plus: 4.1, minus: -4.0}} + - {label: 'ElSFTrigger', asymerror: {plus: 2.1, minus: -1.9}} + - {label: 'ElSFIso', asymerror: {plus: 1.0, minus: -0.8}} + - {label: 'ElSFChargeMisID', asymerror: {plus: -0.01, minus: -0.02}} + - {label: 'METScale', asymerror: {plus: -7.6, minus: 8.1}} + - {label: 'METResLong', symerror: -5.8} + - {label: 'METResTrans', symerror: -6.5} + - {label: 'PileupWeight', asymerror: {plus: 1.2, minus: -0.9}} + - {label: 'QCDlowRange', asymerror: {plus: -0.5, minus: 1.2}} + - {label: 'QCDhighRange', asymerror: {plus: 0.03, minus: -0.1}} + - {label: 'QCDvarIso', symerror: -1.6} + - {label: 'QCDvarElID', symerror: -1.9} + - {label: 'QCDfitUncert', symerror: 0.4} + - {label: 'QCDotherGen', symerror: 2.0} + - {label: 'QCDfitRebin', symerror: -0.02} + - {label: 'XsecZ', asymerror: {plus: 0.1, minus: -0.1}} + - {label: 'XsecTop', asymerror: {plus: 1.7, minus: -1.7}} + - {label: 'XsecDibos', asymerror: {plus: 0.3, minus: -0.3}} + - {label: 'BkgTtbarNorm', symerror: -1.6} + - {label: 'BkgMCstat', symerror: -0.4} + - {label: 'WHFmodel', symerror: -0.2} + - {label: 'LumiUncert', asymerror: {plus: 7.7, minus: -8.0}} + - {label: 'UnfoldMCstat', symerror: -1.1} + - {label: 'UnfoldOtherGen', symerror: 7.6} + - {label: 'UnfoldReweight', symerror: -0.7} + value: 362.3 + - errors: + - {label: 'Stat', symerror: 0.4} + - {label: 'JetScaleEff1', asymerror: {plus: 4.8, minus: -5.1}} + - {label: 'JetScaleEff2', asymerror: {plus: 1.1, minus: -0.9}} + - {label: 'JetScaleEff3', asymerror: {plus: -0.9, minus: 1.1}} + - {label: 'JetScaleEff4', asymerror: {plus: 0.7, minus: -0.6}} + - {label: 'JetScaleEff5', asymerror: {plus: 0.6, minus: 0.3}} + - {label: 'JetScaleEff6', asymerror: {plus: 0.6, minus: -0.5}} + - {label: 'JetScaleEta1', asymerror: {plus: 2.0, minus: -1.9}} + - {label: 'JetScaleEta2', asymerror: {plus: 1.2, minus: -1.1}} + - {label: 'JetScaleHighPt', asymerror: {plus: -0.02, minus: -0.02}} + - {label: 'JetScaleMC', asymerror: {plus: -0.04, minus: -0.03}} + - {label: 'JetScalePileup1', asymerror: {plus: 0.3, minus: -0.1}} + - {label: 'JetScalePileup2', asymerror: {plus: -0.3, minus: 0.5}} + - {label: 'JetScalePileup3', asymerror: {plus: 0.7, minus: -0.7}} + - {label: 'JetScalePileup4', asymerror: {plus: 3.0, minus: -3.0}} + - {label: 'JetScaleFlav1Known', asymerror: {plus: 0.8, minus: -0.7}} + - {label: 'JetScaleFlav2', asymerror: {plus: -5.0, minus: 4.8}} + - {label: 'JetScaleBjet', asymerror: {plus: 0.01, minus: 0.004}} + - {label: 'JetScalepunchT', asymerror: {plus: 0.01, minus: 0.01}} + - {label: 'JetResolution10', symerror: 4.5} + - {label: 'JetSFBeff', asymerror: {plus: -2.0, minus: 2.0}} + - {label: 'JetSFCeff', asymerror: {plus: -0.6, minus: 0.7}} + - {label: 'JetSFLmistag', asymerror: {plus: -0.3, minus: 0.4}} + - {label: 'JetSFHighPt', asymerror: {plus: -0.02, minus: -0.01}} + - {label: 'JetJVFcut', asymerror: {plus: -0.9, minus: -1.0}} + - {label: 'ElScaleR12', asymerror: {plus: 0.7, minus: -0.6}} + - {label: 'ElScaleZee', asymerror: {plus: 0.9, minus: -0.9}} + - {label: 'ElScalePS', asymerror: {plus: -0.04, minus: 0.2}} + - {label: 'ElResolution', symerror: -0.1} + - {label: 'ElSFReco', asymerror: {plus: 0.9, minus: -0.8}} + - {label: 'ElSFId', asymerror: {plus: 2.1, minus: -2.1}} + - {label: 'ElSFTrigger', asymerror: {plus: 1.0, minus: -1.0}} + - {label: 'ElSFIso', asymerror: {plus: 0.5, minus: -0.4}} + - {label: 'ElSFChargeMisID', asymerror: {plus: -0.003, minus: -0.01}} + - {label: 'METScale', asymerror: {plus: -3.0, minus: 3.0}} + - {label: 'METResLong', symerror: -2.5} + - {label: 'METResTrans', symerror: -2.6} + - {label: 'PileupWeight', asymerror: {plus: 0.6, minus: -0.4}} + - {label: 'QCDlowRange', asymerror: {plus: -0.2, minus: 0.4}} + - {label: 'QCDhighRange', asymerror: {plus: 0.01, minus: -0.05}} + - {label: 'QCDvarIso', symerror: -0.9} + - {label: 'QCDvarElID', symerror: -0.8} + - {label: 'QCDfitUncert', symerror: 0.2} + - {label: 'QCDotherGen', symerror: 0.8} + - {label: 'QCDfitRebin', symerror: -0.005} + - {label: 'XsecZ', asymerror: {plus: 0.1, minus: -0.1}} + - {label: 'XsecTop', asymerror: {plus: 1.0, minus: -1.0}} + - {label: 'XsecDibos', asymerror: {plus: 0.2, minus: -0.2}} + - {label: 'BkgTtbarNorm', symerror: -1.0} + - {label: 'BkgMCstat', symerror: -0.3} + - {label: 'WHFmodel', symerror: -0.1} + - {label: 'LumiUncert', asymerror: {plus: 3.7, minus: -3.9}} + - {label: 'UnfoldMCstat', symerror: -0.8} + - {label: 'UnfoldOtherGen', symerror: 3.9} + - {label: 'UnfoldReweight', symerror: -0.3} + value: 171.2 + - errors: + - {label: 'Stat', symerror: 0.39} + - {label: 'JetScaleEff1', asymerror: {plus: 2.57, minus: -2.49}} + - {label: 'JetScaleEff2', asymerror: {plus: 0.88, minus: -0.74}} + - {label: 'JetScaleEff3', asymerror: {plus: -0.64, minus: 0.64}} + - {label: 'JetScaleEff4', asymerror: {plus: 0.34, minus: -0.28}} + - {label: 'JetScaleEff5', asymerror: {plus: 0.29, minus: 0.13}} + - {label: 'JetScaleEff6', asymerror: {plus: 0.32, minus: -0.26}} + - {label: 'JetScaleEta1', asymerror: {plus: 1.04, minus: -0.95}} + - {label: 'JetScaleEta2', asymerror: {plus: 0.69, minus: -0.65}} + - {label: 'JetScaleHighPt', asymerror: {plus: -0.01, minus: -0.01}} + - {label: 'JetScaleMC', asymerror: {plus: -0.02, minus: -0.01}} + - {label: 'JetScalePileup1', asymerror: {plus: 0.13, minus: -0.05}} + - {label: 'JetScalePileup2', asymerror: {plus: -0.18, minus: 0.26}} + - {label: 'JetScalePileup3', asymerror: {plus: 0.37, minus: -0.33}} + - {label: 'JetScalePileup4', asymerror: {plus: 1.47, minus: -1.44}} + - {label: 'JetScaleFlav1Known', asymerror: {plus: 0.47, minus: -0.45}} + - {label: 'JetScaleFlav2', asymerror: {plus: -2.58, minus: 2.53}} + - {label: 'JetScaleBjet', asymerror: {plus: 0.004, minus: 0.002}} + - {label: 'JetScalepunchT', asymerror: {plus: 0.01, minus: 0.005}} + - {label: 'JetResolution10', symerror: 1.88} + - {label: 'JetSFBeff', asymerror: {plus: -1.15, minus: 1.23}} + - {label: 'JetSFCeff', asymerror: {plus: -0.32, minus: 0.34}} + - {label: 'JetSFLmistag', asymerror: {plus: -0.17, minus: 0.21}} + - {label: 'JetSFHighPt', asymerror: {plus: -0.01, minus: -0.004}} + - {label: 'JetJVFcut', asymerror: {plus: -0.61, minus: -0.51}} + - {label: 'ElScaleR12', asymerror: {plus: 0.34, minus: -0.32}} + - {label: 'ElScaleZee', asymerror: {plus: 0.43, minus: -0.44}} + - {label: 'ElScalePS', asymerror: {plus: -0.02, minus: 0.09}} + - {label: 'ElResolution', symerror: -0.06} + - {label: 'ElSFReco', asymerror: {plus: 0.48, minus: -0.44}} + - {label: 'ElSFId', asymerror: {plus: 1.14, minus: -1.15}} + - {label: 'ElSFTrigger', asymerror: {plus: 0.58, minus: -0.56}} + - {label: 'ElSFIso', asymerror: {plus: 0.25, minus: -0.20}} + - {label: 'ElSFChargeMisID', asymerror: {plus: -0.001, minus: -0.004}} + - {label: 'METScale', asymerror: {plus: -1.40, minus: 1.37}} + - {label: 'METResLong', symerror: -1.10} + - {label: 'METResTrans', symerror: -1.27} + - {label: 'PileupWeight', asymerror: {plus: 0.29, minus: -0.21}} + - {label: 'QCDlowRange', asymerror: {plus: -0.10, minus: 0.20}} + - {label: 'QCDhighRange', asymerror: {plus: 0.0003, minus: -0.02}} + - {label: 'QCDvarIso', symerror: -0.48} + - {label: 'QCDvarElID', symerror: -0.40} + - {label: 'QCDfitUncert', symerror: 0.09} + - {label: 'QCDotherGen', symerror: 0.37} + - {label: 'QCDfitRebin', symerror: -0.001} + - {label: 'XsecZ', asymerror: {plus: 0.03, minus: -0.03}} + - {label: 'XsecTop', asymerror: {plus: 0.61, minus: -0.61}} + - {label: 'XsecDibos', asymerror: {plus: 0.09, minus: -0.09}} + - {label: 'BkgTtbarNorm', symerror: -0.61} + - {label: 'BkgMCstat', symerror: -0.18} + - {label: 'WHFmodel', symerror: -0.12} + - {label: 'LumiUncert', asymerror: {plus: 1.90, minus: -1.98}} + - {label: 'UnfoldMCstat', symerror: -0.50} + - {label: 'UnfoldOtherGen', symerror: 1.27} + - {label: 'UnfoldReweight', symerror: -0.18} + value: 86.49 + - errors: + - {label: 'Stat', symerror: 0.28} + - {label: 'JetScaleEff1', asymerror: {plus: 1.43, minus: -1.32}} + - {label: 'JetScaleEff2', asymerror: {plus: 0.56, minus: -0.58}} + - {label: 'JetScaleEff3', asymerror: {plus: -0.34, minus: 0.38}} + - {label: 'JetScaleEff4', asymerror: {plus: 0.18, minus: -0.15}} + - {label: 'JetScaleEff5', asymerror: {plus: 0.16, minus: 0.07}} + - {label: 'JetScaleEff6', asymerror: {plus: 0.17, minus: -0.14}} + - {label: 'JetScaleEta1', asymerror: {plus: 0.54, minus: -0.50}} + - {label: 'JetScaleEta2', asymerror: {plus: 0.33, minus: -0.36}} + - {label: 'JetScaleHighPt', asymerror: {plus: -0.01, minus: -0.01}} + - {label: 'JetScaleMC', asymerror: {plus: -0.01, minus: -0.01}} + - {label: 'JetScalePileup1', asymerror: {plus: 0.07, minus: -0.03}} + - {label: 'JetScalePileup2', asymerror: {plus: -0.09, minus: 0.14}} + - {label: 'JetScalePileup3', asymerror: {plus: 0.20, minus: -0.18}} + - {label: 'JetScalePileup4', asymerror: {plus: 0.67, minus: -0.74}} + - {label: 'JetScaleFlav1Known', asymerror: {plus: 0.25, minus: -0.24}} + - {label: 'JetScaleFlav2', asymerror: {plus: -1.41, minus: 1.38}} + - {label: 'JetScaleBjet', asymerror: {plus: 0.002, minus: 0.001}} + - {label: 'JetScalepunchT', asymerror: {plus: 0.004, minus: 0.002}} + - {label: 'JetResolution10', symerror: 0.84} + - {label: 'JetSFBeff', asymerror: {plus: -0.68, minus: 0.72}} + - {label: 'JetSFCeff', asymerror: {plus: -0.17, minus: 0.18}} + - {label: 'JetSFLmistag', asymerror: {plus: -0.09, minus: 0.11}} + - {label: 'JetSFHighPt', asymerror: {plus: -0.004, minus: -0.002}} + - {label: 'JetJVFcut', asymerror: {plus: -0.40, minus: -0.40}} + - {label: 'ElScaleR12', asymerror: {plus: 0.18, minus: -0.17}} + - {label: 'ElScaleZee', asymerror: {plus: 0.23, minus: -0.23}} + - {label: 'ElScalePS', asymerror: {plus: -0.01, minus: 0.05}} + - {label: 'ElResolution', symerror: -0.03} + - {label: 'ElSFReco', asymerror: {plus: 0.25, minus: -0.23}} + - {label: 'ElSFId', asymerror: {plus: 0.61, minus: -0.66}} + - {label: 'ElSFTrigger', asymerror: {plus: 0.31, minus: -0.30}} + - {label: 'ElSFIso', asymerror: {plus: 0.14, minus: -0.11}} + - {label: 'ElSFChargeMisID', asymerror: {plus: -0.001, minus: -0.002}} + - {label: 'METScale', asymerror: {plus: -0.68, minus: 0.65}} + - {label: 'METResLong', symerror: -0.60} + - {label: 'METResTrans', symerror: -0.56} + - {label: 'PileupWeight', asymerror: {plus: 0.15, minus: -0.11}} + - {label: 'QCDlowRange', asymerror: {plus: -0.05, minus: 0.11}} + - {label: 'QCDhighRange', asymerror: {plus: 0.0004, minus: -0.01}} + - {label: 'QCDvarIso', symerror: -0.32} + - {label: 'QCDvarElID', symerror: -0.21} + - {label: 'QCDfitUncert', symerror: 0.05} + - {label: 'QCDotherGen', symerror: 0.20} + - {label: 'QCDfitRebin', symerror: -0.001} + - {label: 'XsecZ', asymerror: {plus: 0.02, minus: -0.02}} + - {label: 'XsecTop', asymerror: {plus: 0.36, minus: -0.36}} + - {label: 'XsecDibos', asymerror: {plus: 0.05, minus: -0.05}} + - {label: 'BkgTtbarNorm', symerror: -0.36} + - {label: 'BkgMCstat', symerror: -0.13} + - {label: 'WHFmodel', symerror: -0.10} + - {label: 'LumiUncert', asymerror: {plus: 1.03, minus: -1.07}} + - {label: 'UnfoldMCstat', symerror: -0.35} + - {label: 'UnfoldOtherGen', symerror: 1.90} + - {label: 'UnfoldReweight', symerror: -0.09} + value: 46.16 + - errors: + - {label: 'Stat', symerror: 0.16} + - {label: 'JetScaleEff1', asymerror: {plus: 0.58, minus: -0.64}} + - {label: 'JetScaleEff2', asymerror: {plus: 0.29, minus: -0.30}} + - {label: 'JetScaleEff3', asymerror: {plus: -0.20, minus: 0.17}} + - {label: 'JetScaleEff4', asymerror: {plus: 0.08, minus: -0.07}} + - {label: 'JetScaleEff5', asymerror: {plus: 0.07, minus: 0.03}} + - {label: 'JetScaleEff6', asymerror: {plus: 0.07, minus: -0.06}} + - {label: 'JetScaleEta1', asymerror: {plus: 0.20, minus: -0.22}} + - {label: 'JetScaleEta2', asymerror: {plus: 0.15, minus: -0.16}} + - {label: 'JetScaleHighPt', asymerror: {plus: -0.003, minus: -0.003}} + - {label: 'JetScaleMC', asymerror: {plus: -0.004, minus: -0.004}} + - {label: 'JetScalePileup1', asymerror: {plus: 0.03, minus: -0.01}} + - {label: 'JetScalePileup2', asymerror: {plus: -0.04, minus: 0.06}} + - {label: 'JetScalePileup3', asymerror: {plus: 0.09, minus: -0.08}} + - {label: 'JetScalePileup4', asymerror: {plus: 0.28, minus: -0.27}} + - {label: 'JetScaleFlav1Known', asymerror: {plus: 0.11, minus: -0.10}} + - {label: 'JetScaleFlav2', asymerror: {plus: -0.60, minus: 0.56}} + - {label: 'JetScaleBjet', asymerror: {plus: 0.001, minus: 0.0004}} + - {label: 'JetScalepunchT', asymerror: {plus: 0.002, minus: 0.001}} + - {label: 'JetResolution10', symerror: 0.31} + - {label: 'JetSFBeff', asymerror: {plus: -0.32, minus: 0.34}} + - {label: 'JetSFCeff', asymerror: {plus: -0.08, minus: 0.08}} + - {label: 'JetSFLmistag', asymerror: {plus: -0.04, minus: 0.05}} + - {label: 'JetSFHighPt', asymerror: {plus: -0.002, minus: -0.001}} + - {label: 'JetJVFcut', asymerror: {plus: -0.18, minus: -0.17}} + - {label: 'ElScaleR12', asymerror: {plus: 0.08, minus: -0.07}} + - {label: 'ElScaleZee', asymerror: {plus: 0.10, minus: -0.10}} + - {label: 'ElScalePS', asymerror: {plus: -0.01, minus: 0.02}} + - {label: 'ElResolution', symerror: -0.01} + - {label: 'ElSFReco', asymerror: {plus: 0.11, minus: -0.10}} + - {label: 'ElSFId', asymerror: {plus: 0.27, minus: -0.28}} + - {label: 'ElSFTrigger', asymerror: {plus: 0.14, minus: -0.13}} + - {label: 'ElSFIso', asymerror: {plus: 0.06, minus: -0.05}} + - {label: 'ElSFChargeMisID', asymerror: {plus: -0.0003, minus: -0.001}} + - {label: 'METScale', asymerror: {plus: -0.22, minus: 0.26}} + - {label: 'METResLong', symerror: -0.25} + - {label: 'METResTrans', symerror: -0.27} + - {label: 'PileupWeight', asymerror: {plus: 0.07, minus: -0.05}} + - {label: 'QCDlowRange', asymerror: {plus: -0.02, minus: 0.04}} + - {label: 'QCDhighRange', asymerror: {plus: -0.001, minus: -0.004}} + - {label: 'QCDvarIso', symerror: -0.14} + - {label: 'QCDvarElID', symerror: -0.09} + - {label: 'QCDfitUncert', symerror: 0.02} + - {label: 'QCDotherGen', symerror: 0.08} + - {label: 'QCDfitRebin', symerror: -0.0004} + - {label: 'XsecZ', asymerror: {plus: 0.01, minus: -0.01}} + - {label: 'XsecTop', asymerror: {plus: 0.17, minus: -0.17}} + - {label: 'XsecDibos', asymerror: {plus: 0.02, minus: -0.02}} + - {label: 'BkgTtbarNorm', symerror: -0.17} + - {label: 'BkgMCstat', symerror: -0.08} + - {label: 'WHFmodel', symerror: 0.03} + - {label: 'LumiUncert', asymerror: {plus: 0.46, minus: -0.47}} + - {label: 'UnfoldMCstat', symerror: -0.18} + - {label: 'UnfoldOtherGen', symerror: 0.42} + - {label: 'UnfoldReweight', symerror: -0.04} + value: 20.34 + - errors: + - {label: 'Stat', symerror: 0.096} + - {label: 'JetScaleEff1', asymerror: {plus: 0.212, minus: -0.222}} + - {label: 'JetScaleEff2', asymerror: {plus: 0.138, minus: -0.129}} + - {label: 'JetScaleEff3', asymerror: {plus: -0.070, minus: 0.060}} + - {label: 'JetScaleEff4', asymerror: {plus: 0.028, minus: -0.023}} + - {label: 'JetScaleEff5', asymerror: {plus: 0.024, minus: 0.011}} + - {label: 'JetScaleEff6', asymerror: {plus: 0.027, minus: -0.021}} + - {label: 'JetScaleEta1', asymerror: {plus: 0.072, minus: -0.079}} + - {label: 'JetScaleEta2', asymerror: {plus: 0.053, minus: -0.057}} + - {label: 'JetScaleHighPt', asymerror: {plus: -0.001, minus: -0.001}} + - {label: 'JetScaleMC', asymerror: {plus: -0.002, minus: -0.001}} + - {label: 'JetScalePileup1', asymerror: {plus: 0.011, minus: -0.004}} + - {label: 'JetScalePileup2', asymerror: {plus: -0.015, minus: 0.022}} + - {label: 'JetScalePileup3', asymerror: {plus: 0.031, minus: -0.028}} + - {label: 'JetScalePileup4', asymerror: {plus: 0.099, minus: -0.096}} + - {label: 'JetScaleFlav1Known', asymerror: {plus: 0.040, minus: -0.037}} + - {label: 'JetScaleFlav2', asymerror: {plus: -0.179, minus: 0.193}} + - {label: 'JetScaleBjet', asymerror: {plus: 0.0003, minus: 0.0001}} + - {label: 'JetScalepunchT', asymerror: {plus: 0.001, minus: 0.0004}} + - {label: 'JetResolution10', symerror: 0.109} + - {label: 'JetSFBeff', asymerror: {plus: -0.118, minus: 0.133}} + - {label: 'JetSFCeff', asymerror: {plus: -0.027, minus: 0.029}} + - {label: 'JetSFLmistag', asymerror: {plus: -0.014, minus: 0.017}} + - {label: 'JetSFHighPt', asymerror: {plus: -0.001, minus: -0.0003}} + - {label: 'JetJVFcut', asymerror: {plus: -0.064, minus: -0.063}} + - {label: 'ElScaleR12', asymerror: {plus: 0.029, minus: -0.027}} + - {label: 'ElScaleZee', asymerror: {plus: 0.036, minus: -0.037}} + - {label: 'ElScalePS', asymerror: {plus: -0.002, minus: 0.008}} + - {label: 'ElResolution', symerror: -0.005} + - {label: 'ElSFReco', asymerror: {plus: 0.040, minus: -0.037}} + - {label: 'ElSFId', asymerror: {plus: 0.097, minus: -0.102}} + - {label: 'ElSFTrigger', asymerror: {plus: 0.049, minus: -0.047}} + - {label: 'ElSFIso', asymerror: {plus: 0.021, minus: -0.017}} + - {label: 'ElSFChargeMisID', asymerror: {plus: -0.0001, minus: -0.0004}} + - {label: 'METScale', asymerror: {plus: -0.078, minus: 0.091}} + - {label: 'METResLong', symerror: -0.088} + - {label: 'METResTrans', symerror: -0.097} + - {label: 'PileupWeight', asymerror: {plus: 0.024, minus: -0.018}} + - {label: 'QCDlowRange', asymerror: {plus: -0.008, minus: 0.015}} + - {label: 'QCDhighRange', asymerror: {plus: -0.001, minus: -0.001}} + - {label: 'QCDvarIso', symerror: -0.050} + - {label: 'QCDvarElID', symerror: -0.034} + - {label: 'QCDfitUncert', symerror: 0.012} + - {label: 'QCDotherGen', symerror: 0.027} + - {label: 'QCDfitRebin', symerror: 0.0002} + - {label: 'XsecZ', asymerror: {plus: 0.002, minus: -0.002}} + - {label: 'XsecTop', asymerror: {plus: 0.064, minus: -0.065}} + - {label: 'XsecDibos', asymerror: {plus: 0.009, minus: -0.009}} + - {label: 'BkgTtbarNorm', symerror: -0.065} + - {label: 'BkgMCstat', symerror: -0.044} + - {label: 'WHFmodel', symerror: -0.013} + - {label: 'LumiUncert', asymerror: {plus: 0.164, minus: -0.170}} + - {label: 'UnfoldMCstat', symerror: -0.104} + - {label: 'UnfoldOtherGen', symerror: 0.148} + - {label: 'UnfoldReweight', symerror: -0.015} + value: 7.263 + - errors: + - {label: 'Stat', symerror: 0.060} + - {label: 'JetScaleEff1', asymerror: {plus: 0.087, minus: -0.082}} + - {label: 'JetScaleEff2', asymerror: {plus: 0.056, minus: -0.053}} + - {label: 'JetScaleEff3', asymerror: {plus: -0.029, minus: 0.025}} + - {label: 'JetScaleEff4', asymerror: {plus: 0.012, minus: -0.010}} + - {label: 'JetScaleEff5', asymerror: {plus: 0.010, minus: 0.005}} + - {label: 'JetScaleEff6', asymerror: {plus: 0.011, minus: -0.009}} + - {label: 'JetScaleEta1', asymerror: {plus: 0.030, minus: -0.032}} + - {label: 'JetScaleEta2', asymerror: {plus: 0.022, minus: -0.023}} + - {label: 'JetScaleHighPt', asymerror: {plus: -0.0004, minus: -0.0004}} + - {label: 'JetScaleMC', asymerror: {plus: -0.001, minus: -0.001}} + - {label: 'JetScalePileup1', asymerror: {plus: 0.005, minus: -0.002}} + - {label: 'JetScalePileup2', asymerror: {plus: -0.006, minus: 0.009}} + - {label: 'JetScalePileup3', asymerror: {plus: 0.013, minus: -0.011}} + - {label: 'JetScalePileup4', asymerror: {plus: 0.041, minus: -0.039}} + - {label: 'JetScaleFlav1Known', asymerror: {plus: 0.016, minus: -0.015}} + - {label: 'JetScaleFlav2', asymerror: {plus: -0.073, minus: 0.074}} + - {label: 'JetScaleBjet', asymerror: {plus: 0.0001, minus: 0.0001}} + - {label: 'JetScalepunchT', asymerror: {plus: 0.0002, minus: 0.0002}} + - {label: 'JetResolution10', symerror: 0.045} + - {label: 'JetSFBeff', asymerror: {plus: -0.049, minus: 0.054}} + - {label: 'JetSFCeff', asymerror: {plus: -0.011, minus: 0.012}} + - {label: 'JetSFLmistag', asymerror: {plus: -0.006, minus: 0.007}} + - {label: 'JetSFHighPt', asymerror: {plus: -0.0003, minus: -0.0001}} + - {label: 'JetJVFcut', asymerror: {plus: -0.026, minus: -0.026}} + - {label: 'ElScaleR12', asymerror: {plus: 0.012, minus: -0.011}} + - {label: 'ElScaleZee', asymerror: {plus: 0.015, minus: -0.015}} + - {label: 'ElScalePS', asymerror: {plus: -0.001, minus: 0.003}} + - {label: 'ElResolution', symerror: -0.002} + - {label: 'ElSFReco', asymerror: {plus: 0.016, minus: -0.015}} + - {label: 'ElSFId', asymerror: {plus: 0.040, minus: -0.042}} + - {label: 'ElSFTrigger', asymerror: {plus: 0.020, minus: -0.019}} + - {label: 'ElSFIso', asymerror: {plus: 0.009, minus: -0.007}} + - {label: 'ElSFChargeMisID', asymerror: {plus: -0.00005, minus: -0.0002}} + - {label: 'METScale', asymerror: {plus: -0.032, minus: 0.037}} + - {label: 'METResLong', symerror: -0.036} + - {label: 'METResTrans', symerror: -0.040} + - {label: 'PileupWeight', asymerror: {plus: 0.010, minus: -0.007}} + - {label: 'QCDlowRange', asymerror: {plus: -0.003, minus: 0.007}} + - {label: 'QCDhighRange', asymerror: {plus: -0.0001, minus: -0.001}} + - {label: 'QCDvarIso', symerror: -0.020} + - {label: 'QCDvarElID', symerror: -0.014} + - {label: 'QCDfitUncert', symerror: 0.004} + - {label: 'QCDotherGen', symerror: 0.013} + - {label: 'QCDfitRebin', symerror: 0.00003} + - {label: 'XsecZ', asymerror: {plus: 0.0004, minus: -0.0004}} + - {label: 'XsecTop', asymerror: {plus: 0.025, minus: -0.025}} + - {label: 'XsecDibos', asymerror: {plus: 0.004, minus: -0.004}} + - {label: 'BkgTtbarNorm', symerror: -0.025} + - {label: 'BkgMCstat', symerror: -0.026} + - {label: 'WHFmodel', symerror: -0.016} + - {label: 'LumiUncert', asymerror: {plus: 0.067, minus: -0.070}} + - {label: 'UnfoldMCstat', symerror: -0.067} + - {label: 'UnfoldOtherGen', symerror: 0.061} + - {label: 'UnfoldReweight', symerror: -0.006} + value: 2.979 + - errors: + - {label: 'Stat', symerror: 0.040} + - {label: 'JetScaleEff1', asymerror: {plus: 0.049, minus: -0.036}} + - {label: 'JetScaleEff2', asymerror: {plus: 0.049, minus: -0.023}} + - {label: 'JetScaleEff3', asymerror: {plus: -0.013, minus: 0.011}} + - {label: 'JetScaleEff4', asymerror: {plus: 0.005, minus: -0.004}} + - {label: 'JetScaleEff5', asymerror: {plus: 0.004, minus: 0.002}} + - {label: 'JetScaleEff6', asymerror: {plus: 0.005, minus: -0.004}} + - {label: 'JetScaleEta1', asymerror: {plus: 0.013, minus: -0.014}} + - {label: 'JetScaleEta2', asymerror: {plus: 0.010, minus: -0.010}} + - {label: 'JetScaleHighPt', asymerror: {plus: -0.0002, minus: -0.0002}} + - {label: 'JetScaleMC', asymerror: {plus: -0.0003, minus: -0.0002}} + - {label: 'JetScalePileup1', asymerror: {plus: 0.002, minus: -0.001}} + - {label: 'JetScalePileup2', asymerror: {plus: -0.003, minus: 0.004}} + - {label: 'JetScalePileup3', asymerror: {plus: 0.006, minus: -0.005}} + - {label: 'JetScalePileup4', asymerror: {plus: 0.018, minus: -0.017}} + - {label: 'JetScaleFlav1Known', asymerror: {plus: 0.007, minus: -0.007}} + - {label: 'JetScaleFlav2', asymerror: {plus: -0.032, minus: 0.033}} + - {label: 'JetScaleBjet', asymerror: {plus: 0.0001, minus: 0.00003}} + - {label: 'JetScalepunchT', asymerror: {plus: 0.0001, minus: 0.0001}} + - {label: 'JetResolution10', symerror: 0.020} + - {label: 'JetSFBeff', asymerror: {plus: -0.021, minus: 0.024}} + - {label: 'JetSFCeff', asymerror: {plus: -0.005, minus: 0.005}} + - {label: 'JetSFLmistag', asymerror: {plus: -0.003, minus: 0.003}} + - {label: 'JetSFHighPt', asymerror: {plus: -0.0001, minus: -0.0001}} + - {label: 'JetJVFcut', asymerror: {plus: -0.012, minus: -0.011}} + - {label: 'ElScaleR12', asymerror: {plus: 0.005, minus: -0.005}} + - {label: 'ElScaleZee', asymerror: {plus: 0.007, minus: -0.007}} + - {label: 'ElScalePS', asymerror: {plus: -0.0003, minus: 0.001}} + - {label: 'ElResolution', symerror: -0.001} + - {label: 'ElSFReco', asymerror: {plus: 0.007, minus: -0.007}} + - {label: 'ElSFId', asymerror: {plus: 0.018, minus: -0.018}} + - {label: 'ElSFTrigger', asymerror: {plus: 0.009, minus: -0.009}} + - {label: 'ElSFIso', asymerror: {plus: 0.004, minus: -0.003}} + - {label: 'ElSFChargeMisID', asymerror: {plus: -0.00002, minus: -0.0001}} + - {label: 'METScale', asymerror: {plus: -0.014, minus: 0.017}} + - {label: 'METResLong', symerror: -0.016} + - {label: 'METResTrans', symerror: -0.018} + - {label: 'PileupWeight', asymerror: {plus: 0.004, minus: -0.003}} + - {label: 'QCDlowRange', asymerror: {plus: -0.001, minus: 0.002}} + - {label: 'QCDhighRange', asymerror: {plus: -0.0001, minus: -0.0002}} + - {label: 'QCDvarIso', symerror: -0.009} + - {label: 'QCDvarElID', symerror: -0.006} + - {label: 'QCDfitUncert', symerror: 0.001} + - {label: 'QCDotherGen', symerror: 0.004} + - {label: 'QCDfitRebin', symerror: 0.0001} + - {label: 'XsecZ', asymerror: {plus: 0.001, minus: -0.001}} + - {label: 'XsecTop', asymerror: {plus: 0.011, minus: -0.011}} + - {label: 'XsecDibos', asymerror: {plus: 0.002, minus: -0.002}} + - {label: 'BkgTtbarNorm', symerror: -0.010} + - {label: 'BkgMCstat', symerror: -0.018} + - {label: 'WHFmodel', symerror: -0.009} + - {label: 'LumiUncert', asymerror: {plus: 0.030, minus: -0.031}} + - {label: 'UnfoldMCstat', symerror: -0.041} + - {label: 'UnfoldOtherGen', symerror: 0.027} + - {label: 'UnfoldReweight', symerror: -0.003} + value: 1.319 + - errors: + - {label: 'Stat', symerror: 0.0254} + - {label: 'JetScaleEff1', asymerror: {plus: 0.0231, minus: -0.0172}} + - {label: 'JetScaleEff2', asymerror: {plus: 0.0229, minus: -0.0293}} + - {label: 'JetScaleEff3', asymerror: {plus: -0.0060, minus: 0.0052}} + - {label: 'JetScaleEff4', asymerror: {plus: 0.0024, minus: -0.0020}} + - {label: 'JetScaleEff5', asymerror: {plus: 0.0021, minus: 0.0010}} + - {label: 'JetScaleEff6', asymerror: {plus: 0.0023, minus: -0.0018}} + - {label: 'JetScaleEta1', asymerror: {plus: 0.0062, minus: -0.0067}} + - {label: 'JetScaleEta2', asymerror: {plus: 0.0045, minus: -0.0049}} + - {label: 'JetScaleHighPt', asymerror: {plus: -0.0001, minus: -0.0001}} + - {label: 'JetScaleMC', asymerror: {plus: -0.0001, minus: -0.0001}} + - {label: 'JetScalePileup1', asymerror: {plus: 0.0010, minus: -0.0003}} + - {label: 'JetScalePileup2', asymerror: {plus: -0.0013, minus: 0.0019}} + - {label: 'JetScalePileup3', asymerror: {plus: 0.0027, minus: -0.0024}} + - {label: 'JetScalePileup4', asymerror: {plus: 0.0085, minus: -0.0082}} + - {label: 'JetScaleFlav1Known', asymerror: {plus: 0.0034, minus: -0.0032}} + - {label: 'JetScaleFlav2', asymerror: {plus: -0.0153, minus: 0.0154}} + - {label: 'JetScaleBjet', asymerror: {plus: 0.00003, minus: 0.00001}} + - {label: 'JetScalepunchT', asymerror: {plus: 0.0001, minus: 0.00003}} + - {label: 'JetResolution10', symerror: 0.0093} + - {label: 'JetSFBeff', asymerror: {plus: -0.0102, minus: 0.0114}} + - {label: 'JetSFCeff', asymerror: {plus: -0.0023, minus: 0.0025}} + - {label: 'JetSFLmistag', asymerror: {plus: -0.0012, minus: 0.0015}} + - {label: 'JetSFHighPt', asymerror: {plus: -0.0001, minus: -0.00003}} + - {label: 'JetJVFcut', asymerror: {plus: -0.0054, minus: -0.0054}} + - {label: 'ElScaleR12', asymerror: {plus: 0.0025, minus: -0.0023}} + - {label: 'ElScaleZee', asymerror: {plus: 0.0031, minus: -0.0031}} + - {label: 'ElScalePS', asymerror: {plus: -0.0002, minus: 0.0007}} + - {label: 'ElResolution', symerror: -0.0004} + - {label: 'ElSFReco', asymerror: {plus: 0.0034, minus: -0.0031}} + - {label: 'ElSFId', asymerror: {plus: 0.0083, minus: -0.0087}} + - {label: 'ElSFTrigger', asymerror: {plus: 0.0042, minus: -0.0040}} + - {label: 'ElSFIso', asymerror: {plus: 0.0018, minus: -0.0014}} + - {label: 'ElSFChargeMisID', asymerror: {plus: -0.00001, minus: -0.00003}} + - {label: 'METScale', asymerror: {plus: -0.0067, minus: 0.0078}} + - {label: 'METResLong', symerror: -0.0075} + - {label: 'METResTrans', symerror: -0.0083} + - {label: 'PileupWeight', asymerror: {plus: 0.0021, minus: -0.0015}} + - {label: 'QCDlowRange', asymerror: {plus: -0.0006, minus: 0.0011}} + - {label: 'QCDhighRange', asymerror: {plus: 0.00004, minus: -0.0001}} + - {label: 'QCDvarIso', symerror: -0.0043} + - {label: 'QCDvarElID', symerror: -0.0029} + - {label: 'QCDfitUncert', symerror: 0.0004} + - {label: 'QCDotherGen', symerror: 0.0021} + - {label: 'QCDfitRebin', symerror: -0.00002} + - {label: 'XsecZ', asymerror: {plus: 0.0002, minus: -0.0002}} + - {label: 'XsecTop', asymerror: {plus: 0.0046, minus: -0.0046}} + - {label: 'XsecDibos', asymerror: {plus: 0.0008, minus: -0.0008}} + - {label: 'BkgTtbarNorm', symerror: -0.0046} + - {label: 'BkgMCstat', symerror: -0.0095} + - {label: 'WHFmodel', symerror: -0.0060} + - {label: 'LumiUncert', asymerror: {plus: 0.0136, minus: -0.0142}} + - {label: 'UnfoldMCstat', symerror: -0.0291} + - {label: 'UnfoldOtherGen', symerror: 0.0127} + - {label: 'UnfoldReweight', symerror: -0.0013} + value: 0.6226 + - errors: + - {label: 'Stat', symerror: 0.0186} + - {label: 'JetScaleEff1', asymerror: {plus: 0.0124, minus: -0.0092}} + - {label: 'JetScaleEff2', asymerror: {plus: 0.0123, minus: -0.0157}} + - {label: 'JetScaleEff3', asymerror: {plus: -0.0032, minus: 0.0028}} + - {label: 'JetScaleEff4', asymerror: {plus: 0.0013, minus: -0.0011}} + - {label: 'JetScaleEff5', asymerror: {plus: 0.0011, minus: 0.0005}} + - {label: 'JetScaleEff6', asymerror: {plus: 0.0012, minus: -0.0010}} + - {label: 'JetScaleEta1', asymerror: {plus: 0.0033, minus: -0.0036}} + - {label: 'JetScaleEta2', asymerror: {plus: 0.0024, minus: -0.0026}} + - {label: 'JetScaleHighPt', asymerror: {plus: -0.00005, minus: -0.00005}} + - {label: 'JetScaleMC', asymerror: {plus: -0.0001, minus: -0.0001}} + - {label: 'JetScalePileup1', asymerror: {plus: 0.0005, minus: -0.0002}} + - {label: 'JetScalePileup2', asymerror: {plus: -0.0007, minus: 0.0010}} + - {label: 'JetScalePileup3', asymerror: {plus: 0.0014, minus: -0.0013}} + - {label: 'JetScalePileup4', asymerror: {plus: 0.0045, minus: -0.0044}} + - {label: 'JetScaleFlav1Known', asymerror: {plus: 0.0018, minus: -0.0017}} + - {label: 'JetScaleFlav2', asymerror: {plus: -0.0082, minus: 0.0083}} + - {label: 'JetScaleBjet', asymerror: {plus: 0.00002, minus: 0.00001}} + - {label: 'JetScalepunchT', asymerror: {plus: 0.00003, minus: 0.00002}} + - {label: 'JetResolution10', symerror: 0.0050} + - {label: 'JetSFBeff', asymerror: {plus: -0.0054, minus: 0.0061}} + - {label: 'JetSFCeff', asymerror: {plus: -0.0012, minus: 0.0013}} + - {label: 'JetSFLmistag', asymerror: {plus: -0.0006, minus: 0.0008}} + - {label: 'JetSFHighPt', asymerror: {plus: -0.00003, minus: -0.00001}} + - {label: 'JetJVFcut', asymerror: {plus: -0.0029, minus: -0.0029}} + - {label: 'ElScaleR12', asymerror: {plus: 0.0013, minus: -0.0012}} + - {label: 'ElScaleZee', asymerror: {plus: 0.0017, minus: -0.0017}} + - {label: 'ElScalePS', asymerror: {plus: -0.0001, minus: 0.0004}} + - {label: 'ElResolution', symerror: -0.0002} + - {label: 'ElSFReco', asymerror: {plus: 0.0018, minus: -0.0017}} + - {label: 'ElSFId', asymerror: {plus: 0.0044, minus: -0.0047}} + - {label: 'ElSFTrigger', asymerror: {plus: 0.0022, minus: -0.0022}} + - {label: 'ElSFIso', asymerror: {plus: 0.0010, minus: -0.0008}} + - {label: 'ElSFChargeMisID', asymerror: {plus: -0.00001, minus: -0.00002}} + - {label: 'METScale', asymerror: {plus: -0.0036, minus: 0.0042}} + - {label: 'METResLong', symerror: -0.0040} + - {label: 'METResTrans', symerror: -0.0044} + - {label: 'PileupWeight', asymerror: {plus: 0.0011, minus: -0.0008}} + - {label: 'QCDlowRange', asymerror: {plus: -0.0005, minus: 0.0006}} + - {label: 'QCDhighRange', asymerror: {plus: 0.00003, minus: -0.0001}} + - {label: 'QCDvarIso', symerror: -0.0023} + - {label: 'QCDvarElID', symerror: -0.0015} + - {label: 'QCDfitUncert', symerror: 0.0003} + - {label: 'QCDotherGen', symerror: 0.0016} + - {label: 'QCDfitRebin', symerror: 0.00002} + - {label: 'XsecZ', asymerror: {plus: -0.0001, minus: 0.0001}} + - {label: 'XsecTop', asymerror: {plus: 0.0020, minus: -0.0020}} + - {label: 'XsecDibos', asymerror: {plus: 0.0005, minus: -0.0005}} + - {label: 'BkgTtbarNorm', symerror: -0.0022} + - {label: 'BkgMCstat', symerror: -0.0075} + - {label: 'WHFmodel', symerror: 0.0070} + - {label: 'LumiUncert', asymerror: {plus: 0.0072, minus: -0.0075}} + - {label: 'UnfoldMCstat', symerror: -0.0210} + - {label: 'UnfoldOtherGen', symerror: 0.0068} + - {label: 'UnfoldReweight', symerror: -0.0007} + value: 0.3336 + - errors: + - {label: 'Stat', symerror: 0.0100} + - {label: 'JetScaleEff1', asymerror: {plus: 0.0045, minus: -0.0034}} + - {label: 'JetScaleEff2', asymerror: {plus: 0.0045, minus: -0.0058}} + - {label: 'JetScaleEff3', asymerror: {plus: -0.0012, minus: 0.0010}} + - {label: 'JetScaleEff4', asymerror: {plus: 0.0005, minus: -0.0004}} + - {label: 'JetScaleEff5', asymerror: {plus: 0.0004, minus: 0.0002}} + - {label: 'JetScaleEff6', asymerror: {plus: 0.0004, minus: -0.0004}} + - {label: 'JetScaleEta1', asymerror: {plus: 0.0012, minus: -0.0013}} + - {label: 'JetScaleEta2', asymerror: {plus: 0.0009, minus: -0.0010}} + - {label: 'JetScaleHighPt', asymerror: {plus: -0.00002, minus: -0.00002}} + - {label: 'JetScaleMC', asymerror: {plus: -0.00003, minus: -0.00002}} + - {label: 'JetScalePileup1', asymerror: {plus: 0.0002, minus: -0.0001}} + - {label: 'JetScalePileup2', asymerror: {plus: -0.0002, minus: 0.0004}} + - {label: 'JetScalePileup3', asymerror: {plus: 0.0005, minus: -0.0005}} + - {label: 'JetScalePileup4', asymerror: {plus: 0.0017, minus: -0.0016}} + - {label: 'JetScaleFlav1Known', asymerror: {plus: 0.0007, minus: -0.0006}} + - {label: 'JetScaleFlav2', asymerror: {plus: -0.0030, minus: 0.0030}} + - {label: 'JetScaleBjet', asymerror: {plus: 0.00001, minus: 0.000003}} + - {label: 'JetScalepunchT', asymerror: {plus: 0.00001, minus: 0.00001}} + - {label: 'JetResolution10', symerror: 0.0018} + - {label: 'JetSFBeff', asymerror: {plus: -0.0020, minus: 0.0022}} + - {label: 'JetSFCeff', asymerror: {plus: -0.0005, minus: 0.0005}} + - {label: 'JetSFLmistag', asymerror: {plus: -0.0002, minus: 0.0003}} + - {label: 'JetSFHighPt', asymerror: {plus: -0.00001, minus: -0.000005}} + - {label: 'JetJVFcut', asymerror: {plus: -0.0011, minus: -0.0011}} + - {label: 'ElScaleR12', asymerror: {plus: 0.0005, minus: -0.0004}} + - {label: 'ElScaleZee', asymerror: {plus: 0.0006, minus: -0.0006}} + - {label: 'ElScalePS', asymerror: {plus: -0.00003, minus: 0.0001}} + - {label: 'ElResolution', symerror: -0.0001} + - {label: 'ElSFReco', asymerror: {plus: 0.0007, minus: -0.0006}} + - {label: 'ElSFId', asymerror: {plus: 0.0016, minus: -0.0017}} + - {label: 'ElSFTrigger', asymerror: {plus: 0.0008, minus: -0.0008}} + - {label: 'ElSFIso', asymerror: {plus: 0.0004, minus: -0.0003}} + - {label: 'ElSFChargeMisID', asymerror: {plus: -0.000002, minus: -0.00001}} + - {label: 'METScale', asymerror: {plus: -0.0013, minus: 0.0015}} + - {label: 'METResLong', symerror: -0.0015} + - {label: 'METResTrans', symerror: -0.0016} + - {label: 'PileupWeight', asymerror: {plus: 0.0004, minus: -0.0003}} + - {label: 'QCDlowRange', asymerror: {plus: 0.00001, minus: 0.0001}} + - {label: 'QCDhighRange', asymerror: {plus: 0.00001, minus: -0.00001}} + - {label: 'QCDvarIso', symerror: -0.0008} + - {label: 'QCDvarElID', symerror: -0.0006} + - {label: 'QCDfitUncert', symerror: 0.00000005} + - {label: 'QCDotherGen', symerror: 0.0001} + - {label: 'QCDfitRebin', symerror: 0.000002} + - {label: 'XsecZ', asymerror: {plus: 0.0002, minus: -0.0002}} + - {label: 'XsecTop', asymerror: {plus: 0.0009, minus: -0.0009}} + - {label: 'XsecDibos', asymerror: {plus: 0.0002, minus: -0.0002}} + - {label: 'BkgTtbarNorm', symerror: -0.0009} + - {label: 'BkgMCstat', symerror: -0.0032} + - {label: 'WHFmodel', symerror: 0.0014} + - {label: 'LumiUncert', asymerror: {plus: 0.0028, minus: -0.0029}} + - {label: 'UnfoldMCstat', symerror: -0.0092} + - {label: 'UnfoldOtherGen', symerror: 0.0025} + - {label: 'UnfoldReweight', symerror: -0.0002} + value: 0.1224 + - errors: + - {label: 'Stat', symerror: 0.00345} + - {label: 'JetScaleEff1', asymerror: {plus: 0.00105, minus: -0.00078}} + - {label: 'JetScaleEff2', asymerror: {plus: 0.00104, minus: -0.00133}} + - {label: 'JetScaleEff3', asymerror: {plus: -0.00027, minus: 0.00024}} + - {label: 'JetScaleEff4', asymerror: {plus: 0.00011, minus: -0.00009}} + - {label: 'JetScaleEff5', asymerror: {plus: 0.00010, minus: 0.00004}} + - {label: 'JetScaleEff6', asymerror: {plus: 0.00010, minus: -0.00008}} + - {label: 'JetScaleEta1', asymerror: {plus: 0.00028, minus: -0.00031}} + - {label: 'JetScaleEta2', asymerror: {plus: 0.00021, minus: -0.00022}} + - {label: 'JetScaleHighPt', asymerror: {plus: -0.000004, minus: -0.000004}} + - {label: 'JetScaleMC', asymerror: {plus: -0.00001, minus: -0.000005}} + - {label: 'JetScalePileup1', asymerror: {plus: 0.00004, minus: -0.00002}} + - {label: 'JetScalePileup2', asymerror: {plus: -0.00006, minus: 0.00008}} + - {label: 'JetScalePileup3', asymerror: {plus: 0.00012, minus: -0.00011}} + - {label: 'JetScalePileup4', asymerror: {plus: 0.00039, minus: -0.00037}} + - {label: 'JetScaleFlav1Known', asymerror: {plus: 0.00015, minus: -0.00015}} + - {label: 'JetScaleFlav2', asymerror: {plus: -0.00070, minus: 0.00070}} + - {label: 'JetScaleBjet', asymerror: {plus: 0.000001, minus: 0.000001}} + - {label: 'JetScalepunchT', asymerror: {plus: 0.000002, minus: 0.000001}} + - {label: 'JetResolution10', symerror: 0.00043} + - {label: 'JetSFBeff', asymerror: {plus: -0.00046, minus: 0.00052}} + - {label: 'JetSFCeff', asymerror: {plus: -0.00011, minus: 0.00011}} + - {label: 'JetSFLmistag', asymerror: {plus: -0.00005, minus: 0.00007}} + - {label: 'JetSFHighPt', asymerror: {plus: -0.000003, minus: -0.000001}} + - {label: 'JetJVFcut', asymerror: {plus: -0.00025, minus: -0.00024}} + - {label: 'ElScaleR12', asymerror: {plus: 0.00011, minus: -0.00010}} + - {label: 'ElScaleZee', asymerror: {plus: 0.00014, minus: -0.00014}} + - {label: 'ElScalePS', asymerror: {plus: -0.00001, minus: 0.00003}} + - {label: 'ElResolution', symerror: -0.00002} + - {label: 'ElSFReco', asymerror: {plus: 0.00016, minus: -0.00014}} + - {label: 'ElSFId', asymerror: {plus: 0.00038, minus: -0.00040}} + - {label: 'ElSFTrigger', asymerror: {plus: 0.00019, minus: -0.00018}} + - {label: 'ElSFIso', asymerror: {plus: 0.00008, minus: -0.00007}} + - {label: 'ElSFChargeMisID', asymerror: {plus: -0.0000004, minus: -0.000001}} + - {label: 'METScale', asymerror: {plus: -0.00030, minus: 0.00036}} + - {label: 'METResLong', symerror: -0.00034} + - {label: 'METResTrans', symerror: -0.00038} + - {label: 'PileupWeight', asymerror: {plus: 0.00009, minus: -0.00007}} + - {label: 'QCDlowRange', asymerror: {plus: 0.00001, minus: -0.00001}} + - {label: 'QCDhighRange', asymerror: {plus: -0.0000002, minus: 0.000001}} + - {label: 'QCDvarIso', symerror: -0.00019} + - {label: 'QCDvarElID', symerror: -0.00013} + - {label: 'QCDfitUncert', symerror: -0.000003} + - {label: 'QCDotherGen', symerror: -0.00002} + - {label: 'QCDfitRebin', symerror: -0.00000001} + - {label: 'XsecZ', asymerror: {plus: 0.00006, minus: -0.00006}} + - {label: 'XsecTop', asymerror: {plus: 0.00014, minus: -0.00014}} + - {label: 'XsecDibos', asymerror: {plus: 0.00008, minus: -0.00008}} + - {label: 'BkgTtbarNorm', symerror: -0.00013} + - {label: 'BkgMCstat', symerror: -0.00099} + - {label: 'WHFmodel', symerror: -0.00075} + - {label: 'LumiUncert', asymerror: {plus: 0.00064, minus: -0.00066}} + - {label: 'UnfoldMCstat', symerror: -0.00404} + - {label: 'UnfoldOtherGen', symerror: 0.00058} + - {label: 'UnfoldReweight', symerror: -0.00006} + value: 0.02836 +- header: {name: '$d\sigma^{W^+}/dp_\text{T}^\text{W} / d\sigma^{W^-}/dp_\text{T}^\text{W}$'} + qualifiers: + - {name: 'Cross section', value: 'W+/W- (electron channel)'} + - {name: 'ABS(ETARAP(ELECTRON))', value: '< 2.5'} + - {name: 'ABS(YRAP(JET))', value: '< 4.4'} + - {name: 'PT(JET)', units: 'GEV', value: '> 30'} + - {name: 'PT(LEPTON)', units: 'GEV', value: '> 25'} + - {name: 'RE', value: 'P P --> W JET(S) X'} + - {name: 'SQRT(S)', units: 'GEV', value: '8000.0'} + values: + - errors: + - {label: 'Stat', symerror: 0.0015} + - {label: 'JetScaleEff1', asymerror: {plus: -0.0067, minus: 0.0068}} + - {label: 'JetScaleEff2', asymerror: {plus: -0.0009, minus: 0.0003}} + - {label: 'JetScaleEff3', asymerror: {plus: 0.0006, minus: -0.00004}} + - {label: 'JetScaleEff4', asymerror: {plus: -0.0004, minus: 0.0007}} + - {label: 'JetScaleEff5', asymerror: {plus: 0.0004, minus: 0.0009}} + - {label: 'JetScaleEff6', asymerror: {plus: -0.0002, minus: 0.0003}} + - {label: 'JetScaleEta1', asymerror: {plus: -0.0023, minus: 0.0030}} + - {label: 'JetScaleEta2', asymerror: {plus: -0.0013, minus: 0.0018}} + - {label: 'JetScaleHighPt', asymerror: {plus: 0.0003, minus: 0.0003}} + - {label: 'JetScaleMC', asymerror: {plus: 0.0005, minus: 0.0004}} + - {label: 'JetScalePileup1', asymerror: {plus: -0.0010, minus: -0.0004}} + - {label: 'JetScalePileup2', asymerror: {plus: 0.0015, minus: -0.0005}} + - {label: 'JetScalePileup3', asymerror: {plus: -0.0004, minus: 0.00001}} + - {label: 'JetScalePileup4', asymerror: {plus: -0.0038, minus: 0.0038}} + - {label: 'JetScaleFlav1Known', asymerror: {plus: -0.0013, minus: 0.0003}} + - {label: 'JetScaleFlav2', asymerror: {plus: 0.0055, minus: -0.0066}} + - {label: 'JetScaleBjet', asymerror: {plus: 0.0001, minus: 0.0001}} + - {label: 'JetScalepunchT', asymerror: {plus: -0.000003, minus: 0.0001}} + - {label: 'JetResolution10', symerror: -0.0174} + - {label: 'JetSFBeff', asymerror: {plus: 0.0016, minus: -0.0009}} + - {label: 'JetSFCeff', asymerror: {plus: 0.0012, minus: -0.0005}} + - {label: 'JetSFLmistag', asymerror: {plus: 0.0003, minus: 0.0003}} + - {label: 'JetSFHighPt', asymerror: {plus: 0.0003, minus: 0.0002}} + - {label: 'JetJVFcut', asymerror: {plus: 0.0021, minus: 0.0010}} + - {label: 'ElScaleR12', asymerror: {plus: -0.0004, minus: 0.0003}} + - {label: 'ElScaleZee', asymerror: {plus: -0.0019, minus: 0.0007}} + - {label: 'ElScalePS', asymerror: {plus: 0.0001, minus: 0.00001}} + - {label: 'ElResolution', symerror: -0.0008} + - {label: 'ElSFReco', asymerror: {plus: 0.0005, minus: -0.0001}} + - {label: 'ElSFId', asymerror: {plus: 0.0015, minus: -0.0008}} + - {label: 'ElSFTrigger', asymerror: {plus: 0.0005, minus: -0.0009}} + - {label: 'ElSFIso', asymerror: {plus: 0.0004, minus: -0.00005}} + - {label: 'ElSFChargeMisID', asymerror: {plus: 0.00004, minus: 0.0001}} + - {label: 'METScale', asymerror: {plus: 0.0102, minus: -0.0098}} + - {label: 'METResLong', symerror: 0.0092} + - {label: 'METResTrans', symerror: 0.0105} + - {label: 'PileupWeight', asymerror: {plus: -0.0023, minus: 0.0023}} + - {label: 'QCDlowRange', asymerror: {plus: 0.0035, minus: -0.0066}} + - {label: 'QCDhighRange', asymerror: {plus: 0.0007, minus: 0.0012}} + - {label: 'QCDvarIso', symerror: -0.0037} + - {label: 'QCDvarElID', symerror: -0.0163} + - {label: 'QCDfitUncert', symerror: 0.0057} + - {label: 'QCDotherGen', symerror: -0.0292} + - {label: 'QCDfitRebin', symerror: 0.000001} + - {label: 'XsecZ', asymerror: {plus: 0.0016, minus: -0.0016}} + - {label: 'XsecTop', asymerror: {plus: -0.0008, minus: 0.0008}} + - {label: 'XsecDibos', asymerror: {plus: -0.0004, minus: 0.0004}} + - {label: 'BkgTtbarNorm', symerror: 0.0009} + - {label: 'BkgMCstat', symerror: 0.0017} + - {label: 'WHFmodel', symerror: -0.0046} + - {label: 'LumiUncert', asymerror: {plus: -0.0005, minus: 0.0006}} + - {label: 'UnfoldMCstat', symerror: 0.0043} + - {label: 'UnfoldOtherGen', symerror: -0.0008} + - {label: 'UnfoldReweight', symerror: -0.0147} + value: 1.4349 + - errors: + - {label: 'Stat', symerror: 0.0006} + - {label: 'JetScaleEff1', asymerror: {plus: -0.0019, minus: 0.0010}} + - {label: 'JetScaleEff2', asymerror: {plus: -0.0001, minus: 0.0009}} + - {label: 'JetScaleEff3', asymerror: {plus: 0.0005, minus: 0.0002}} + - {label: 'JetScaleEff4', asymerror: {plus: 0.0004, minus: 0.0004}} + - {label: 'JetScaleEff5', asymerror: {plus: 0.0003, minus: 0.0006}} + - {label: 'JetScaleEff6', asymerror: {plus: 0.0004, minus: 0.0003}} + - {label: 'JetScaleEta1', asymerror: {plus: 0.0001, minus: 0.0002}} + - {label: 'JetScaleEta2', asymerror: {plus: 0.0005, minus: 0.0009}} + - {label: 'JetScaleHighPt', asymerror: {plus: 0.0003, minus: 0.0003}} + - {label: 'JetScaleMC', asymerror: {plus: 0.0005, minus: 0.0004}} + - {label: 'JetScalePileup1', asymerror: {plus: -0.0009, minus: -0.0001}} + - {label: 'JetScalePileup2', asymerror: {plus: -0.0002, minus: 0.0010}} + - {label: 'JetScalePileup3', asymerror: {plus: 0.00004, minus: -0.0001}} + - {label: 'JetScalePileup4', asymerror: {plus: -0.0010, minus: -0.00003}} + - {label: 'JetScaleFlav1Known', asymerror: {plus: -0.0001, minus: -0.0001}} + - {label: 'JetScaleFlav2', asymerror: {plus: 0.0006, minus: -0.0018}} + - {label: 'JetScaleBjet', asymerror: {plus: 0.0001, minus: 0.0001}} + - {label: 'JetScalepunchT', asymerror: {plus: -0.000003, minus: 0.0001}} + - {label: 'JetResolution10', symerror: -0.0073} + - {label: 'JetSFBeff', asymerror: {plus: 0.0008, minus: -0.0004}} + - {label: 'JetSFCeff', asymerror: {plus: 0.0011, minus: -0.0004}} + - {label: 'JetSFLmistag', asymerror: {plus: 0.0002, minus: 0.0003}} + - {label: 'JetSFHighPt', asymerror: {plus: 0.0003, minus: 0.0002}} + - {label: 'JetJVFcut', asymerror: {plus: 0.0019, minus: 0.0010}} + - {label: 'ElScaleR12', asymerror: {plus: -0.0011, minus: 0.0010}} + - {label: 'ElScaleZee', asymerror: {plus: -0.0013, minus: 0.0011}} + - {label: 'ElScalePS', asymerror: {plus: 0.0001, minus: 0.000005}} + - {label: 'ElResolution', symerror: -0.0010} + - {label: 'ElSFReco', asymerror: {plus: 0.0003, minus: 0.00002}} + - {label: 'ElSFId', asymerror: {plus: 0.0008, minus: -0.0003}} + - {label: 'ElSFTrigger', asymerror: {plus: 0.0007, minus: -0.0005}} + - {label: 'ElSFIso', asymerror: {plus: 0.0003, minus: 0.00002}} + - {label: 'ElSFChargeMisID', asymerror: {plus: 0.00004, minus: 0.0001}} + - {label: 'METScale', asymerror: {plus: 0.0044, minus: -0.0056}} + - {label: 'METResLong', symerror: 0.0051} + - {label: 'METResTrans', symerror: 0.0044} + - {label: 'PileupWeight', asymerror: {plus: -0.0012, minus: 0.0013}} + - {label: 'QCDlowRange', asymerror: {plus: 0.0013, minus: -0.0037}} + - {label: 'QCDhighRange', asymerror: {plus: 0.0003, minus: 0.0006}} + - {label: 'QCDvarIso', symerror: -0.0003} + - {label: 'QCDvarElID', symerror: -0.0068} + - {label: 'QCDfitUncert', symerror: 0.0029} + - {label: 'QCDotherGen', symerror: -0.0144} + - {label: 'QCDfitRebin', symerror: -0.00004} + - {label: 'XsecZ', asymerror: {plus: 0.0006, minus: -0.0006}} + - {label: 'XsecTop', asymerror: {plus: -0.0004, minus: 0.0004}} + - {label: 'XsecDibos', asymerror: {plus: -0.0002, minus: 0.0002}} + - {label: 'BkgTtbarNorm', symerror: 0.0005} + - {label: 'BkgMCstat', symerror: 0.0009} + - {label: 'WHFmodel', symerror: -0.0042} + - {label: 'LumiUncert', asymerror: {plus: -0.0003, minus: 0.0004}} + - {label: 'UnfoldMCstat', symerror: 0.0026} + - {label: 'UnfoldOtherGen', symerror: 0.0081} + - {label: 'UnfoldReweight', symerror: 0.0068} + value: 1.3979 + - errors: + - {label: 'Stat', symerror: 0.0008} + - {label: 'JetScaleEff1', asymerror: {plus: -0.0016, minus: 0.0002}} + - {label: 'JetScaleEff2', asymerror: {plus: -0.00001, minus: 0.0003}} + - {label: 'JetScaleEff3', asymerror: {plus: 0.0002, minus: -0.00004}} + - {label: 'JetScaleEff4', asymerror: {plus: 0.0007, minus: 0.00003}} + - {label: 'JetScaleEff5', asymerror: {plus: 0.0003, minus: 0.0003}} + - {label: 'JetScaleEff6', asymerror: {plus: 0.0002, minus: 0.0003}} + - {label: 'JetScaleEta1', asymerror: {plus: 0.0003, minus: -0.0006}} + - {label: 'JetScaleEta2', asymerror: {plus: 0.0001, minus: 0.0002}} + - {label: 'JetScaleHighPt', asymerror: {plus: 0.0003, minus: 0.0003}} + - {label: 'JetScaleMC', asymerror: {plus: 0.0005, minus: 0.0004}} + - {label: 'JetScalePileup1', asymerror: {plus: -0.0006, minus: -0.0002}} + - {label: 'JetScalePileup2', asymerror: {plus: -0.0011, minus: 0.0002}} + - {label: 'JetScalePileup3', asymerror: {plus: 0.0003, minus: -0.0007}} + - {label: 'JetScalePileup4', asymerror: {plus: -0.0009, minus: -0.0004}} + - {label: 'JetScaleFlav1Known', asymerror: {plus: -0.0004, minus: -0.0001}} + - {label: 'JetScaleFlav2', asymerror: {plus: -0.0004, minus: -0.0014}} + - {label: 'JetScaleBjet', asymerror: {plus: 0.0001, minus: 0.0001}} + - {label: 'JetScalepunchT', asymerror: {plus: -0.000003, minus: 0.0001}} + - {label: 'JetResolution10', symerror: -0.0069} + - {label: 'JetSFBeff', asymerror: {plus: 0.0010, minus: -0.0008}} + - {label: 'JetSFCeff', asymerror: {plus: 0.0010, minus: -0.0008}} + - {label: 'JetSFLmistag', asymerror: {plus: 0.0001, minus: -0.0001}} + - {label: 'JetSFHighPt', asymerror: {plus: 0.0003, minus: 0.0002}} + - {label: 'JetJVFcut', asymerror: {plus: 0.0017, minus: 0.0012}} + - {label: 'ElScaleR12', asymerror: {plus: -0.0018, minus: 0.0015}} + - {label: 'ElScaleZee', asymerror: {plus: -0.0013, minus: 0.0012}} + - {label: 'ElScalePS', asymerror: {plus: 0.0001, minus: 0.00001}} + - {label: 'ElResolution', symerror: -0.0002} + - {label: 'ElSFReco', asymerror: {plus: 0.0001, minus: 0.0001}} + - {label: 'ElSFId', asymerror: {plus: 0.0001, minus: -0.00002}} + - {label: 'ElSFTrigger', asymerror: {plus: 0.0006, minus: -0.0006}} + - {label: 'ElSFIso', asymerror: {plus: 0.0001, minus: -0.0001}} + - {label: 'ElSFChargeMisID', asymerror: {plus: 0.00004, minus: 0.0001}} + - {label: 'METScale', asymerror: {plus: 0.0046, minus: -0.0054}} + - {label: 'METResLong', symerror: 0.0049} + - {label: 'METResTrans', symerror: 0.0040} + - {label: 'PileupWeight', asymerror: {plus: -0.0013, minus: 0.0011}} + - {label: 'QCDlowRange', asymerror: {plus: 0.0014, minus: -0.0025}} + - {label: 'QCDhighRange', asymerror: {plus: 0.0004, minus: 0.0005}} + - {label: 'QCDvarIso', symerror: 0.0004} + - {label: 'QCDvarElID', symerror: 0.0026} + - {label: 'QCDfitUncert', symerror: 0.0026} + - {label: 'QCDotherGen', symerror: -0.0123} + - {label: 'QCDfitRebin', symerror: 0.00004} + - {label: 'XsecZ', asymerror: {plus: 0.0002, minus: -0.0002}} + - {label: 'XsecTop', asymerror: {plus: -0.0005, minus: 0.0005}} + - {label: 'XsecDibos', asymerror: {plus: -0.0002, minus: 0.0002}} + - {label: 'BkgTtbarNorm', symerror: 0.0006} + - {label: 'BkgMCstat', symerror: 0.0011} + - {label: 'WHFmodel', symerror: -0.00005} + - {label: 'LumiUncert', asymerror: {plus: -0.0004, minus: 0.0004}} + - {label: 'UnfoldMCstat', symerror: 0.0030} + - {label: 'UnfoldOtherGen', symerror: 0.0065} + - {label: 'UnfoldReweight', symerror: 0.0057} + value: 1.4182 + - errors: + - {label: 'Stat', symerror: 0.0016} + - {label: 'JetScaleEff1', asymerror: {plus: -0.0025, minus: 0.0025}} + - {label: 'JetScaleEff2', asymerror: {plus: 0.0001, minus: 0.0017}} + - {label: 'JetScaleEff3', asymerror: {plus: 0.0004, minus: -0.0003}} + - {label: 'JetScaleEff4', asymerror: {plus: -0.0003, minus: 0.0005}} + - {label: 'JetScaleEff5', asymerror: {plus: 0.0003, minus: 0.0003}} + - {label: 'JetScaleEff6', asymerror: {plus: -0.0002, minus: 0.0004}} + - {label: 'JetScaleEta1', asymerror: {plus: 0.0008, minus: -0.0006}} + - {label: 'JetScaleEta2', asymerror: {plus: -0.0002, minus: 0.0008}} + - {label: 'JetScaleHighPt', asymerror: {plus: 0.0003, minus: 0.0004}} + - {label: 'JetScaleMC', asymerror: {plus: 0.0005, minus: 0.0004}} + - {label: 'JetScalePileup1', asymerror: {plus: -0.0006, minus: -0.0002}} + - {label: 'JetScalePileup2', asymerror: {plus: -0.0002, minus: -0.0002}} + - {label: 'JetScalePileup3', asymerror: {plus: 0.0002, minus: 0.0003}} + - {label: 'JetScalePileup4', asymerror: {plus: -0.0016, minus: 0.0013}} + - {label: 'JetScaleFlav1Known', asymerror: {plus: -0.0001, minus: 0.0010}} + - {label: 'JetScaleFlav2', asymerror: {plus: 0.0016, minus: -0.0022}} + - {label: 'JetScaleBjet', asymerror: {plus: 0.0001, minus: 0.0001}} + - {label: 'JetScalepunchT', asymerror: {plus: -0.000003, minus: 0.0001}} + - {label: 'JetResolution10', symerror: -0.0075} + - {label: 'JetSFBeff', asymerror: {plus: 0.0015, minus: -0.0016}} + - {label: 'JetSFCeff', asymerror: {plus: 0.0012, minus: -0.0014}} + - {label: 'JetSFLmistag', asymerror: {plus: -0.0001, minus: -0.0003}} + - {label: 'JetSFHighPt', asymerror: {plus: 0.0003, minus: 0.0002}} + - {label: 'JetJVFcut', asymerror: {plus: 0.0014, minus: 0.0018}} + - {label: 'ElScaleR12', asymerror: {plus: -0.0023, minus: 0.0019}} + - {label: 'ElScaleZee', asymerror: {plus: -0.0013, minus: 0.0007}} + - {label: 'ElScalePS', asymerror: {plus: 0.0001, minus: -0.0013}} + - {label: 'ElResolution', symerror: -0.0002} + - {label: 'ElSFReco', asymerror: {plus: -0.0005, minus: 0.0006}} + - {label: 'ElSFId', asymerror: {plus: -0.0007, minus: 0.0007}} + - {label: 'ElSFTrigger', asymerror: {plus: 0.0003, minus: -0.0007}} + - {label: 'ElSFIso', asymerror: {plus: -0.0001, minus: 0.0001}} + - {label: 'ElSFChargeMisID', asymerror: {plus: 0.00004, minus: 0.0001}} + - {label: 'METScale', asymerror: {plus: 0.0061, minus: -0.0056}} + - {label: 'METResLong', symerror: 0.0071} + - {label: 'METResTrans', symerror: 0.0060} + - {label: 'PileupWeight', asymerror: {plus: -0.0009, minus: 0.0007}} + - {label: 'QCDlowRange', asymerror: {plus: 0.0014, minus: -0.0014}} + - {label: 'QCDhighRange', asymerror: {plus: 0.0005, minus: 0.0004}} + - {label: 'QCDvarIso', symerror: 0.0006} + - {label: 'QCDvarElID', symerror: -0.0049} + - {label: 'QCDfitUncert', symerror: 0.0025} + - {label: 'QCDotherGen', symerror: -0.0103} + - {label: 'QCDfitRebin', symerror: 0.0001} + - {label: 'XsecZ', asymerror: {plus: -0.0001, minus: 0.0001}} + - {label: 'XsecTop', asymerror: {plus: -0.0010, minus: 0.0010}} + - {label: 'XsecDibos', asymerror: {plus: -0.0003, minus: 0.0003}} + - {label: 'BkgTtbarNorm', symerror: 0.0012} + - {label: 'BkgMCstat', symerror: 0.0015} + - {label: 'WHFmodel', symerror: 0.0057} + - {label: 'LumiUncert', asymerror: {plus: -0.0005, minus: 0.0006}} + - {label: 'UnfoldMCstat', symerror: 0.0039} + - {label: 'UnfoldOtherGen', symerror: 0.0106} + - {label: 'UnfoldReweight', symerror: -0.0010} + value: 1.4507 + - errors: + - {label: 'Stat', symerror: 0.0028} + - {label: 'JetScaleEff1', asymerror: {plus: -0.0024, minus: 0.0019}} + - {label: 'JetScaleEff2', asymerror: {plus: -0.0001, minus: -0.0060}} + - {label: 'JetScaleEff3', asymerror: {plus: 0.00002, minus: -0.0008}} + - {label: 'JetScaleEff4', asymerror: {plus: -0.0009, minus: -0.0001}} + - {label: 'JetScaleEff5', asymerror: {plus: 0.0003, minus: 0.0004}} + - {label: 'JetScaleEff6', asymerror: {plus: -0.0005, minus: -0.0002}} + - {label: 'JetScaleEta1', asymerror: {plus: 0.0004, minus: -0.0009}} + - {label: 'JetScaleEta2', asymerror: {plus: -0.0006, minus: -0.0002}} + - {label: 'JetScaleHighPt', asymerror: {plus: 0.0003, minus: 0.0004}} + - {label: 'JetScaleMC', asymerror: {plus: 0.0005, minus: 0.0004}} + - {label: 'JetScalePileup1', asymerror: {plus: -0.0006, minus: -0.0002}} + - {label: 'JetScalePileup2', asymerror: {plus: -0.0001, minus: -0.0013}} + - {label: 'JetScalePileup3', asymerror: {plus: -0.0011, minus: -0.0006}} + - {label: 'JetScalePileup4', asymerror: {plus: -0.0023, minus: 0.0005}} + - {label: 'JetScaleFlav1Known', asymerror: {plus: -0.0001, minus: 0.0002}} + - {label: 'JetScaleFlav2', asymerror: {plus: 0.0005, minus: -0.0022}} + - {label: 'JetScaleBjet', asymerror: {plus: 0.0001, minus: 0.0001}} + - {label: 'JetScalepunchT', asymerror: {plus: -0.000003, minus: 0.0001}} + - {label: 'JetResolution10', symerror: -0.0081} + - {label: 'JetSFBeff', asymerror: {plus: 0.0025, minus: -0.0033}} + - {label: 'JetSFCeff', asymerror: {plus: 0.0007, minus: -0.0023}} + - {label: 'JetSFLmistag', asymerror: {plus: -0.0003, minus: -0.0009}} + - {label: 'JetSFHighPt', asymerror: {plus: 0.0003, minus: 0.0002}} + - {label: 'JetJVFcut', asymerror: {plus: 0.0012, minus: 0.0017}} + - {label: 'ElScaleR12', asymerror: {plus: -0.0022, minus: 0.0010}} + - {label: 'ElScaleZee', asymerror: {plus: -0.0020, minus: 0.0002}} + - {label: 'ElScalePS', asymerror: {plus: 0.0001, minus: -0.0013}} + - {label: 'ElResolution', symerror: -0.0002} + - {label: 'ElSFReco', asymerror: {plus: -0.0015, minus: 0.0004}} + - {label: 'ElSFId', asymerror: {plus: -0.0018, minus: 0.0010}} + - {label: 'ElSFTrigger', asymerror: {plus: -0.0004, minus: -0.0007}} + - {label: 'ElSFIso', asymerror: {plus: -0.0004, minus: -0.0004}} + - {label: 'ElSFChargeMisID', asymerror: {plus: 0.00004, minus: 0.0001}} + - {label: 'METScale', asymerror: {plus: 0.0071, minus: -0.0067}} + - {label: 'METResLong', symerror: 0.0048} + - {label: 'METResTrans', symerror: 0.0051} + - {label: 'PileupWeight', asymerror: {plus: -0.0020, minus: 0.0004}} + - {label: 'QCDlowRange', asymerror: {plus: 0.0011, minus: -0.0009}} + - {label: 'QCDhighRange', asymerror: {plus: 0.0004, minus: 0.0003}} + - {label: 'QCDvarIso', symerror: 0.0023} + - {label: 'QCDvarElID', symerror: -0.0010} + - {label: 'QCDfitUncert', symerror: 0.0021} + - {label: 'QCDotherGen', symerror: -0.0075} + - {label: 'QCDfitRebin', symerror: 0.0001} + - {label: 'XsecZ', asymerror: {plus: -0.0003, minus: 0.0003}} + - {label: 'XsecTop', asymerror: {plus: -0.0015, minus: 0.0015}} + - {label: 'XsecDibos', asymerror: {plus: -0.0003, minus: 0.0003}} + - {label: 'BkgTtbarNorm', symerror: 0.0018} + - {label: 'BkgMCstat', symerror: 0.0021} + - {label: 'WHFmodel', symerror: 0.0114} + - {label: 'LumiUncert', asymerror: {plus: -0.0007, minus: 0.0008}} + - {label: 'UnfoldMCstat', symerror: 0.0061} + - {label: 'UnfoldOtherGen', symerror: 0.0198} + - {label: 'UnfoldReweight', symerror: -0.0011} + value: 1.4825 + - errors: + - {label: 'Stat', symerror: 0.0044} + - {label: 'JetScaleEff1', asymerror: {plus: -0.0043, minus: 0.0052}} + - {label: 'JetScaleEff2', asymerror: {plus: -0.0019, minus: 0.000005}} + - {label: 'JetScaleEff3', asymerror: {plus: 0.0002, minus: -0.0023}} + - {label: 'JetScaleEff4', asymerror: {plus: -0.0009, minus: -0.0005}} + - {label: 'JetScaleEff5', asymerror: {plus: -0.0075, minus: 0.0004}} + - {label: 'JetScaleEff6', asymerror: {plus: -0.0007, minus: -0.0006}} + - {label: 'JetScaleEta1', asymerror: {plus: -0.0001, minus: -0.0012}} + - {label: 'JetScaleEta2', asymerror: {plus: -0.0015, minus: 0.0001}} + - {label: 'JetScaleHighPt', asymerror: {plus: 0.0003, minus: 0.0004}} + - {label: 'JetScaleMC', asymerror: {plus: 0.0005, minus: 0.0004}} + - {label: 'JetScalePileup1', asymerror: {plus: -0.0006, minus: -0.0002}} + - {label: 'JetScalePileup2', asymerror: {plus: -0.0001, minus: -0.0013}} + - {label: 'JetScalePileup3', asymerror: {plus: -0.0017, minus: 0.0001}} + - {label: 'JetScalePileup4', asymerror: {plus: -0.0030, minus: 0.0026}} + - {label: 'JetScaleFlav1Known', asymerror: {plus: -0.0008, minus: -0.0007}} + - {label: 'JetScaleFlav2', asymerror: {plus: 0.0038, minus: -0.0041}} + - {label: 'JetScaleBjet', asymerror: {plus: 0.0001, minus: 0.0001}} + - {label: 'JetScalepunchT', asymerror: {plus: -0.000003, minus: 0.0001}} + - {label: 'JetResolution10', symerror: -0.0094} + - {label: 'JetSFBeff', asymerror: {plus: 0.0037, minus: -0.0041}} + - {label: 'JetSFCeff', asymerror: {plus: 0.0013, minus: -0.0024}} + - {label: 'JetSFLmistag', asymerror: {plus: -0.0008, minus: -0.0009}} + - {label: 'JetSFHighPt', asymerror: {plus: 0.0003, minus: 0.0002}} + - {label: 'JetJVFcut', asymerror: {plus: 0.0018, minus: 0.0023}} + - {label: 'ElScaleR12', asymerror: {plus: -0.0013, minus: 0.0011}} + - {label: 'ElScaleZee', asymerror: {plus: -0.0007, minus: -0.0005}} + - {label: 'ElScalePS', asymerror: {plus: 0.0001, minus: -0.0013}} + - {label: 'ElResolution', symerror: -0.0002} + - {label: 'ElSFReco', asymerror: {plus: -0.0014, minus: 0.00005}} + - {label: 'ElSFId', asymerror: {plus: -0.0022, minus: 0.0017}} + - {label: 'ElSFTrigger', asymerror: {plus: -0.0006, minus: -0.0004}} + - {label: 'ElSFIso', asymerror: {plus: -0.0008, minus: -0.0006}} + - {label: 'ElSFChargeMisID', asymerror: {plus: 0.00004, minus: 0.0001}} + - {label: 'METScale', asymerror: {plus: 0.0085, minus: -0.0097}} + - {label: 'METResLong', symerror: 0.0066} + - {label: 'METResTrans', symerror: 0.0069} + - {label: 'PileupWeight', asymerror: {plus: -0.0020, minus: 0.0004}} + - {label: 'QCDlowRange', asymerror: {plus: 0.0008, minus: -0.0008}} + - {label: 'QCDhighRange', asymerror: {plus: 0.0004, minus: 0.0003}} + - {label: 'QCDvarIso', symerror: 0.0028} + - {label: 'QCDvarElID', symerror: 0.0008} + - {label: 'QCDfitUncert', symerror: 0.0020} + - {label: 'QCDotherGen', symerror: -0.0060} + - {label: 'QCDfitRebin', symerror: 0.0001} + - {label: 'XsecZ', asymerror: {plus: -0.0001, minus: 0.0001}} + - {label: 'XsecTop', asymerror: {plus: -0.0021, minus: 0.0022}} + - {label: 'XsecDibos', asymerror: {plus: -0.0003, minus: 0.0003}} + - {label: 'BkgTtbarNorm', symerror: 0.0025} + - {label: 'BkgMCstat', symerror: 0.0029} + - {label: 'WHFmodel', symerror: 0.0098} + - {label: 'LumiUncert', asymerror: {plus: -0.0008, minus: 0.0008}} + - {label: 'UnfoldMCstat', symerror: 0.0084} + - {label: 'UnfoldOtherGen', symerror: -0.0095} + - {label: 'UnfoldReweight', symerror: -0.0011} + value: 1.5074 + - errors: + - {label: 'Stat', symerror: 0.0092} + - {label: 'JetScaleEff1', asymerror: {plus: -0.0053, minus: 0.0029}} + - {label: 'JetScaleEff2', asymerror: {plus: -0.0030, minus: -0.0005}} + - {label: 'JetScaleEff3', asymerror: {plus: 0.0007, minus: -0.0044}} + - {label: 'JetScaleEff4', asymerror: {plus: -0.0009, minus: -0.0005}} + - {label: 'JetScaleEff5', asymerror: {plus: -0.0077, minus: -0.0085}} + - {label: 'JetScaleEff6', asymerror: {plus: -0.0007, minus: -0.0006}} + - {label: 'JetScaleEta1', asymerror: {plus: 0.0003, minus: -0.0011}} + - {label: 'JetScaleEta2', asymerror: {plus: -0.0014, minus: -0.0011}} + - {label: 'JetScaleHighPt', asymerror: {plus: 0.0003, minus: 0.0004}} + - {label: 'JetScaleMC', asymerror: {plus: 0.0005, minus: 0.0004}} + - {label: 'JetScalePileup1', asymerror: {plus: -0.0007, minus: -0.0002}} + - {label: 'JetScalePileup2', asymerror: {plus: -0.0001, minus: -0.0014}} + - {label: 'JetScalePileup3', asymerror: {plus: -0.0006, minus: 0.0002}} + - {label: 'JetScalePileup4', asymerror: {plus: -0.0016, minus: 0.0006}} + - {label: 'JetScaleFlav1Known', asymerror: {plus: -0.0021, minus: 0.0008}} + - {label: 'JetScaleFlav2', asymerror: {plus: 0.0040, minus: -0.0034}} + - {label: 'JetScaleBjet', asymerror: {plus: 0.0001, minus: 0.0001}} + - {label: 'JetScalepunchT', asymerror: {plus: -0.000003, minus: 0.0001}} + - {label: 'JetResolution10', symerror: -0.0058} + - {label: 'JetSFBeff', asymerror: {plus: 0.0051, minus: -0.0060}} + - {label: 'JetSFCeff', asymerror: {plus: 0.0014, minus: -0.0024}} + - {label: 'JetSFLmistag', asymerror: {plus: -0.0008, minus: -0.0009}} + - {label: 'JetSFHighPt', asymerror: {plus: 0.0003, minus: 0.0002}} + - {label: 'JetJVFcut', asymerror: {plus: 0.0046, minus: 0.0024}} + - {label: 'ElScaleR12', asymerror: {plus: -0.0013, minus: 0.0012}} + - {label: 'ElScaleZee', asymerror: {plus: -0.0009, minus: 0.0011}} + - {label: 'ElScalePS', asymerror: {plus: 0.0001, minus: -0.0014}} + - {label: 'ElResolution', symerror: -0.0002} + - {label: 'ElSFReco', asymerror: {plus: -0.0018, minus: 0.0005}} + - {label: 'ElSFId', asymerror: {plus: -0.0028, minus: 0.0025}} + - {label: 'ElSFTrigger', asymerror: {plus: -0.0018, minus: 0.0005}} + - {label: 'ElSFIso', asymerror: {plus: -0.0008, minus: -0.0006}} + - {label: 'ElSFChargeMisID', asymerror: {plus: 0.00005, minus: 0.0001}} + - {label: 'METScale', asymerror: {plus: 0.0103, minus: -0.0099}} + - {label: 'METResLong', symerror: 0.0098} + - {label: 'METResTrans', symerror: 0.0109} + - {label: 'PileupWeight', asymerror: {plus: -0.0021, minus: 0.0004}} + - {label: 'QCDlowRange', asymerror: {plus: 0.0008, minus: -0.0009}} + - {label: 'QCDhighRange', asymerror: {plus: 0.0004, minus: 0.0003}} + - {label: 'QCDvarIso', symerror: 0.0022} + - {label: 'QCDvarElID', symerror: 0.0009} + - {label: 'QCDfitUncert', symerror: 0.0021} + - {label: 'QCDotherGen', symerror: -0.0059} + - {label: 'QCDfitRebin', symerror: 0.0002} + - {label: 'XsecZ', asymerror: {plus: -0.0003, minus: 0.0003}} + - {label: 'XsecTop', asymerror: {plus: -0.0029, minus: 0.0030}} + - {label: 'XsecDibos', asymerror: {plus: -0.0004, minus: 0.0004}} + - {label: 'BkgTtbarNorm', symerror: 0.0033} + - {label: 'BkgMCstat', symerror: 0.0040} + - {label: 'WHFmodel', symerror: 0.0119} + - {label: 'LumiUncert', asymerror: {plus: -0.0010, minus: 0.0011}} + - {label: 'UnfoldMCstat', symerror: 0.0115} + - {label: 'UnfoldOtherGen', symerror: 0.0069} + - {label: 'UnfoldReweight', symerror: -0.0011} + value: 1.5605 + - errors: + - {label: 'Stat', symerror: 0.0124} + - {label: 'JetScaleEff1', asymerror: {plus: -0.0053, minus: 0.0039}} + - {label: 'JetScaleEff2', asymerror: {plus: -0.0022, minus: 0.0032}} + - {label: 'JetScaleEff3', asymerror: {plus: 0.0005, minus: -0.0004}} + - {label: 'JetScaleEff4', asymerror: {plus: -0.0010, minus: -0.0005}} + - {label: 'JetScaleEff5', asymerror: {plus: -0.0079, minus: -0.0086}} + - {label: 'JetScaleEff6', asymerror: {plus: -0.0007, minus: -0.0006}} + - {label: 'JetScaleEta1', asymerror: {plus: -0.0011, minus: 0.0006}} + - {label: 'JetScaleEta2', asymerror: {plus: 0.0001, minus: 0.0015}} + - {label: 'JetScaleHighPt', asymerror: {plus: 0.0003, minus: 0.0004}} + - {label: 'JetScaleMC', asymerror: {plus: 0.0006, minus: 0.0004}} + - {label: 'JetScalePileup1', asymerror: {plus: -0.0007, minus: -0.0002}} + - {label: 'JetScalePileup2', asymerror: {plus: -0.0001, minus: -0.0014}} + - {label: 'JetScalePileup3', asymerror: {plus: -0.0006, minus: 0.0002}} + - {label: 'JetScalePileup4', asymerror: {plus: 0.0025, minus: 0.0019}} + - {label: 'JetScaleFlav1Known', asymerror: {plus: -0.0022, minus: 0.0008}} + - {label: 'JetScaleFlav2', asymerror: {plus: 0.0070, minus: -0.0034}} + - {label: 'JetScaleBjet', asymerror: {plus: 0.0001, minus: 0.0001}} + - {label: 'JetScalepunchT', asymerror: {plus: -0.000003, minus: 0.0001}} + - {label: 'JetResolution10', symerror: -0.0013} + - {label: 'JetSFBeff', asymerror: {plus: 0.0067, minus: -0.0077}} + - {label: 'JetSFCeff', asymerror: {plus: 0.0014, minus: -0.0025}} + - {label: 'JetSFLmistag', asymerror: {plus: -0.0008, minus: -0.0009}} + - {label: 'JetSFHighPt', asymerror: {plus: 0.0003, minus: 0.0002}} + - {label: 'JetJVFcut', asymerror: {plus: 0.0051, minus: 0.0050}} + - {label: 'ElScaleR12', asymerror: {plus: -0.0013, minus: 0.0012}} + - {label: 'ElScaleZee', asymerror: {plus: -0.0009, minus: 0.0012}} + - {label: 'ElScalePS', asymerror: {plus: 0.0001, minus: -0.0014}} + - {label: 'ElResolution', symerror: -0.0002} + - {label: 'ElSFReco', asymerror: {plus: -0.0018, minus: 0.0005}} + - {label: 'ElSFId', asymerror: {plus: -0.0022, minus: 0.0043}} + - {label: 'ElSFTrigger', asymerror: {plus: -0.0013, minus: 0.0006}} + - {label: 'ElSFIso', asymerror: {plus: -0.0009, minus: -0.0006}} + - {label: 'ElSFChargeMisID', asymerror: {plus: 0.00005, minus: 0.0001}} + - {label: 'METScale', asymerror: {plus: 0.0123, minus: -0.0097}} + - {label: 'METResLong', symerror: 0.0109} + - {label: 'METResTrans', symerror: 0.0095} + - {label: 'PileupWeight', asymerror: {plus: -0.0021, minus: 0.0004}} + - {label: 'QCDlowRange', asymerror: {plus: 0.0008, minus: -0.0011}} + - {label: 'QCDhighRange', asymerror: {plus: 0.0004, minus: 0.0003}} + - {label: 'QCDvarIso', symerror: 0.0045} + - {label: 'QCDvarElID', symerror: 0.0009} + - {label: 'QCDfitUncert', symerror: 0.0021} + - {label: 'QCDotherGen', symerror: -0.0060} + - {label: 'QCDfitRebin', symerror: 0.0001} + - {label: 'XsecZ', asymerror: {plus: -0.0005, minus: 0.0005}} + - {label: 'XsecTop', asymerror: {plus: -0.0037, minus: 0.0038}} + - {label: 'XsecDibos', asymerror: {plus: -0.0004, minus: 0.0004}} + - {label: 'BkgTtbarNorm', symerror: 0.0041} + - {label: 'BkgMCstat', symerror: 0.0053} + - {label: 'WHFmodel', symerror: 0.0111} + - {label: 'LumiUncert', asymerror: {plus: -0.0013, minus: 0.0015}} + - {label: 'UnfoldMCstat', symerror: 0.0158} + - {label: 'UnfoldOtherGen', symerror: -0.0336} + - {label: 'UnfoldReweight', symerror: -0.0011} + value: 1.5934 + - errors: + - {label: 'Stat', symerror: 0.0168} + - {label: 'JetScaleEff1', asymerror: {plus: -0.0010, minus: 0.0074}} + - {label: 'JetScaleEff2', asymerror: {plus: 0.0006, minus: 0.0040}} + - {label: 'JetScaleEff3', asymerror: {plus: 0.0042, minus: 0.0003}} + - {label: 'JetScaleEff4', asymerror: {plus: -0.0010, minus: -0.0005}} + - {label: 'JetScaleEff5', asymerror: {plus: -0.0082, minus: -0.0090}} + - {label: 'JetScaleEff6', asymerror: {plus: -0.0007, minus: -0.0006}} + - {label: 'JetScaleEta1', asymerror: {plus: -0.0014, minus: 0.0026}} + - {label: 'JetScaleEta2', asymerror: {plus: 0.0001, minus: 0.0016}} + - {label: 'JetScaleHighPt', asymerror: {plus: 0.0004, minus: 0.0004}} + - {label: 'JetScaleMC', asymerror: {plus: 0.0006, minus: 0.0005}} + - {label: 'JetScalePileup1', asymerror: {plus: -0.0007, minus: -0.0002}} + - {label: 'JetScalePileup2', asymerror: {plus: -0.0001, minus: -0.0015}} + - {label: 'JetScalePileup3', asymerror: {plus: -0.0006, minus: 0.0002}} + - {label: 'JetScalePileup4', asymerror: {plus: -0.0015, minus: -0.0007}} + - {label: 'JetScaleFlav1Known', asymerror: {plus: -0.0023, minus: 0.0008}} + - {label: 'JetScaleFlav2', asymerror: {plus: 0.0073, minus: -0.0021}} + - {label: 'JetScaleBjet', asymerror: {plus: 0.0001, minus: 0.0001}} + - {label: 'JetScalepunchT', asymerror: {plus: -0.000003, minus: 0.0001}} + - {label: 'JetResolution10', symerror: -0.0056} + - {label: 'JetSFBeff', asymerror: {plus: 0.0085, minus: -0.0093}} + - {label: 'JetSFCeff', asymerror: {plus: 0.0015, minus: -0.0026}} + - {label: 'JetSFLmistag', asymerror: {plus: -0.0008, minus: -0.0010}} + - {label: 'JetSFHighPt', asymerror: {plus: 0.0003, minus: 0.0002}} + - {label: 'JetJVFcut', asymerror: {plus: 0.0053, minus: 0.0052}} + - {label: 'ElScaleR12', asymerror: {plus: -0.0014, minus: 0.0012}} + - {label: 'ElScaleZee', asymerror: {plus: -0.0010, minus: 0.0012}} + - {label: 'ElScalePS', asymerror: {plus: 0.0001, minus: -0.0014}} + - {label: 'ElResolution', symerror: -0.0002} + - {label: 'ElSFReco', asymerror: {plus: -0.0019, minus: 0.0005}} + - {label: 'ElSFId', asymerror: {plus: -0.0024, minus: 0.0042}} + - {label: 'ElSFTrigger', asymerror: {plus: -0.0013, minus: 0.0006}} + - {label: 'ElSFIso', asymerror: {plus: -0.0009, minus: -0.0006}} + - {label: 'ElSFChargeMisID', asymerror: {plus: 0.00005, minus: 0.0002}} + - {label: 'METScale', asymerror: {plus: 0.0062, minus: -0.0076}} + - {label: 'METResLong', symerror: 0.0099} + - {label: 'METResTrans', symerror: 0.0120} + - {label: 'PileupWeight', asymerror: {plus: -0.0022, minus: 0.0004}} + - {label: 'QCDlowRange', asymerror: {plus: 0.0007, minus: -0.0009}} + - {label: 'QCDhighRange', asymerror: {plus: 0.0005, minus: 0.0003}} + - {label: 'QCDvarIso', symerror: 0.0046} + - {label: 'QCDvarElID', symerror: 0.0009} + - {label: 'QCDfitUncert', symerror: 0.0024} + - {label: 'QCDotherGen', symerror: -0.0059} + - {label: 'QCDfitRebin', symerror: 0.0002} + - {label: 'XsecZ', asymerror: {plus: -0.0004, minus: 0.0004}} + - {label: 'XsecTop', asymerror: {plus: -0.0045, minus: 0.0046}} + - {label: 'XsecDibos', asymerror: {plus: -0.0005, minus: 0.0005}} + - {label: 'BkgTtbarNorm', symerror: 0.0050} + - {label: 'BkgMCstat', symerror: 0.0075} + - {label: 'WHFmodel', symerror: 0.0032} + - {label: 'LumiUncert', asymerror: {plus: -0.0015, minus: 0.0017}} + - {label: 'UnfoldMCstat', symerror: 0.0192} + - {label: 'UnfoldOtherGen', symerror: -0.0003} + - {label: 'UnfoldReweight', symerror: -0.0012} + value: 1.6587 + - errors: + - {label: 'Stat', symerror: 0.0290} + - {label: 'JetScaleEff1', asymerror: {plus: -0.0059, minus: 0.0060}} + - {label: 'JetScaleEff2', asymerror: {plus: -0.0023, minus: 0.00001}} + - {label: 'JetScaleEff3', asymerror: {plus: 0.0044, minus: 0.0003}} + - {label: 'JetScaleEff4', asymerror: {plus: -0.0010, minus: -0.0005}} + - {label: 'JetScaleEff5', asymerror: {plus: -0.0086, minus: -0.0094}} + - {label: 'JetScaleEff6', asymerror: {plus: -0.0008, minus: -0.0007}} + - {label: 'JetScaleEta1', asymerror: {plus: -0.0014, minus: 0.0027}} + - {label: 'JetScaleEta2', asymerror: {plus: 0.0001, minus: 0.0017}} + - {label: 'JetScaleHighPt', asymerror: {plus: 0.0004, minus: 0.0004}} + - {label: 'JetScaleMC', asymerror: {plus: 0.0006, minus: 0.0005}} + - {label: 'JetScalePileup1', asymerror: {plus: -0.0007, minus: -0.0002}} + - {label: 'JetScalePileup2', asymerror: {plus: -0.0001, minus: -0.0015}} + - {label: 'JetScalePileup3', asymerror: {plus: -0.0007, minus: 0.0002}} + - {label: 'JetScalePileup4', asymerror: {plus: -0.0028, minus: 0.0029}} + - {label: 'JetScaleFlav1Known', asymerror: {plus: -0.0024, minus: 0.0008}} + - {label: 'JetScaleFlav2', asymerror: {plus: 0.0047, minus: -0.0044}} + - {label: 'JetScaleBjet', asymerror: {plus: 0.0001, minus: 0.0001}} + - {label: 'JetScalepunchT', asymerror: {plus: -0.000003, minus: 0.0001}} + - {label: 'JetResolution10', symerror: -0.0046} + - {label: 'JetSFBeff', asymerror: {plus: 0.0095, minus: -0.0124}} + - {label: 'JetSFCeff', asymerror: {plus: 0.0015, minus: -0.0027}} + - {label: 'JetSFLmistag', asymerror: {plus: -0.0009, minus: -0.0010}} + - {label: 'JetSFHighPt', asymerror: {plus: 0.0003, minus: 0.0002}} + - {label: 'JetJVFcut', asymerror: {plus: 0.0055, minus: 0.0055}} + - {label: 'ElScaleR12', asymerror: {plus: -0.0015, minus: 0.0013}} + - {label: 'ElScaleZee', asymerror: {plus: -0.0010, minus: 0.0013}} + - {label: 'ElScalePS', asymerror: {plus: 0.0001, minus: -0.0015}} + - {label: 'ElResolution', symerror: -0.0002} + - {label: 'ElSFReco', asymerror: {plus: -0.0020, minus: 0.0006}} + - {label: 'ElSFId', asymerror: {plus: -0.0015, minus: 0.0030}} + - {label: 'ElSFTrigger', asymerror: {plus: -0.0014, minus: 0.0007}} + - {label: 'ElSFIso', asymerror: {plus: -0.0009, minus: -0.0007}} + - {label: 'ElSFChargeMisID', asymerror: {plus: 0.0001, minus: 0.0002}} + - {label: 'METScale', asymerror: {plus: 0.0065, minus: -0.0079}} + - {label: 'METResLong', symerror: 0.0104} + - {label: 'METResTrans', symerror: 0.0125} + - {label: 'PileupWeight', asymerror: {plus: -0.0023, minus: 0.0004}} + - {label: 'QCDlowRange', asymerror: {plus: 0.0006, minus: -0.0002}} + - {label: 'QCDhighRange', asymerror: {plus: 0.0009, minus: -0.0001}} + - {label: 'QCDvarIso', symerror: 0.0049} + - {label: 'QCDvarElID', symerror: 0.0010} + - {label: 'QCDfitUncert', symerror: 0.0032} + - {label: 'QCDotherGen', symerror: -0.0054} + - {label: 'QCDfitRebin', symerror: 0.00003} + - {label: 'XsecZ', asymerror: {plus: -0.0007, minus: 0.0007}} + - {label: 'XsecTop', asymerror: {plus: -0.0055, minus: 0.0059}} + - {label: 'XsecDibos', asymerror: {plus: -0.0006, minus: 0.0006}} + - {label: 'BkgTtbarNorm', symerror: 0.0064} + - {label: 'BkgMCstat', symerror: 0.0130} + - {label: 'WHFmodel', symerror: 0.0136} + - {label: 'LumiUncert', asymerror: {plus: -0.0016, minus: 0.0017}} + - {label: 'UnfoldMCstat', symerror: 0.0308} + - {label: 'UnfoldOtherGen', symerror: 0.0119} + - {label: 'UnfoldReweight', symerror: -0.0012} + value: 1.7342 + - errors: + - {label: 'Stat', symerror: 0.0459} + - {label: 'JetScaleEff1', asymerror: {plus: -0.0062, minus: -0.0051}} + - {label: 'JetScaleEff2', asymerror: {plus: -0.0024, minus: 0.00001}} + - {label: 'JetScaleEff3', asymerror: {plus: 0.0046, minus: 0.0003}} + - {label: 'JetScaleEff4', asymerror: {plus: -0.0011, minus: -0.0006}} + - {label: 'JetScaleEff5', asymerror: {plus: -0.0090, minus: -0.0098}} + - {label: 'JetScaleEff6', asymerror: {plus: -0.0008, minus: -0.0007}} + - {label: 'JetScaleEta1', asymerror: {plus: -0.0015, minus: 0.0029}} + - {label: 'JetScaleEta2', asymerror: {plus: 0.0001, minus: 0.0018}} + - {label: 'JetScaleHighPt', asymerror: {plus: 0.0004, minus: 0.0004}} + - {label: 'JetScaleMC', asymerror: {plus: 0.0006, minus: 0.0005}} + - {label: 'JetScalePileup1', asymerror: {plus: -0.0008, minus: -0.0002}} + - {label: 'JetScalePileup2', asymerror: {plus: -0.0001, minus: -0.0016}} + - {label: 'JetScalePileup3', asymerror: {plus: -0.0007, minus: 0.0002}} + - {label: 'JetScalePileup4', asymerror: {plus: -0.0029, minus: 0.0030}} + - {label: 'JetScaleFlav1Known', asymerror: {plus: -0.0025, minus: 0.0009}} + - {label: 'JetScaleFlav2', asymerror: {plus: 0.0044, minus: -0.0078}} + - {label: 'JetScaleBjet', asymerror: {plus: 0.0001, minus: 0.0001}} + - {label: 'JetScalepunchT', asymerror: {plus: -0.000003, minus: 0.0001}} + - {label: 'JetResolution10', symerror: -0.0048} + - {label: 'JetSFBeff', asymerror: {plus: 0.0099, minus: -0.0130}} + - {label: 'JetSFCeff', asymerror: {plus: 0.0016, minus: -0.0028}} + - {label: 'JetSFLmistag', asymerror: {plus: -0.0009, minus: -0.0011}} + - {label: 'JetSFHighPt', asymerror: {plus: 0.0003, minus: 0.0003}} + - {label: 'JetJVFcut', asymerror: {plus: 0.0058, minus: 0.0057}} + - {label: 'ElScaleR12', asymerror: {plus: -0.0015, minus: 0.0014}} + - {label: 'ElScaleZee', asymerror: {plus: -0.0011, minus: 0.0013}} + - {label: 'ElScalePS', asymerror: {plus: 0.0001, minus: -0.0016}} + - {label: 'ElResolution', symerror: -0.0002} + - {label: 'ElSFReco', asymerror: {plus: -0.0021, minus: 0.0006}} + - {label: 'ElSFId', asymerror: {plus: -0.0016, minus: 0.0031}} + - {label: 'ElSFTrigger', asymerror: {plus: -0.0014, minus: 0.0007}} + - {label: 'ElSFIso', asymerror: {plus: -0.0010, minus: -0.0007}} + - {label: 'ElSFChargeMisID', asymerror: {plus: 0.0001, minus: 0.0002}} + - {label: 'METScale', asymerror: {plus: 0.0068, minus: -0.0083}} + - {label: 'METResLong', symerror: 0.0108} + - {label: 'METResTrans', symerror: 0.0131} + - {label: 'PileupWeight', asymerror: {plus: -0.0024, minus: 0.0005}} + - {label: 'QCDlowRange', asymerror: {plus: 0.0008, minus: -0.0016}} + - {label: 'QCDhighRange', asymerror: {plus: 0.0004, minus: 0.0003}} + - {label: 'QCDvarIso', symerror: 0.0051} + - {label: 'QCDvarElID', symerror: 0.0010} + - {label: 'QCDfitUncert', symerror: 0.0030} + - {label: 'QCDotherGen', symerror: -0.0067} + - {label: 'QCDfitRebin', symerror: 0.0003} + - {label: 'XsecZ', asymerror: {plus: -0.0002, minus: 0.0002}} + - {label: 'XsecTop', asymerror: {plus: -0.0061, minus: 0.0063}} + - {label: 'XsecDibos', asymerror: {plus: -0.0009, minus: 0.0009}} + - {label: 'BkgTtbarNorm', symerror: 0.0064} + - {label: 'BkgMCstat', symerror: 0.0187} + - {label: 'WHFmodel', symerror: 0.0155} + - {label: 'LumiUncert', asymerror: {plus: -0.0021, minus: 0.0023}} + - {label: 'UnfoldMCstat', symerror: 0.0494} + - {label: 'UnfoldOtherGen', symerror: 0.0124} + - {label: 'UnfoldReweight', symerror: -0.0013} + value: 1.8136 + - errors: + - {label: 'Stat', symerror: 0.0714} + - {label: 'JetScaleEff1', asymerror: {plus: -0.0153, minus: 0.0027}} + - {label: 'JetScaleEff2', asymerror: {plus: -0.0357, minus: -0.0163}} + - {label: 'JetScaleEff3', asymerror: {plus: 0.0049, minus: 0.0004}} + - {label: 'JetScaleEff4', asymerror: {plus: -0.0012, minus: -0.0006}} + - {label: 'JetScaleEff5', asymerror: {plus: -0.0096, minus: -0.0105}} + - {label: 'JetScaleEff6', asymerror: {plus: -0.0009, minus: -0.0007}} + - {label: 'JetScaleEta1', asymerror: {plus: -0.0016, minus: 0.0030}} + - {label: 'JetScaleEta2', asymerror: {plus: 0.0001, minus: 0.0019}} + - {label: 'JetScaleHighPt', asymerror: {plus: 0.0004, minus: 0.0005}} + - {label: 'JetScaleMC', asymerror: {plus: 0.0007, minus: 0.0005}} + - {label: 'JetScalePileup1', asymerror: {plus: -0.0008, minus: -0.0003}} + - {label: 'JetScalePileup2', asymerror: {plus: -0.0001, minus: -0.0017}} + - {label: 'JetScalePileup3', asymerror: {plus: -0.0008, minus: 0.0002}} + - {label: 'JetScalePileup4', asymerror: {plus: -0.0031, minus: 0.0032}} + - {label: 'JetScaleFlav1Known', asymerror: {plus: -0.0026, minus: 0.0009}} + - {label: 'JetScaleFlav2', asymerror: {plus: 0.0047, minus: -0.0084}} + - {label: 'JetScaleBjet', asymerror: {plus: 0.0002, minus: 0.0001}} + - {label: 'JetScalepunchT', asymerror: {plus: -0.000004, minus: 0.0001}} + - {label: 'JetResolution10', symerror: -0.0051} + - {label: 'JetSFBeff', asymerror: {plus: 0.0106, minus: -0.0138}} + - {label: 'JetSFCeff', asymerror: {plus: 0.0017, minus: -0.0030}} + - {label: 'JetSFLmistag', asymerror: {plus: -0.0010, minus: -0.0011}} + - {label: 'JetSFHighPt', asymerror: {plus: 0.0004, minus: 0.0003}} + - {label: 'JetJVFcut', asymerror: {plus: 0.0061, minus: 0.0061}} + - {label: 'ElScaleR12', asymerror: {plus: -0.0016, minus: 0.0014}} + - {label: 'ElScaleZee', asymerror: {plus: -0.0011, minus: 0.0014}} + - {label: 'ElScalePS', asymerror: {plus: 0.0001, minus: -0.0017}} + - {label: 'ElResolution', symerror: -0.0003} + - {label: 'ElSFReco', asymerror: {plus: -0.0022, minus: 0.0006}} + - {label: 'ElSFId', asymerror: {plus: -0.0017, minus: 0.0033}} + - {label: 'ElSFTrigger', asymerror: {plus: -0.0015, minus: 0.0008}} + - {label: 'ElSFIso', asymerror: {plus: -0.0010, minus: -0.0008}} + - {label: 'ElSFChargeMisID', asymerror: {plus: 0.0001, minus: 0.0002}} + - {label: 'METScale', asymerror: {plus: 0.0072, minus: -0.0089}} + - {label: 'METResLong', symerror: 0.0116} + - {label: 'METResTrans', symerror: 0.0140} + - {label: 'PileupWeight', asymerror: {plus: -0.0026, minus: 0.0005}} + - {label: 'QCDlowRange', asymerror: {plus: 0.0007, minus: 0.00004}} + - {label: 'QCDhighRange', asymerror: {plus: 0.0006, minus: 0.0001}} + - {label: 'QCDvarIso', symerror: 0.0054} + - {label: 'QCDvarElID', symerror: 0.0011} + - {label: 'QCDfitUncert', symerror: 0.0026} + - {label: 'QCDotherGen', symerror: -0.0052} + - {label: 'QCDfitRebin', symerror: 0.0001} + - {label: 'XsecZ', asymerror: {plus: -0.0015, minus: 0.0015}} + - {label: 'XsecTop', asymerror: {plus: -0.0076, minus: 0.0076}} + - {label: 'XsecDibos', asymerror: {plus: -0.0009, minus: 0.0009}} + - {label: 'BkgTtbarNorm', symerror: 0.0070} + - {label: 'BkgMCstat', symerror: 0.0305} + - {label: 'WHFmodel', symerror: 0.0225} + - {label: 'LumiUncert', asymerror: {plus: -0.0028, minus: 0.0030}} + - {label: 'UnfoldMCstat', symerror: 0.0749} + - {label: 'UnfoldOtherGen', symerror: 0.0132} + - {label: 'UnfoldReweight', symerror: -0.0014} + value: 1.9338 + - errors: + - {label: 'Stat', symerror: 0.1015} + - {label: 'JetScaleEff1', asymerror: {plus: -0.0159, minus: 0.0028}} + - {label: 'JetScaleEff2', asymerror: {plus: -0.0068, minus: 0.0443}} + - {label: 'JetScaleEff3', asymerror: {plus: 0.0051, minus: 0.0004}} + - {label: 'JetScaleEff4', asymerror: {plus: -0.0012, minus: -0.0006}} + - {label: 'JetScaleEff5', asymerror: {plus: -0.0099, minus: -0.0109}} + - {label: 'JetScaleEff6', asymerror: {plus: -0.0009, minus: -0.0008}} + - {label: 'JetScaleEta1', asymerror: {plus: -0.0016, minus: 0.0032}} + - {label: 'JetScaleEta2', asymerror: {plus: 0.0001, minus: 0.0020}} + - {label: 'JetScaleHighPt', asymerror: {plus: 0.0004, minus: 0.0005}} + - {label: 'JetScaleMC', asymerror: {plus: 0.0007, minus: 0.0006}} + - {label: 'JetScalePileup1', asymerror: {plus: -0.0008, minus: -0.0003}} + - {label: 'JetScalePileup2', asymerror: {plus: -0.0001, minus: -0.0018}} + - {label: 'JetScalePileup3', asymerror: {plus: -0.0008, minus: 0.0002}} + - {label: 'JetScalePileup4', asymerror: {plus: -0.0032, minus: 0.0034}} + - {label: 'JetScaleFlav1Known', asymerror: {plus: -0.0027, minus: 0.0010}} + - {label: 'JetScaleFlav2', asymerror: {plus: 0.0049, minus: -0.0087}} + - {label: 'JetScaleBjet', asymerror: {plus: 0.0002, minus: 0.0001}} + - {label: 'JetScalepunchT', asymerror: {plus: -0.000004, minus: 0.0001}} + - {label: 'JetResolution10', symerror: -0.0053} + - {label: 'JetSFBeff', asymerror: {plus: 0.0110, minus: -0.0143}} + - {label: 'JetSFCeff', asymerror: {plus: 0.0018, minus: -0.0031}} + - {label: 'JetSFLmistag', asymerror: {plus: -0.0010, minus: -0.0012}} + - {label: 'JetSFHighPt', asymerror: {plus: 0.0004, minus: 0.0003}} + - {label: 'JetJVFcut', asymerror: {plus: 0.0064, minus: 0.0063}} + - {label: 'ElScaleR12', asymerror: {plus: -0.0017, minus: 0.0015}} + - {label: 'ElScaleZee', asymerror: {plus: -0.0012, minus: 0.0015}} + - {label: 'ElScalePS', asymerror: {plus: 0.0001, minus: -0.0017}} + - {label: 'ElResolution', symerror: -0.0003} + - {label: 'ElSFReco', asymerror: {plus: -0.0023, minus: 0.0006}} + - {label: 'ElSFId', asymerror: {plus: -0.0018, minus: 0.0034}} + - {label: 'ElSFTrigger', asymerror: {plus: -0.0016, minus: 0.0008}} + - {label: 'ElSFIso', asymerror: {plus: -0.0011, minus: -0.0008}} + - {label: 'ElSFChargeMisID', asymerror: {plus: 0.0001, minus: 0.0002}} + - {label: 'METScale', asymerror: {plus: 0.0075, minus: -0.0092}} + - {label: 'METResLong', symerror: 0.0120} + - {label: 'METResTrans', symerror: 0.0145} + - {label: 'PileupWeight', asymerror: {plus: -0.0027, minus: 0.0005}} + - {label: 'QCDlowRange', asymerror: {plus: 0.0009, minus: -0.0007}} + - {label: 'QCDhighRange', asymerror: {plus: 0.0005, minus: 0.0001}} + - {label: 'QCDvarIso', symerror: 0.0056} + - {label: 'QCDvarElID', symerror: 0.0011} + - {label: 'QCDfitUncert', symerror: 0.0018} + - {label: 'QCDotherGen', symerror: -0.0062} + - {label: 'QCDfitRebin', symerror: 0.00005} + - {label: 'XsecZ', asymerror: {plus: 0.0003, minus: -0.0003}} + - {label: 'XsecTop', asymerror: {plus: -0.0070, minus: 0.0072}} + - {label: 'XsecDibos', asymerror: {plus: -0.0009, minus: 0.0009}} + - {label: 'BkgTtbarNorm', symerror: 0.0075} + - {label: 'BkgMCstat', symerror: 0.0397} + - {label: 'WHFmodel', symerror: 0.0425} + - {label: 'LumiUncert', asymerror: {plus: -0.0013, minus: 0.0014}} + - {label: 'UnfoldMCstat', symerror: 0.1134} + - {label: 'UnfoldOtherGen', symerror: -0.2401} + - {label: 'UnfoldReweight', symerror: -0.0014} + value: 2.0064 + - errors: + - {label: 'Stat', symerror: 0.1434} + - {label: 'JetScaleEff1', asymerror: {plus: -0.0165, minus: 0.0029}} + - {label: 'JetScaleEff2', asymerror: {plus: -0.0070, minus: 0.0461}} + - {label: 'JetScaleEff3', asymerror: {plus: 0.0053, minus: 0.0004}} + - {label: 'JetScaleEff4', asymerror: {plus: -0.0013, minus: -0.0007}} + - {label: 'JetScaleEff5', asymerror: {plus: -0.0103, minus: -0.0113}} + - {label: 'JetScaleEff6', asymerror: {plus: -0.0009, minus: -0.0008}} + - {label: 'JetScaleEta1', asymerror: {plus: -0.0017, minus: 0.0033}} + - {label: 'JetScaleEta2', asymerror: {plus: 0.0001, minus: 0.0020}} + - {label: 'JetScaleHighPt', asymerror: {plus: 0.0004, minus: 0.0005}} + - {label: 'JetScaleMC', asymerror: {plus: 0.0007, minus: 0.0006}} + - {label: 'JetScalePileup1', asymerror: {plus: -0.0009, minus: -0.0003}} + - {label: 'JetScalePileup2', asymerror: {plus: -0.0001, minus: -0.0019}} + - {label: 'JetScalePileup3', asymerror: {plus: -0.0008, minus: 0.0002}} + - {label: 'JetScalePileup4', asymerror: {plus: -0.0033, minus: 0.0035}} + - {label: 'JetScaleFlav1Known', asymerror: {plus: -0.0028, minus: 0.0010}} + - {label: 'JetScaleFlav2', asymerror: {plus: 0.0051, minus: -0.0090}} + - {label: 'JetScaleBjet', asymerror: {plus: 0.0002, minus: 0.0002}} + - {label: 'JetScalepunchT', asymerror: {plus: -0.000004, minus: 0.0001}} + - {label: 'JetResolution10', symerror: -0.0055} + - {label: 'JetSFBeff', asymerror: {plus: 0.0114, minus: -0.0149}} + - {label: 'JetSFCeff', asymerror: {plus: 0.0019, minus: -0.0033}} + - {label: 'JetSFLmistag', asymerror: {plus: -0.0010, minus: -0.0012}} + - {label: 'JetSFHighPt', asymerror: {plus: 0.0004, minus: 0.0003}} + - {label: 'JetJVFcut', asymerror: {plus: 0.0066, minus: 0.0066}} + - {label: 'ElScaleR12', asymerror: {plus: -0.0018, minus: 0.0016}} + - {label: 'ElScaleZee', asymerror: {plus: -0.0012, minus: 0.0015}} + - {label: 'ElScalePS', asymerror: {plus: 0.0001, minus: -0.0018}} + - {label: 'ElResolution', symerror: -0.0003} + - {label: 'ElSFReco', asymerror: {plus: -0.0024, minus: 0.0007}} + - {label: 'ElSFId', asymerror: {plus: -0.0019, minus: 0.0036}} + - {label: 'ElSFTrigger', asymerror: {plus: -0.0017, minus: 0.0008}} + - {label: 'ElSFIso', asymerror: {plus: -0.0011, minus: -0.0008}} + - {label: 'ElSFChargeMisID', asymerror: {plus: 0.0001, minus: 0.0002}} + - {label: 'METScale', asymerror: {plus: 0.0078, minus: -0.0096}} + - {label: 'METResLong', symerror: 0.0125} + - {label: 'METResTrans', symerror: 0.0151} + - {label: 'PileupWeight', asymerror: {plus: -0.0028, minus: 0.0005}} + - {label: 'QCDlowRange', asymerror: {plus: 0.0028, minus: -0.0026}} + - {label: 'QCDhighRange', asymerror: {plus: 0.0001, minus: 0.0005}} + - {label: 'QCDvarIso', symerror: 0.0058} + - {label: 'QCDvarElID', symerror: 0.0012} + - {label: 'QCDfitUncert', symerror: 0.0017} + - {label: 'QCDotherGen', symerror: -0.0094} + - {label: 'QCDfitRebin', symerror: -0.0002} + - {label: 'XsecZ', asymerror: {plus: 0.0008, minus: -0.0008}} + - {label: 'XsecTop', asymerror: {plus: -0.0047, minus: 0.0048}} + - {label: 'XsecDibos', asymerror: {plus: -0.0016, minus: 0.0016}} + - {label: 'BkgTtbarNorm', symerror: 0.0066} + - {label: 'BkgMCstat', symerror: 0.0520} + - {label: 'WHFmodel', symerror: -0.0245} + - {label: 'LumiUncert', asymerror: {plus: -0.0013, minus: 0.0014}} + - {label: 'UnfoldMCstat', symerror: 0.1628} + - {label: 'UnfoldOtherGen', symerror: 0.1994} + - {label: 'UnfoldReweight', symerror: -0.0015} + value: 2.0865 + - errors: + - {label: 'Stat', symerror: 0.2360} + - {label: 'JetScaleEff1', asymerror: {plus: -0.0195, minus: 0.0034}} + - {label: 'JetScaleEff2', asymerror: {plus: -0.0083, minus: 0.0544}} + - {label: 'JetScaleEff3', asymerror: {plus: 0.0062, minus: 0.0005}} + - {label: 'JetScaleEff4', asymerror: {plus: -0.0015, minus: -0.0008}} + - {label: 'JetScaleEff5', asymerror: {plus: -0.0122, minus: -0.0134}} + - {label: 'JetScaleEff6', asymerror: {plus: -0.0011, minus: -0.0009}} + - {label: 'JetScaleEta1', asymerror: {plus: -0.0020, minus: 0.0039}} + - {label: 'JetScaleEta2', asymerror: {plus: 0.0001, minus: 0.0024}} + - {label: 'JetScaleHighPt', asymerror: {plus: 0.0005, minus: 0.0006}} + - {label: 'JetScaleMC', asymerror: {plus: 0.0009, minus: 0.0007}} + - {label: 'JetScalePileup1', asymerror: {plus: -0.0010, minus: -0.0003}} + - {label: 'JetScalePileup2', asymerror: {plus: -0.0001, minus: -0.0022}} + - {label: 'JetScalePileup3', asymerror: {plus: -0.0010, minus: 0.0002}} + - {label: 'JetScalePileup4', asymerror: {plus: -0.0040, minus: 0.0041}} + - {label: 'JetScaleFlav1Known', asymerror: {plus: -0.0033, minus: 0.0012}} + - {label: 'JetScaleFlav2', asymerror: {plus: 0.0060, minus: -0.0107}} + - {label: 'JetScaleBjet', asymerror: {plus: 0.0002, minus: 0.0002}} + - {label: 'JetScalepunchT', asymerror: {plus: -0.000005, minus: 0.0001}} + - {label: 'JetResolution10', symerror: -0.0065} + - {label: 'JetSFBeff', asymerror: {plus: 0.0135, minus: -0.0176}} + - {label: 'JetSFCeff', asymerror: {plus: 0.0022, minus: -0.0039}} + - {label: 'JetSFLmistag', asymerror: {plus: -0.0012, minus: -0.0014}} + - {label: 'JetSFHighPt', asymerror: {plus: 0.0005, minus: 0.0003}} + - {label: 'JetJVFcut', asymerror: {plus: 0.0078, minus: 0.0078}} + - {label: 'ElScaleR12', asymerror: {plus: -0.0021, minus: 0.0018}} + - {label: 'ElScaleZee', asymerror: {plus: -0.0015, minus: 0.0018}} + - {label: 'ElScalePS', asymerror: {plus: 0.0001, minus: -0.0021}} + - {label: 'ElResolution', symerror: -0.0003} + - {label: 'ElSFReco', asymerror: {plus: -0.0028, minus: 0.0008}} + - {label: 'ElSFId', asymerror: {plus: -0.0022, minus: 0.0042}} + - {label: 'ElSFTrigger', asymerror: {plus: -0.0020, minus: 0.0010}} + - {label: 'ElSFIso', asymerror: {plus: -0.0013, minus: -0.0010}} + - {label: 'ElSFChargeMisID', asymerror: {plus: 0.0001, minus: 0.0002}} + - {label: 'METScale', asymerror: {plus: 0.0092, minus: -0.0113}} + - {label: 'METResLong', symerror: 0.0147} + - {label: 'METResTrans', symerror: 0.0178} + - {label: 'PileupWeight', asymerror: {plus: -0.0033, minus: 0.0006}} + - {label: 'QCDlowRange', asymerror: {plus: -0.0012, minus: 0.0009}} + - {label: 'QCDhighRange', asymerror: {plus: 0.0005, minus: 0.0001}} + - {label: 'QCDvarIso', symerror: 0.0069} + - {label: 'QCDvarElID', symerror: 0.0014} + - {label: 'QCDfitUncert', symerror: 0.0012} + - {label: 'QCDotherGen', symerror: -0.0005} + - {label: 'QCDfitRebin', symerror: 0.00002} + - {label: 'XsecZ', asymerror: {plus: -0.0052, minus: 0.0053}} + - {label: 'XsecTop', asymerror: {plus: -0.0069, minus: 0.0070}} + - {label: 'XsecDibos', asymerror: {plus: -0.0026, minus: 0.0026}} + - {label: 'BkgTtbarNorm', symerror: 0.0112} + - {label: 'BkgMCstat', symerror: 0.0835} + - {label: 'WHFmodel', symerror: 0.0015} + - {label: 'LumiUncert', asymerror: {plus: -0.0019, minus: 0.0021}} + - {label: 'UnfoldMCstat', symerror: 0.2208} + - {label: 'UnfoldOtherGen', symerror: 0.3231} + - {label: 'UnfoldReweight', symerror: -0.0018} + value: 2.4644 + - errors: + - {label: 'Stat', symerror: 0.3932} + - {label: 'JetScaleEff1', asymerror: {plus: -0.0216, minus: 0.0038}} + - {label: 'JetScaleEff2', asymerror: {plus: -0.0092, minus: 0.0602}} + - {label: 'JetScaleEff3', asymerror: {plus: 0.0069, minus: 0.0005}} + - {label: 'JetScaleEff4', asymerror: {plus: -0.0016, minus: -0.0009}} + - {label: 'JetScaleEff5', asymerror: {plus: -0.0135, minus: -0.0148}} + - {label: 'JetScaleEff6', asymerror: {plus: -0.0012, minus: -0.0010}} + - {label: 'JetScaleEta1', asymerror: {plus: -0.0022, minus: 0.0043}} + - {label: 'JetScaleEta2', asymerror: {plus: 0.0001, minus: 0.0027}} + - {label: 'JetScaleHighPt', asymerror: {plus: 0.0006, minus: 0.0007}} + - {label: 'JetScaleMC', asymerror: {plus: 0.0009, minus: 0.0008}} + - {label: 'JetScalePileup1', asymerror: {plus: -0.0011, minus: -0.0004}} + - {label: 'JetScalePileup2', asymerror: {plus: -0.0002, minus: -0.0024}} + - {label: 'JetScalePileup3', asymerror: {plus: -0.0011, minus: 0.0003}} + - {label: 'JetScalePileup4', asymerror: {plus: -0.0044, minus: 0.0046}} + - {label: 'JetScaleFlav1Known', asymerror: {plus: -0.0037, minus: 0.0013}} + - {label: 'JetScaleFlav2', asymerror: {plus: 0.0066, minus: -0.0118}} + - {label: 'JetScaleBjet', asymerror: {plus: 0.0002, minus: 0.0002}} + - {label: 'JetScalepunchT', asymerror: {plus: -0.00001, minus: 0.0002}} + - {label: 'JetResolution10', symerror: -0.0072} + - {label: 'JetSFBeff', asymerror: {plus: 0.0149, minus: -0.0195}} + - {label: 'JetSFCeff', asymerror: {plus: 0.0024, minus: -0.0043}} + - {label: 'JetSFLmistag', asymerror: {plus: -0.0014, minus: -0.0016}} + - {label: 'JetSFHighPt', asymerror: {plus: 0.0005, minus: 0.0004}} + - {label: 'JetJVFcut', asymerror: {plus: 0.0087, minus: 0.0086}} + - {label: 'ElScaleR12', asymerror: {plus: -0.0023, minus: 0.0020}} + - {label: 'ElScaleZee', asymerror: {plus: -0.0016, minus: 0.0020}} + - {label: 'ElScalePS', asymerror: {plus: 0.0001, minus: -0.0024}} + - {label: 'ElResolution', symerror: -0.0004} + - {label: 'ElSFReco', asymerror: {plus: -0.0031, minus: 0.0009}} + - {label: 'ElSFId', asymerror: {plus: -0.0024, minus: 0.0047}} + - {label: 'ElSFTrigger', asymerror: {plus: -0.0022, minus: 0.0011}} + - {label: 'ElSFIso', asymerror: {plus: -0.0015, minus: -0.0011}} + - {label: 'ElSFChargeMisID', asymerror: {plus: 0.0001, minus: 0.0003}} + - {label: 'METScale', asymerror: {plus: 0.0102, minus: -0.0125}} + - {label: 'METResLong', symerror: 0.0163} + - {label: 'METResTrans', symerror: 0.0197} + - {label: 'PileupWeight', asymerror: {plus: -0.0037, minus: 0.0007}} + - {label: 'QCDlowRange', asymerror: {plus: -0.0016, minus: 0.0029}} + - {label: 'QCDhighRange', asymerror: {plus: 0.0008, minus: -0.0003}} + - {label: 'QCDvarIso', symerror: 0.0076} + - {label: 'QCDvarElID', symerror: 0.0015} + - {label: 'QCDfitUncert', symerror: 0.0014} + - {label: 'QCDotherGen', symerror: 0.0037} + - {label: 'QCDfitRebin', symerror: -0.0002} + - {label: 'XsecZ', asymerror: {plus: -0.0065, minus: 0.0065}} + - {label: 'XsecTop', asymerror: {plus: -0.0044, minus: 0.0044}} + - {label: 'XsecDibos', asymerror: {plus: -0.0048, minus: 0.0048}} + - {label: 'BkgTtbarNorm', symerror: 0.0060} + - {label: 'BkgMCstat', symerror: 0.1150} + - {label: 'WHFmodel', symerror: 0.1046} + - {label: 'LumiUncert', asymerror: {plus: -0.0045, minus: 0.0048}} + - {label: 'UnfoldMCstat', symerror: 0.4519} + - {label: 'UnfoldOtherGen', symerror: 0.3578} + - {label: 'UnfoldReweight', symerror: -0.0019} + value: 2.729 +independent_variables: +- header: {name: '$p_\text{T}^\text{W}\text{ [GeV]}$'} + values: + - {low: 0.0, high: 25.0} + - {low: 25.0, high: 50.0} + - {low: 50.0, high: 75.0} + - {low: 75.0, high: 100.0} + - {low: 100.0, high: 125.0} + - {low: 125.0, high: 150.0} + - {low: 150.0, high: 175.0} + - {low: 175.0, high: 200.0} + - {low: 200.0, high: 250.0} + - {low: 250.0, high: 300.0} + - {low: 300.0, high: 350.0} + - {low: 350.0, high: 400.0} + - {low: 400.0, high: 450.0} + - {low: 450.0, high: 500.0} + - {low: 500.0, high: 600.0} + - {low: 600.0, high: 800.0} diff --git a/nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/rawdata/data14.yaml b/nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/rawdata/data14.yaml new file mode 100644 index 0000000000..aa8fe7c263 --- /dev/null +++ b/nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/rawdata/data14.yaml @@ -0,0 +1,784 @@ +dependent_variables: +- header: {name: '$\rho^{W^+}(p_\text{T}^\text{W})$'} + qualifiers: + - {name: 'Correlation for cross section', value: 'W+ (electron channel)'} + - {name: 'ABS(ETARAP(ELECTRON))', value: '< 2.5'} + - {name: 'ABS(YRAP(JET))', value: '< 4.4'} + - {name: 'PT(JET)', units: 'GEV', value: '> 30'} + - {name: 'PT(LEPTON)', units: 'GEV', value: '> 25'} + - {name: 'RE', value: 'P P --> W JET(S) X'} + - {name: 'SQRT(S)', units: 'GEV', value: '8000.0'} + values: + - {value: +1.000000} + - {value: +0.442678} + - {value: -0.026622} + - {value: -0.062553} + - {value: -0.016604} + - {value: -0.001635} + - {value: +0.000300} + - {value: +0.000199} + - {value: +0.000040} + - {value: +0.000002} + - {value: -0.000007} + - {value: -0.000010} + - {value: -0.000010} + - {value: -0.000004} + - {value: -0.000007} + - {value: -0.000017} + - {value: +0.442678} + - {value: +1.000000} + - {value: +0.409170} + - {value: -0.048645} + - {value: -0.061283} + - {value: -0.014545} + - {value: -0.001104} + - {value: +0.000400} + - {value: +0.000148} + - {value: +0.000018} + - {value: -0.000006} + - {value: -0.000022} + - {value: +0.000018} + - {value: -0.000007} + - {value: -0.000021} + - {value: -0.000028} + - {value: -0.026622} + - {value: +0.409170} + - {value: +1.000000} + - {value: +0.409340} + - {value: -0.045459} + - {value: -0.064544} + - {value: -0.016317} + - {value: -0.001577} + - {value: +0.000387} + - {value: +0.000099} + - {value: -0.000033} + - {value: +0.000028} + - {value: -0.000024} + - {value: -0.000022} + - {value: +0.000020} + - {value: -0.000041} + - {value: -0.062553} + - {value: -0.048645} + - {value: +0.409340} + - {value: +1.000000} + - {value: +0.427921} + - {value: -0.045540} + - {value: -0.072139} + - {value: -0.021082} + - {value: -0.001160} + - {value: +0.000350} + - {value: +0.000131} + - {value: -0.000015} + - {value: -0.000020} + - {value: -0.000003} + - {value: -0.000025} + - {value: -0.000051} + - {value: -0.016604} + - {value: -0.061283} + - {value: -0.045459} + - {value: +0.427921} + - {value: +1.000000} + - {value: +0.449054} + - {value: -0.041381} + - {value: -0.081285} + - {value: -0.017331} + - {value: +0.000129} + - {value: +0.000265} + - {value: +0.000021} + - {value: +0.000003} + - {value: -0.000000} + - {value: -0.000004} + - {value: -0.000018} + - {value: -0.001635} + - {value: -0.014545} + - {value: -0.064544} + - {value: -0.045540} + - {value: +0.449054} + - {value: +1.000000} + - {value: +0.469414} + - {value: -0.026294} + - {value: -0.072196} + - {value: -0.007730} + - {value: +0.000710} + - {value: +0.000179} + - {value: +0.000022} + - {value: +0.000001} + - {value: -0.000010} + - {value: -0.000009} + - {value: +0.000300} + - {value: -0.001104} + - {value: -0.016317} + - {value: -0.072139} + - {value: -0.041381} + - {value: +0.469414} + - {value: +1.000000} + - {value: +0.522590} + - {value: -0.069841} + - {value: -0.045502} + - {value: -0.002703} + - {value: +0.000666} + - {value: +0.000067} + - {value: -0.000006} + - {value: -0.000024} + - {value: -0.000021} + - {value: +0.000199} + - {value: +0.000400} + - {value: -0.001577} + - {value: -0.021082} + - {value: -0.081285} + - {value: -0.026294} + - {value: +0.522590} + - {value: +1.000000} + - {value: +0.333983} + - {value: -0.094374} + - {value: -0.027180} + - {value: +0.000252} + - {value: +0.000593} + - {value: +0.000059} + - {value: -0.000122} + - {value: -0.000064} + - {value: +0.000040} + - {value: +0.000148} + - {value: +0.000387} + - {value: -0.001160} + - {value: -0.017331} + - {value: -0.072196} + - {value: -0.069841} + - {value: +0.333983} + - {value: +1.000000} + - {value: +0.148737} + - {value: -0.076883} + - {value: -0.019191} + - {value: -0.000140} + - {value: +0.000362} + - {value: +0.000087} + - {value: -0.000132} + - {value: +0.000002} + - {value: +0.000018} + - {value: +0.000099} + - {value: +0.000350} + - {value: +0.000129} + - {value: -0.007730} + - {value: -0.045502} + - {value: -0.094374} + - {value: +0.148737} + - {value: +1.000000} + - {value: +0.177779} + - {value: -0.082374} + - {value: -0.024344} + - {value: -0.000477} + - {value: +0.000269} + - {value: +0.000034} + - {value: -0.000007} + - {value: -0.000006} + - {value: -0.000033} + - {value: +0.000131} + - {value: +0.000265} + - {value: +0.000710} + - {value: -0.002703} + - {value: -0.027180} + - {value: -0.076883} + - {value: +0.177779} + - {value: +1.000000} + - {value: +0.202385} + - {value: -0.088239} + - {value: -0.029429} + - {value: -0.001028} + - {value: +0.000115} + - {value: -0.000010} + - {value: -0.000022} + - {value: +0.000028} + - {value: -0.000015} + - {value: +0.000021} + - {value: +0.000179} + - {value: +0.000666} + - {value: +0.000252} + - {value: -0.019191} + - {value: -0.082374} + - {value: +0.202385} + - {value: +1.000000} + - {value: +0.245531} + - {value: -0.094095} + - {value: -0.024182} + - {value: +0.000293} + - {value: -0.000010} + - {value: +0.000018} + - {value: -0.000024} + - {value: -0.000020} + - {value: +0.000003} + - {value: +0.000022} + - {value: +0.000067} + - {value: +0.000593} + - {value: -0.000140} + - {value: -0.024344} + - {value: -0.088239} + - {value: +0.245531} + - {value: +1.000000} + - {value: +0.282610} + - {value: -0.089259} + - {value: -0.009190} + - {value: -0.000004} + - {value: -0.000007} + - {value: -0.000022} + - {value: -0.000003} + - {value: -0.000000} + - {value: +0.000001} + - {value: -0.000006} + - {value: +0.000059} + - {value: +0.000362} + - {value: -0.000477} + - {value: -0.029429} + - {value: -0.094095} + - {value: +0.282610} + - {value: +1.000000} + - {value: +0.123969} + - {value: -0.050583} + - {value: -0.000007} + - {value: -0.000021} + - {value: +0.000020} + - {value: -0.000025} + - {value: -0.000004} + - {value: -0.000010} + - {value: -0.000024} + - {value: -0.000122} + - {value: +0.000087} + - {value: +0.000269} + - {value: -0.001028} + - {value: -0.024182} + - {value: -0.089259} + - {value: +0.123969} + - {value: +1.000000} + - {value: -0.011560} + - {value: -0.000017} + - {value: -0.000028} + - {value: -0.000041} + - {value: -0.000051} + - {value: -0.000018} + - {value: -0.000009} + - {value: -0.000021} + - {value: -0.000064} + - {value: -0.000132} + - {value: +0.000034} + - {value: +0.000115} + - {value: +0.000293} + - {value: -0.009190} + - {value: -0.050583} + - {value: -0.011560} + - {value: +1.000000} +independent_variables: +- header: {name: '$p_\text{T}^\text{W}\text{ [GeV]}$'} + values: + - {low: 0.0, high: 25.0} + - {low: 0.0, high: 25.0} + - {low: 0.0, high: 25.0} + - {low: 0.0, high: 25.0} + - {low: 0.0, high: 25.0} + - {low: 0.0, high: 25.0} + - {low: 0.0, high: 25.0} + - {low: 0.0, high: 25.0} + - {low: 0.0, high: 25.0} + - {low: 0.0, high: 25.0} + - {low: 0.0, high: 25.0} + - {low: 0.0, high: 25.0} + - {low: 0.0, high: 25.0} + - {low: 0.0, high: 25.0} + - {low: 0.0, high: 25.0} + - {low: 0.0, high: 25.0} + - {low: 25.0, high: 50.0} + - {low: 25.0, high: 50.0} + - {low: 25.0, high: 50.0} + - {low: 25.0, high: 50.0} + - {low: 25.0, high: 50.0} + - {low: 25.0, high: 50.0} + - {low: 25.0, high: 50.0} + - {low: 25.0, high: 50.0} + - {low: 25.0, high: 50.0} + - {low: 25.0, high: 50.0} + - {low: 25.0, high: 50.0} + - {low: 25.0, high: 50.0} + - {low: 25.0, high: 50.0} + - {low: 25.0, high: 50.0} + - {low: 25.0, high: 50.0} + - {low: 25.0, high: 50.0} + - {low: 50.0, high: 75.0} + - {low: 50.0, high: 75.0} + - {low: 50.0, high: 75.0} + - {low: 50.0, high: 75.0} + - {low: 50.0, high: 75.0} + - {low: 50.0, high: 75.0} + - {low: 50.0, high: 75.0} + - {low: 50.0, high: 75.0} + - {low: 50.0, high: 75.0} + - {low: 50.0, high: 75.0} + - {low: 50.0, high: 75.0} + - {low: 50.0, high: 75.0} + - {low: 50.0, high: 75.0} + - {low: 50.0, high: 75.0} + - {low: 50.0, high: 75.0} + - {low: 50.0, high: 75.0} + - {low: 75.0, high: 100.0} + - {low: 75.0, high: 100.0} + - {low: 75.0, high: 100.0} + - {low: 75.0, high: 100.0} + - {low: 75.0, high: 100.0} + - {low: 75.0, high: 100.0} + - {low: 75.0, high: 100.0} + - {low: 75.0, high: 100.0} + - {low: 75.0, high: 100.0} + - {low: 75.0, high: 100.0} + - {low: 75.0, high: 100.0} + - {low: 75.0, high: 100.0} + - {low: 75.0, high: 100.0} + - {low: 75.0, high: 100.0} + - {low: 75.0, high: 100.0} + - {low: 75.0, high: 100.0} + - {low: 100.0, high: 125.0} + - {low: 100.0, high: 125.0} + - {low: 100.0, high: 125.0} + - {low: 100.0, high: 125.0} + - {low: 100.0, high: 125.0} + - {low: 100.0, high: 125.0} + - {low: 100.0, high: 125.0} + - {low: 100.0, high: 125.0} + - {low: 100.0, high: 125.0} + - {low: 100.0, high: 125.0} + - {low: 100.0, high: 125.0} + - {low: 100.0, high: 125.0} + - {low: 100.0, high: 125.0} + - {low: 100.0, high: 125.0} + - {low: 100.0, high: 125.0} + - {low: 100.0, high: 125.0} + - {low: 125.0, high: 150.0} + - {low: 125.0, high: 150.0} + - {low: 125.0, high: 150.0} + - {low: 125.0, high: 150.0} + - {low: 125.0, high: 150.0} + - {low: 125.0, high: 150.0} + - {low: 125.0, high: 150.0} + - {low: 125.0, high: 150.0} + - {low: 125.0, high: 150.0} + - {low: 125.0, high: 150.0} + - {low: 125.0, high: 150.0} + - {low: 125.0, high: 150.0} + - {low: 125.0, high: 150.0} + - {low: 125.0, high: 150.0} + - {low: 125.0, high: 150.0} + - {low: 125.0, high: 150.0} + - {low: 150.0, high: 175.0} + - {low: 150.0, high: 175.0} + - {low: 150.0, high: 175.0} + - {low: 150.0, high: 175.0} + - {low: 150.0, high: 175.0} + - {low: 150.0, high: 175.0} + - {low: 150.0, high: 175.0} + - {low: 150.0, high: 175.0} + - {low: 150.0, high: 175.0} + - {low: 150.0, high: 175.0} + - {low: 150.0, high: 175.0} + - {low: 150.0, high: 175.0} + - {low: 150.0, high: 175.0} + - {low: 150.0, high: 175.0} + - {low: 150.0, high: 175.0} + - {low: 150.0, high: 175.0} + - {low: 175.0, high: 200.0} + - {low: 175.0, high: 200.0} + - {low: 175.0, high: 200.0} + - {low: 175.0, high: 200.0} + - {low: 175.0, high: 200.0} + - {low: 175.0, high: 200.0} + - {low: 175.0, high: 200.0} + - {low: 175.0, high: 200.0} + - {low: 175.0, high: 200.0} + - {low: 175.0, high: 200.0} + - {low: 175.0, high: 200.0} + - {low: 175.0, high: 200.0} + - {low: 175.0, high: 200.0} + - {low: 175.0, high: 200.0} + - {low: 175.0, high: 200.0} + - {low: 175.0, high: 200.0} + - {low: 200.0, high: 250.0} + - {low: 200.0, high: 250.0} + - {low: 200.0, high: 250.0} + - {low: 200.0, high: 250.0} + - {low: 200.0, high: 250.0} + - {low: 200.0, high: 250.0} + - {low: 200.0, high: 250.0} + - {low: 200.0, high: 250.0} + - {low: 200.0, high: 250.0} + - {low: 200.0, high: 250.0} + - {low: 200.0, high: 250.0} + - {low: 200.0, high: 250.0} + - {low: 200.0, high: 250.0} + - {low: 200.0, high: 250.0} + - {low: 200.0, high: 250.0} + - {low: 200.0, high: 250.0} + - {low: 250.0, high: 300.0} + - {low: 250.0, high: 300.0} + - {low: 250.0, high: 300.0} + - {low: 250.0, high: 300.0} + - {low: 250.0, high: 300.0} + - {low: 250.0, high: 300.0} + - {low: 250.0, high: 300.0} + - {low: 250.0, high: 300.0} + - {low: 250.0, high: 300.0} + - {low: 250.0, high: 300.0} + - {low: 250.0, high: 300.0} + - {low: 250.0, high: 300.0} + - {low: 250.0, high: 300.0} + - {low: 250.0, high: 300.0} + - {low: 250.0, high: 300.0} + - {low: 250.0, high: 300.0} + - {low: 300.0, high: 350.0} + - {low: 300.0, high: 350.0} + - {low: 300.0, high: 350.0} + - {low: 300.0, high: 350.0} + - {low: 300.0, high: 350.0} + - {low: 300.0, high: 350.0} + - {low: 300.0, high: 350.0} + - {low: 300.0, high: 350.0} + - {low: 300.0, high: 350.0} + - {low: 300.0, high: 350.0} + - {low: 300.0, high: 350.0} + - {low: 300.0, high: 350.0} + - {low: 300.0, high: 350.0} + - {low: 300.0, high: 350.0} + - {low: 300.0, high: 350.0} + - {low: 300.0, high: 350.0} + - {low: 350.0, high: 400.0} + - {low: 350.0, high: 400.0} + - {low: 350.0, high: 400.0} + - {low: 350.0, high: 400.0} + - {low: 350.0, high: 400.0} + - {low: 350.0, high: 400.0} + - {low: 350.0, high: 400.0} + - {low: 350.0, high: 400.0} + - {low: 350.0, high: 400.0} + - {low: 350.0, high: 400.0} + - {low: 350.0, high: 400.0} + - {low: 350.0, high: 400.0} + - {low: 350.0, high: 400.0} + - {low: 350.0, high: 400.0} + - {low: 350.0, high: 400.0} + - {low: 350.0, high: 400.0} + - {low: 400.0, high: 450.0} + - {low: 400.0, high: 450.0} + - {low: 400.0, high: 450.0} + - {low: 400.0, high: 450.0} + - {low: 400.0, high: 450.0} + - {low: 400.0, high: 450.0} + - {low: 400.0, high: 450.0} + - {low: 400.0, high: 450.0} + - {low: 400.0, high: 450.0} + - {low: 400.0, high: 450.0} + - {low: 400.0, high: 450.0} + - {low: 400.0, high: 450.0} + - {low: 400.0, high: 450.0} + - {low: 400.0, high: 450.0} + - {low: 400.0, high: 450.0} + - {low: 400.0, high: 450.0} + - {low: 450.0, high: 500.0} + - {low: 450.0, high: 500.0} + - {low: 450.0, high: 500.0} + - {low: 450.0, high: 500.0} + - {low: 450.0, high: 500.0} + - {low: 450.0, high: 500.0} + - {low: 450.0, high: 500.0} + - {low: 450.0, high: 500.0} + - {low: 450.0, high: 500.0} + - {low: 450.0, high: 500.0} + - {low: 450.0, high: 500.0} + - {low: 450.0, high: 500.0} + - {low: 450.0, high: 500.0} + - {low: 450.0, high: 500.0} + - {low: 450.0, high: 500.0} + - {low: 450.0, high: 500.0} + - {low: 500.0, high: 600.0} + - {low: 500.0, high: 600.0} + - {low: 500.0, high: 600.0} + - {low: 500.0, high: 600.0} + - {low: 500.0, high: 600.0} + - {low: 500.0, high: 600.0} + - {low: 500.0, high: 600.0} + - {low: 500.0, high: 600.0} + - {low: 500.0, high: 600.0} + - {low: 500.0, high: 600.0} + - {low: 500.0, high: 600.0} + - {low: 500.0, high: 600.0} + - {low: 500.0, high: 600.0} + - {low: 500.0, high: 600.0} + - {low: 500.0, high: 600.0} + - {low: 500.0, high: 600.0} + - {low: 600.0, high: 800.0} + - {low: 600.0, high: 800.0} + - {low: 600.0, high: 800.0} + - {low: 600.0, high: 800.0} + - {low: 600.0, high: 800.0} + - {low: 600.0, high: 800.0} + - {low: 600.0, high: 800.0} + - {low: 600.0, high: 800.0} + - {low: 600.0, high: 800.0} + - {low: 600.0, high: 800.0} + - {low: 600.0, high: 800.0} + - {low: 600.0, high: 800.0} + - {low: 600.0, high: 800.0} + - {low: 600.0, high: 800.0} + - {low: 600.0, high: 800.0} + - {low: 600.0, high: 800.0} +- header: {name: '$p_\text{T}^\text{W}\text{ [GeV]}$'} + values: + - {low: 0.0, high: 25.0} + - {low: 25.0, high: 50.0} + - {low: 50.0, high: 75.0} + - {low: 75.0, high: 100.0} + - {low: 100.0, high: 125.0} + - {low: 125.0, high: 150.0} + - {low: 150.0, high: 175.0} + - {low: 175.0, high: 200.0} + - {low: 200.0, high: 250.0} + - {low: 250.0, high: 300.0} + - {low: 300.0, high: 350.0} + - {low: 350.0, high: 400.0} + - {low: 400.0, high: 450.0} + - {low: 450.0, high: 500.0} + - {low: 500.0, high: 600.0} + - {low: 600.0, high: 800.0} + - {low: 0.0, high: 25.0} + - {low: 25.0, high: 50.0} + - {low: 50.0, high: 75.0} + - {low: 75.0, high: 100.0} + - {low: 100.0, high: 125.0} + - {low: 125.0, high: 150.0} + - {low: 150.0, high: 175.0} + - {low: 175.0, high: 200.0} + - {low: 200.0, high: 250.0} + - {low: 250.0, high: 300.0} + - {low: 300.0, high: 350.0} + - {low: 350.0, high: 400.0} + - {low: 400.0, high: 450.0} + - {low: 450.0, high: 500.0} + - {low: 500.0, high: 600.0} + - {low: 600.0, high: 800.0} + - {low: 0.0, high: 25.0} + - {low: 25.0, high: 50.0} + - {low: 50.0, high: 75.0} + - {low: 75.0, high: 100.0} + - {low: 100.0, high: 125.0} + - {low: 125.0, high: 150.0} + - {low: 150.0, high: 175.0} + - {low: 175.0, high: 200.0} + - {low: 200.0, high: 250.0} + - {low: 250.0, high: 300.0} + - {low: 300.0, high: 350.0} + - {low: 350.0, high: 400.0} + - {low: 400.0, high: 450.0} + - {low: 450.0, high: 500.0} + - {low: 500.0, high: 600.0} + - {low: 600.0, high: 800.0} + - {low: 0.0, high: 25.0} + - {low: 25.0, high: 50.0} + - {low: 50.0, high: 75.0} + - {low: 75.0, high: 100.0} + - {low: 100.0, high: 125.0} + - {low: 125.0, high: 150.0} + - {low: 150.0, high: 175.0} + - {low: 175.0, high: 200.0} + - {low: 200.0, high: 250.0} + - {low: 250.0, high: 300.0} + - {low: 300.0, high: 350.0} + - {low: 350.0, high: 400.0} + - {low: 400.0, high: 450.0} + - {low: 450.0, high: 500.0} + - {low: 500.0, high: 600.0} + - {low: 600.0, high: 800.0} + - {low: 0.0, high: 25.0} + - {low: 25.0, high: 50.0} + - {low: 50.0, high: 75.0} + - {low: 75.0, high: 100.0} + - {low: 100.0, high: 125.0} + - {low: 125.0, high: 150.0} + - {low: 150.0, high: 175.0} + - {low: 175.0, high: 200.0} + - {low: 200.0, high: 250.0} + - {low: 250.0, high: 300.0} + - {low: 300.0, high: 350.0} + - {low: 350.0, high: 400.0} + - {low: 400.0, high: 450.0} + - {low: 450.0, high: 500.0} + - {low: 500.0, high: 600.0} + - {low: 600.0, high: 800.0} + - {low: 0.0, high: 25.0} + - {low: 25.0, high: 50.0} + - {low: 50.0, high: 75.0} + - {low: 75.0, high: 100.0} + - {low: 100.0, high: 125.0} + - {low: 125.0, high: 150.0} + - {low: 150.0, high: 175.0} + - {low: 175.0, high: 200.0} + - {low: 200.0, high: 250.0} + - {low: 250.0, high: 300.0} + - {low: 300.0, high: 350.0} + - {low: 350.0, high: 400.0} + - {low: 400.0, high: 450.0} + - {low: 450.0, high: 500.0} + - {low: 500.0, high: 600.0} + - {low: 600.0, high: 800.0} + - {low: 0.0, high: 25.0} + - {low: 25.0, high: 50.0} + - {low: 50.0, high: 75.0} + - {low: 75.0, high: 100.0} + - {low: 100.0, high: 125.0} + - {low: 125.0, high: 150.0} + - {low: 150.0, high: 175.0} + - {low: 175.0, high: 200.0} + - {low: 200.0, high: 250.0} + - {low: 250.0, high: 300.0} + - {low: 300.0, high: 350.0} + - {low: 350.0, high: 400.0} + - {low: 400.0, high: 450.0} + - {low: 450.0, high: 500.0} + - {low: 500.0, high: 600.0} + - {low: 600.0, high: 800.0} + - {low: 0.0, high: 25.0} + - {low: 25.0, high: 50.0} + - {low: 50.0, high: 75.0} + - {low: 75.0, high: 100.0} + - {low: 100.0, high: 125.0} + - {low: 125.0, high: 150.0} + - {low: 150.0, high: 175.0} + - {low: 175.0, high: 200.0} + - {low: 200.0, high: 250.0} + - {low: 250.0, high: 300.0} + - {low: 300.0, high: 350.0} + - {low: 350.0, high: 400.0} + - {low: 400.0, high: 450.0} + - {low: 450.0, high: 500.0} + - {low: 500.0, high: 600.0} + - {low: 600.0, high: 800.0} + - {low: 0.0, high: 25.0} + - {low: 25.0, high: 50.0} + - {low: 50.0, high: 75.0} + - {low: 75.0, high: 100.0} + - {low: 100.0, high: 125.0} + - {low: 125.0, high: 150.0} + - {low: 150.0, high: 175.0} + - {low: 175.0, high: 200.0} + - {low: 200.0, high: 250.0} + - {low: 250.0, high: 300.0} + - {low: 300.0, high: 350.0} + - {low: 350.0, high: 400.0} + - {low: 400.0, high: 450.0} + - {low: 450.0, high: 500.0} + - {low: 500.0, high: 600.0} + - {low: 600.0, high: 800.0} + - {low: 0.0, high: 25.0} + - {low: 25.0, high: 50.0} + - {low: 50.0, high: 75.0} + - {low: 75.0, high: 100.0} + - {low: 100.0, high: 125.0} + - {low: 125.0, high: 150.0} + - {low: 150.0, high: 175.0} + - {low: 175.0, high: 200.0} + - {low: 200.0, high: 250.0} + - {low: 250.0, high: 300.0} + - {low: 300.0, high: 350.0} + - {low: 350.0, high: 400.0} + - {low: 400.0, high: 450.0} + - {low: 450.0, high: 500.0} + - {low: 500.0, high: 600.0} + - {low: 600.0, high: 800.0} + - {low: 0.0, high: 25.0} + - {low: 25.0, high: 50.0} + - {low: 50.0, high: 75.0} + - {low: 75.0, high: 100.0} + - {low: 100.0, high: 125.0} + - {low: 125.0, high: 150.0} + - {low: 150.0, high: 175.0} + - {low: 175.0, high: 200.0} + - {low: 200.0, high: 250.0} + - {low: 250.0, high: 300.0} + - {low: 300.0, high: 350.0} + - {low: 350.0, high: 400.0} + - {low: 400.0, high: 450.0} + - {low: 450.0, high: 500.0} + - {low: 500.0, high: 600.0} + - {low: 600.0, high: 800.0} + - {low: 0.0, high: 25.0} + - {low: 25.0, high: 50.0} + - {low: 50.0, high: 75.0} + - {low: 75.0, high: 100.0} + - {low: 100.0, high: 125.0} + - {low: 125.0, high: 150.0} + - {low: 150.0, high: 175.0} + - {low: 175.0, high: 200.0} + - {low: 200.0, high: 250.0} + - {low: 250.0, high: 300.0} + - {low: 300.0, high: 350.0} + - {low: 350.0, high: 400.0} + - {low: 400.0, high: 450.0} + - {low: 450.0, high: 500.0} + - {low: 500.0, high: 600.0} + - {low: 600.0, high: 800.0} + - {low: 0.0, high: 25.0} + - {low: 25.0, high: 50.0} + - {low: 50.0, high: 75.0} + - {low: 75.0, high: 100.0} + - {low: 100.0, high: 125.0} + - {low: 125.0, high: 150.0} + - {low: 150.0, high: 175.0} + - {low: 175.0, high: 200.0} + - {low: 200.0, high: 250.0} + - {low: 250.0, high: 300.0} + - {low: 300.0, high: 350.0} + - {low: 350.0, high: 400.0} + - {low: 400.0, high: 450.0} + - {low: 450.0, high: 500.0} + - {low: 500.0, high: 600.0} + - {low: 600.0, high: 800.0} + - {low: 0.0, high: 25.0} + - {low: 25.0, high: 50.0} + - {low: 50.0, high: 75.0} + - {low: 75.0, high: 100.0} + - {low: 100.0, high: 125.0} + - {low: 125.0, high: 150.0} + - {low: 150.0, high: 175.0} + - {low: 175.0, high: 200.0} + - {low: 200.0, high: 250.0} + - {low: 250.0, high: 300.0} + - {low: 300.0, high: 350.0} + - {low: 350.0, high: 400.0} + - {low: 400.0, high: 450.0} + - {low: 450.0, high: 500.0} + - {low: 500.0, high: 600.0} + - {low: 600.0, high: 800.0} + - {low: 0.0, high: 25.0} + - {low: 25.0, high: 50.0} + - {low: 50.0, high: 75.0} + - {low: 75.0, high: 100.0} + - {low: 100.0, high: 125.0} + - {low: 125.0, high: 150.0} + - {low: 150.0, high: 175.0} + - {low: 175.0, high: 200.0} + - {low: 200.0, high: 250.0} + - {low: 250.0, high: 300.0} + - {low: 300.0, high: 350.0} + - {low: 350.0, high: 400.0} + - {low: 400.0, high: 450.0} + - {low: 450.0, high: 500.0} + - {low: 500.0, high: 600.0} + - {low: 600.0, high: 800.0} + - {low: 0.0, high: 25.0} + - {low: 25.0, high: 50.0} + - {low: 50.0, high: 75.0} + - {low: 75.0, high: 100.0} + - {low: 100.0, high: 125.0} + - {low: 125.0, high: 150.0} + - {low: 150.0, high: 175.0} + - {low: 175.0, high: 200.0} + - {low: 200.0, high: 250.0} + - {low: 250.0, high: 300.0} + - {low: 300.0, high: 350.0} + - {low: 350.0, high: 400.0} + - {low: 400.0, high: 450.0} + - {low: 450.0, high: 500.0} + - {low: 500.0, high: 600.0} + - {low: 600.0, high: 800.0} diff --git a/nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/rawdata/data15.yaml b/nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/rawdata/data15.yaml new file mode 100644 index 0000000000..a8b141d9c1 --- /dev/null +++ b/nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/rawdata/data15.yaml @@ -0,0 +1,784 @@ +dependent_variables: +- header: {name: '$\rho^{W^-}(p_\text{T}^\text{W})$'} + qualifiers: + - {name: 'Correlation for cross section', value: 'W- (electron channel)'} + - {name: 'ABS(ETARAP(ELECTRON))', value: '< 2.5'} + - {name: 'ABS(YRAP(JET))', value: '< 4.4'} + - {name: 'PT(JET)', units: 'GEV', value: '> 30'} + - {name: 'PT(LEPTON)', units: 'GEV', value: '> 25'} + - {name: 'RE', value: 'P P --> W JET(S) X'} + - {name: 'SQRT(S)', units: 'GEV', value: '8000.0'} + values: + - {value: +1.000000} + - {value: +0.443117} + - {value: -0.027961} + - {value: -0.062189} + - {value: -0.016126} + - {value: -0.001595} + - {value: +0.000267} + - {value: +0.000165} + - {value: +0.000042} + - {value: -0.000004} + - {value: -0.000013} + - {value: -0.000006} + - {value: +0.000010} + - {value: -0.000012} + - {value: -0.000051} + - {value: -0.000003} + - {value: +0.443117} + - {value: +1.000000} + - {value: +0.402593} + - {value: -0.049550} + - {value: -0.060171} + - {value: -0.014452} + - {value: -0.001178} + - {value: +0.000325} + - {value: +0.000147} + - {value: -0.000006} + - {value: +0.000009} + - {value: -0.000007} + - {value: -0.000030} + - {value: -0.000039} + - {value: +0.000079} + - {value: -0.000056} + - {value: -0.027961} + - {value: +0.402593} + - {value: +1.000000} + - {value: +0.409904} + - {value: -0.046934} + - {value: -0.064435} + - {value: -0.016171} + - {value: -0.001528} + - {value: +0.000362} + - {value: +0.000148} + - {value: -0.000003} + - {value: -0.000008} + - {value: -0.000007} + - {value: -0.000017} + - {value: -0.000025} + - {value: -0.000019} + - {value: -0.062189} + - {value: -0.049550} + - {value: +0.409904} + - {value: +1.000000} + - {value: +0.429749} + - {value: -0.044436} + - {value: -0.072536} + - {value: -0.020592} + - {value: -0.001120} + - {value: +0.000342} + - {value: +0.000062} + - {value: +0.000007} + - {value: +0.000003} + - {value: -0.000004} + - {value: -0.000037} + - {value: +0.000012} + - {value: -0.016126} + - {value: -0.060171} + - {value: -0.046934} + - {value: +0.429749} + - {value: +1.000000} + - {value: +0.454566} + - {value: -0.040671} + - {value: -0.081088} + - {value: -0.017700} + - {value: +0.000141} + - {value: +0.000300} + - {value: +0.000067} + - {value: +0.000009} + - {value: -0.000006} + - {value: -0.000002} + - {value: -0.000027} + - {value: -0.001595} + - {value: -0.014452} + - {value: -0.064435} + - {value: -0.044436} + - {value: +0.454566} + - {value: +1.000000} + - {value: +0.479556} + - {value: -0.025980} + - {value: -0.072886} + - {value: -0.007802} + - {value: +0.000597} + - {value: +0.000188} + - {value: +0.000031} + - {value: -0.000053} + - {value: +0.000006} + - {value: -0.000017} + - {value: +0.000267} + - {value: -0.001178} + - {value: -0.016171} + - {value: -0.072536} + - {value: -0.040671} + - {value: +0.479556} + - {value: +1.000000} + - {value: +0.520140} + - {value: -0.067439} + - {value: -0.045386} + - {value: -0.002805} + - {value: +0.000492} + - {value: +0.000104} + - {value: -0.000197} + - {value: +0.000010} + - {value: -0.000118} + - {value: +0.000165} + - {value: +0.000325} + - {value: -0.001528} + - {value: -0.020592} + - {value: -0.081088} + - {value: -0.025980} + - {value: +0.520140} + - {value: +1.000000} + - {value: +0.346344} + - {value: -0.092598} + - {value: -0.028072} + - {value: -0.000224} + - {value: +0.000264} + - {value: -0.000001} + - {value: -0.000069} + - {value: -0.000014} + - {value: +0.000042} + - {value: +0.000147} + - {value: +0.000362} + - {value: -0.001120} + - {value: -0.017700} + - {value: -0.072886} + - {value: -0.067439} + - {value: +0.346344} + - {value: +1.000000} + - {value: +0.150627} + - {value: -0.075917} + - {value: -0.020117} + - {value: -0.000973} + - {value: +0.000563} + - {value: -0.000212} + - {value: +0.000018} + - {value: -0.000004} + - {value: -0.000006} + - {value: +0.000148} + - {value: +0.000342} + - {value: +0.000141} + - {value: -0.007802} + - {value: -0.045386} + - {value: -0.092598} + - {value: +0.150627} + - {value: +1.000000} + - {value: +0.184646} + - {value: -0.075038} + - {value: -0.024746} + - {value: -0.001541} + - {value: -0.000485} + - {value: -0.000041} + - {value: -0.000013} + - {value: +0.000009} + - {value: -0.000003} + - {value: +0.000062} + - {value: +0.000300} + - {value: +0.000597} + - {value: -0.002805} + - {value: -0.028072} + - {value: -0.075917} + - {value: +0.184646} + - {value: +1.000000} + - {value: +0.192065} + - {value: -0.080670} + - {value: -0.028807} + - {value: -0.000929} + - {value: +0.000100} + - {value: -0.000006} + - {value: -0.000007} + - {value: -0.000008} + - {value: +0.000007} + - {value: +0.000067} + - {value: +0.000188} + - {value: +0.000492} + - {value: -0.000224} + - {value: -0.020117} + - {value: -0.075038} + - {value: +0.192065} + - {value: +1.000000} + - {value: +0.226133} + - {value: -0.080182} + - {value: -0.023933} + - {value: -0.001255} + - {value: +0.000010} + - {value: -0.000030} + - {value: -0.000007} + - {value: +0.000003} + - {value: +0.000009} + - {value: +0.000031} + - {value: +0.000104} + - {value: +0.000264} + - {value: -0.000973} + - {value: -0.024746} + - {value: -0.080670} + - {value: +0.226133} + - {value: +1.000000} + - {value: +0.267126} + - {value: -0.074646} + - {value: -0.019251} + - {value: -0.000012} + - {value: -0.000039} + - {value: -0.000017} + - {value: -0.000004} + - {value: -0.000006} + - {value: -0.000053} + - {value: -0.000197} + - {value: -0.000001} + - {value: +0.000563} + - {value: -0.001541} + - {value: -0.028807} + - {value: -0.080182} + - {value: +0.267126} + - {value: +1.000000} + - {value: +0.125664} + - {value: -0.033750} + - {value: -0.000051} + - {value: +0.000079} + - {value: -0.000025} + - {value: -0.000037} + - {value: -0.000002} + - {value: +0.000006} + - {value: +0.000010} + - {value: -0.000069} + - {value: -0.000212} + - {value: -0.000485} + - {value: -0.000929} + - {value: -0.023933} + - {value: -0.074646} + - {value: +0.125664} + - {value: +1.000000} + - {value: -0.016987} + - {value: -0.000003} + - {value: -0.000056} + - {value: -0.000019} + - {value: +0.000012} + - {value: -0.000027} + - {value: -0.000017} + - {value: -0.000118} + - {value: -0.000014} + - {value: +0.000018} + - {value: -0.000041} + - {value: +0.000100} + - {value: -0.001255} + - {value: -0.019251} + - {value: -0.033750} + - {value: -0.016987} + - {value: +1.000000} +independent_variables: +- header: {name: '$p_\text{T}^\text{W}\text{ [GeV]}$'} + values: + - {low: 0.0, high: 25.0} + - {low: 0.0, high: 25.0} + - {low: 0.0, high: 25.0} + - {low: 0.0, high: 25.0} + - {low: 0.0, high: 25.0} + - {low: 0.0, high: 25.0} + - {low: 0.0, high: 25.0} + - {low: 0.0, high: 25.0} + - {low: 0.0, high: 25.0} + - {low: 0.0, high: 25.0} + - {low: 0.0, high: 25.0} + - {low: 0.0, high: 25.0} + - {low: 0.0, high: 25.0} + - {low: 0.0, high: 25.0} + - {low: 0.0, high: 25.0} + - {low: 0.0, high: 25.0} + - {low: 25.0, high: 50.0} + - {low: 25.0, high: 50.0} + - {low: 25.0, high: 50.0} + - {low: 25.0, high: 50.0} + - {low: 25.0, high: 50.0} + - {low: 25.0, high: 50.0} + - {low: 25.0, high: 50.0} + - {low: 25.0, high: 50.0} + - {low: 25.0, high: 50.0} + - {low: 25.0, high: 50.0} + - {low: 25.0, high: 50.0} + - {low: 25.0, high: 50.0} + - {low: 25.0, high: 50.0} + - {low: 25.0, high: 50.0} + - {low: 25.0, high: 50.0} + - {low: 25.0, high: 50.0} + - {low: 50.0, high: 75.0} + - {low: 50.0, high: 75.0} + - {low: 50.0, high: 75.0} + - {low: 50.0, high: 75.0} + - {low: 50.0, high: 75.0} + - {low: 50.0, high: 75.0} + - {low: 50.0, high: 75.0} + - {low: 50.0, high: 75.0} + - {low: 50.0, high: 75.0} + - {low: 50.0, high: 75.0} + - {low: 50.0, high: 75.0} + - {low: 50.0, high: 75.0} + - {low: 50.0, high: 75.0} + - {low: 50.0, high: 75.0} + - {low: 50.0, high: 75.0} + - {low: 50.0, high: 75.0} + - {low: 75.0, high: 100.0} + - {low: 75.0, high: 100.0} + - {low: 75.0, high: 100.0} + - {low: 75.0, high: 100.0} + - {low: 75.0, high: 100.0} + - {low: 75.0, high: 100.0} + - {low: 75.0, high: 100.0} + - {low: 75.0, high: 100.0} + - {low: 75.0, high: 100.0} + - {low: 75.0, high: 100.0} + - {low: 75.0, high: 100.0} + - {low: 75.0, high: 100.0} + - {low: 75.0, high: 100.0} + - {low: 75.0, high: 100.0} + - {low: 75.0, high: 100.0} + - {low: 75.0, high: 100.0} + - {low: 100.0, high: 125.0} + - {low: 100.0, high: 125.0} + - {low: 100.0, high: 125.0} + - {low: 100.0, high: 125.0} + - {low: 100.0, high: 125.0} + - {low: 100.0, high: 125.0} + - {low: 100.0, high: 125.0} + - {low: 100.0, high: 125.0} + - {low: 100.0, high: 125.0} + - {low: 100.0, high: 125.0} + - {low: 100.0, high: 125.0} + - {low: 100.0, high: 125.0} + - {low: 100.0, high: 125.0} + - {low: 100.0, high: 125.0} + - {low: 100.0, high: 125.0} + - {low: 100.0, high: 125.0} + - {low: 125.0, high: 150.0} + - {low: 125.0, high: 150.0} + - {low: 125.0, high: 150.0} + - {low: 125.0, high: 150.0} + - {low: 125.0, high: 150.0} + - {low: 125.0, high: 150.0} + - {low: 125.0, high: 150.0} + - {low: 125.0, high: 150.0} + - {low: 125.0, high: 150.0} + - {low: 125.0, high: 150.0} + - {low: 125.0, high: 150.0} + - {low: 125.0, high: 150.0} + - {low: 125.0, high: 150.0} + - {low: 125.0, high: 150.0} + - {low: 125.0, high: 150.0} + - {low: 125.0, high: 150.0} + - {low: 150.0, high: 175.0} + - {low: 150.0, high: 175.0} + - {low: 150.0, high: 175.0} + - {low: 150.0, high: 175.0} + - {low: 150.0, high: 175.0} + - {low: 150.0, high: 175.0} + - {low: 150.0, high: 175.0} + - {low: 150.0, high: 175.0} + - {low: 150.0, high: 175.0} + - {low: 150.0, high: 175.0} + - {low: 150.0, high: 175.0} + - {low: 150.0, high: 175.0} + - {low: 150.0, high: 175.0} + - {low: 150.0, high: 175.0} + - {low: 150.0, high: 175.0} + - {low: 150.0, high: 175.0} + - {low: 175.0, high: 200.0} + - {low: 175.0, high: 200.0} + - {low: 175.0, high: 200.0} + - {low: 175.0, high: 200.0} + - {low: 175.0, high: 200.0} + - {low: 175.0, high: 200.0} + - {low: 175.0, high: 200.0} + - {low: 175.0, high: 200.0} + - {low: 175.0, high: 200.0} + - {low: 175.0, high: 200.0} + - {low: 175.0, high: 200.0} + - {low: 175.0, high: 200.0} + - {low: 175.0, high: 200.0} + - {low: 175.0, high: 200.0} + - {low: 175.0, high: 200.0} + - {low: 175.0, high: 200.0} + - {low: 200.0, high: 250.0} + - {low: 200.0, high: 250.0} + - {low: 200.0, high: 250.0} + - {low: 200.0, high: 250.0} + - {low: 200.0, high: 250.0} + - {low: 200.0, high: 250.0} + - {low: 200.0, high: 250.0} + - {low: 200.0, high: 250.0} + - {low: 200.0, high: 250.0} + - {low: 200.0, high: 250.0} + - {low: 200.0, high: 250.0} + - {low: 200.0, high: 250.0} + - {low: 200.0, high: 250.0} + - {low: 200.0, high: 250.0} + - {low: 200.0, high: 250.0} + - {low: 200.0, high: 250.0} + - {low: 250.0, high: 300.0} + - {low: 250.0, high: 300.0} + - {low: 250.0, high: 300.0} + - {low: 250.0, high: 300.0} + - {low: 250.0, high: 300.0} + - {low: 250.0, high: 300.0} + - {low: 250.0, high: 300.0} + - {low: 250.0, high: 300.0} + - {low: 250.0, high: 300.0} + - {low: 250.0, high: 300.0} + - {low: 250.0, high: 300.0} + - {low: 250.0, high: 300.0} + - {low: 250.0, high: 300.0} + - {low: 250.0, high: 300.0} + - {low: 250.0, high: 300.0} + - {low: 250.0, high: 300.0} + - {low: 300.0, high: 350.0} + - {low: 300.0, high: 350.0} + - {low: 300.0, high: 350.0} + - {low: 300.0, high: 350.0} + - {low: 300.0, high: 350.0} + - {low: 300.0, high: 350.0} + - {low: 300.0, high: 350.0} + - {low: 300.0, high: 350.0} + - {low: 300.0, high: 350.0} + - {low: 300.0, high: 350.0} + - {low: 300.0, high: 350.0} + - {low: 300.0, high: 350.0} + - {low: 300.0, high: 350.0} + - {low: 300.0, high: 350.0} + - {low: 300.0, high: 350.0} + - {low: 300.0, high: 350.0} + - {low: 350.0, high: 400.0} + - {low: 350.0, high: 400.0} + - {low: 350.0, high: 400.0} + - {low: 350.0, high: 400.0} + - {low: 350.0, high: 400.0} + - {low: 350.0, high: 400.0} + - {low: 350.0, high: 400.0} + - {low: 350.0, high: 400.0} + - {low: 350.0, high: 400.0} + - {low: 350.0, high: 400.0} + - {low: 350.0, high: 400.0} + - {low: 350.0, high: 400.0} + - {low: 350.0, high: 400.0} + - {low: 350.0, high: 400.0} + - {low: 350.0, high: 400.0} + - {low: 350.0, high: 400.0} + - {low: 400.0, high: 450.0} + - {low: 400.0, high: 450.0} + - {low: 400.0, high: 450.0} + - {low: 400.0, high: 450.0} + - {low: 400.0, high: 450.0} + - {low: 400.0, high: 450.0} + - {low: 400.0, high: 450.0} + - {low: 400.0, high: 450.0} + - {low: 400.0, high: 450.0} + - {low: 400.0, high: 450.0} + - {low: 400.0, high: 450.0} + - {low: 400.0, high: 450.0} + - {low: 400.0, high: 450.0} + - {low: 400.0, high: 450.0} + - {low: 400.0, high: 450.0} + - {low: 400.0, high: 450.0} + - {low: 450.0, high: 500.0} + - {low: 450.0, high: 500.0} + - {low: 450.0, high: 500.0} + - {low: 450.0, high: 500.0} + - {low: 450.0, high: 500.0} + - {low: 450.0, high: 500.0} + - {low: 450.0, high: 500.0} + - {low: 450.0, high: 500.0} + - {low: 450.0, high: 500.0} + - {low: 450.0, high: 500.0} + - {low: 450.0, high: 500.0} + - {low: 450.0, high: 500.0} + - {low: 450.0, high: 500.0} + - {low: 450.0, high: 500.0} + - {low: 450.0, high: 500.0} + - {low: 450.0, high: 500.0} + - {low: 500.0, high: 600.0} + - {low: 500.0, high: 600.0} + - {low: 500.0, high: 600.0} + - {low: 500.0, high: 600.0} + - {low: 500.0, high: 600.0} + - {low: 500.0, high: 600.0} + - {low: 500.0, high: 600.0} + - {low: 500.0, high: 600.0} + - {low: 500.0, high: 600.0} + - {low: 500.0, high: 600.0} + - {low: 500.0, high: 600.0} + - {low: 500.0, high: 600.0} + - {low: 500.0, high: 600.0} + - {low: 500.0, high: 600.0} + - {low: 500.0, high: 600.0} + - {low: 500.0, high: 600.0} + - {low: 600.0, high: 800.0} + - {low: 600.0, high: 800.0} + - {low: 600.0, high: 800.0} + - {low: 600.0, high: 800.0} + - {low: 600.0, high: 800.0} + - {low: 600.0, high: 800.0} + - {low: 600.0, high: 800.0} + - {low: 600.0, high: 800.0} + - {low: 600.0, high: 800.0} + - {low: 600.0, high: 800.0} + - {low: 600.0, high: 800.0} + - {low: 600.0, high: 800.0} + - {low: 600.0, high: 800.0} + - {low: 600.0, high: 800.0} + - {low: 600.0, high: 800.0} + - {low: 600.0, high: 800.0} +- header: {name: '$p_\text{T}^\text{W}\text{ [GeV]}$'} + values: + - {low: 0.0, high: 25.0} + - {low: 25.0, high: 50.0} + - {low: 50.0, high: 75.0} + - {low: 75.0, high: 100.0} + - {low: 100.0, high: 125.0} + - {low: 125.0, high: 150.0} + - {low: 150.0, high: 175.0} + - {low: 175.0, high: 200.0} + - {low: 200.0, high: 250.0} + - {low: 250.0, high: 300.0} + - {low: 300.0, high: 350.0} + - {low: 350.0, high: 400.0} + - {low: 400.0, high: 450.0} + - {low: 450.0, high: 500.0} + - {low: 500.0, high: 600.0} + - {low: 600.0, high: 800.0} + - {low: 0.0, high: 25.0} + - {low: 25.0, high: 50.0} + - {low: 50.0, high: 75.0} + - {low: 75.0, high: 100.0} + - {low: 100.0, high: 125.0} + - {low: 125.0, high: 150.0} + - {low: 150.0, high: 175.0} + - {low: 175.0, high: 200.0} + - {low: 200.0, high: 250.0} + - {low: 250.0, high: 300.0} + - {low: 300.0, high: 350.0} + - {low: 350.0, high: 400.0} + - {low: 400.0, high: 450.0} + - {low: 450.0, high: 500.0} + - {low: 500.0, high: 600.0} + - {low: 600.0, high: 800.0} + - {low: 0.0, high: 25.0} + - {low: 25.0, high: 50.0} + - {low: 50.0, high: 75.0} + - {low: 75.0, high: 100.0} + - {low: 100.0, high: 125.0} + - {low: 125.0, high: 150.0} + - {low: 150.0, high: 175.0} + - {low: 175.0, high: 200.0} + - {low: 200.0, high: 250.0} + - {low: 250.0, high: 300.0} + - {low: 300.0, high: 350.0} + - {low: 350.0, high: 400.0} + - {low: 400.0, high: 450.0} + - {low: 450.0, high: 500.0} + - {low: 500.0, high: 600.0} + - {low: 600.0, high: 800.0} + - {low: 0.0, high: 25.0} + - {low: 25.0, high: 50.0} + - {low: 50.0, high: 75.0} + - {low: 75.0, high: 100.0} + - {low: 100.0, high: 125.0} + - {low: 125.0, high: 150.0} + - {low: 150.0, high: 175.0} + - {low: 175.0, high: 200.0} + - {low: 200.0, high: 250.0} + - {low: 250.0, high: 300.0} + - {low: 300.0, high: 350.0} + - {low: 350.0, high: 400.0} + - {low: 400.0, high: 450.0} + - {low: 450.0, high: 500.0} + - {low: 500.0, high: 600.0} + - {low: 600.0, high: 800.0} + - {low: 0.0, high: 25.0} + - {low: 25.0, high: 50.0} + - {low: 50.0, high: 75.0} + - {low: 75.0, high: 100.0} + - {low: 100.0, high: 125.0} + - {low: 125.0, high: 150.0} + - {low: 150.0, high: 175.0} + - {low: 175.0, high: 200.0} + - {low: 200.0, high: 250.0} + - {low: 250.0, high: 300.0} + - {low: 300.0, high: 350.0} + - {low: 350.0, high: 400.0} + - {low: 400.0, high: 450.0} + - {low: 450.0, high: 500.0} + - {low: 500.0, high: 600.0} + - {low: 600.0, high: 800.0} + - {low: 0.0, high: 25.0} + - {low: 25.0, high: 50.0} + - {low: 50.0, high: 75.0} + - {low: 75.0, high: 100.0} + - {low: 100.0, high: 125.0} + - {low: 125.0, high: 150.0} + - {low: 150.0, high: 175.0} + - {low: 175.0, high: 200.0} + - {low: 200.0, high: 250.0} + - {low: 250.0, high: 300.0} + - {low: 300.0, high: 350.0} + - {low: 350.0, high: 400.0} + - {low: 400.0, high: 450.0} + - {low: 450.0, high: 500.0} + - {low: 500.0, high: 600.0} + - {low: 600.0, high: 800.0} + - {low: 0.0, high: 25.0} + - {low: 25.0, high: 50.0} + - {low: 50.0, high: 75.0} + - {low: 75.0, high: 100.0} + - {low: 100.0, high: 125.0} + - {low: 125.0, high: 150.0} + - {low: 150.0, high: 175.0} + - {low: 175.0, high: 200.0} + - {low: 200.0, high: 250.0} + - {low: 250.0, high: 300.0} + - {low: 300.0, high: 350.0} + - {low: 350.0, high: 400.0} + - {low: 400.0, high: 450.0} + - {low: 450.0, high: 500.0} + - {low: 500.0, high: 600.0} + - {low: 600.0, high: 800.0} + - {low: 0.0, high: 25.0} + - {low: 25.0, high: 50.0} + - {low: 50.0, high: 75.0} + - {low: 75.0, high: 100.0} + - {low: 100.0, high: 125.0} + - {low: 125.0, high: 150.0} + - {low: 150.0, high: 175.0} + - {low: 175.0, high: 200.0} + - {low: 200.0, high: 250.0} + - {low: 250.0, high: 300.0} + - {low: 300.0, high: 350.0} + - {low: 350.0, high: 400.0} + - {low: 400.0, high: 450.0} + - {low: 450.0, high: 500.0} + - {low: 500.0, high: 600.0} + - {low: 600.0, high: 800.0} + - {low: 0.0, high: 25.0} + - {low: 25.0, high: 50.0} + - {low: 50.0, high: 75.0} + - {low: 75.0, high: 100.0} + - {low: 100.0, high: 125.0} + - {low: 125.0, high: 150.0} + - {low: 150.0, high: 175.0} + - {low: 175.0, high: 200.0} + - {low: 200.0, high: 250.0} + - {low: 250.0, high: 300.0} + - {low: 300.0, high: 350.0} + - {low: 350.0, high: 400.0} + - {low: 400.0, high: 450.0} + - {low: 450.0, high: 500.0} + - {low: 500.0, high: 600.0} + - {low: 600.0, high: 800.0} + - {low: 0.0, high: 25.0} + - {low: 25.0, high: 50.0} + - {low: 50.0, high: 75.0} + - {low: 75.0, high: 100.0} + - {low: 100.0, high: 125.0} + - {low: 125.0, high: 150.0} + - {low: 150.0, high: 175.0} + - {low: 175.0, high: 200.0} + - {low: 200.0, high: 250.0} + - {low: 250.0, high: 300.0} + - {low: 300.0, high: 350.0} + - {low: 350.0, high: 400.0} + - {low: 400.0, high: 450.0} + - {low: 450.0, high: 500.0} + - {low: 500.0, high: 600.0} + - {low: 600.0, high: 800.0} + - {low: 0.0, high: 25.0} + - {low: 25.0, high: 50.0} + - {low: 50.0, high: 75.0} + - {low: 75.0, high: 100.0} + - {low: 100.0, high: 125.0} + - {low: 125.0, high: 150.0} + - {low: 150.0, high: 175.0} + - {low: 175.0, high: 200.0} + - {low: 200.0, high: 250.0} + - {low: 250.0, high: 300.0} + - {low: 300.0, high: 350.0} + - {low: 350.0, high: 400.0} + - {low: 400.0, high: 450.0} + - {low: 450.0, high: 500.0} + - {low: 500.0, high: 600.0} + - {low: 600.0, high: 800.0} + - {low: 0.0, high: 25.0} + - {low: 25.0, high: 50.0} + - {low: 50.0, high: 75.0} + - {low: 75.0, high: 100.0} + - {low: 100.0, high: 125.0} + - {low: 125.0, high: 150.0} + - {low: 150.0, high: 175.0} + - {low: 175.0, high: 200.0} + - {low: 200.0, high: 250.0} + - {low: 250.0, high: 300.0} + - {low: 300.0, high: 350.0} + - {low: 350.0, high: 400.0} + - {low: 400.0, high: 450.0} + - {low: 450.0, high: 500.0} + - {low: 500.0, high: 600.0} + - {low: 600.0, high: 800.0} + - {low: 0.0, high: 25.0} + - {low: 25.0, high: 50.0} + - {low: 50.0, high: 75.0} + - {low: 75.0, high: 100.0} + - {low: 100.0, high: 125.0} + - {low: 125.0, high: 150.0} + - {low: 150.0, high: 175.0} + - {low: 175.0, high: 200.0} + - {low: 200.0, high: 250.0} + - {low: 250.0, high: 300.0} + - {low: 300.0, high: 350.0} + - {low: 350.0, high: 400.0} + - {low: 400.0, high: 450.0} + - {low: 450.0, high: 500.0} + - {low: 500.0, high: 600.0} + - {low: 600.0, high: 800.0} + - {low: 0.0, high: 25.0} + - {low: 25.0, high: 50.0} + - {low: 50.0, high: 75.0} + - {low: 75.0, high: 100.0} + - {low: 100.0, high: 125.0} + - {low: 125.0, high: 150.0} + - {low: 150.0, high: 175.0} + - {low: 175.0, high: 200.0} + - {low: 200.0, high: 250.0} + - {low: 250.0, high: 300.0} + - {low: 300.0, high: 350.0} + - {low: 350.0, high: 400.0} + - {low: 400.0, high: 450.0} + - {low: 450.0, high: 500.0} + - {low: 500.0, high: 600.0} + - {low: 600.0, high: 800.0} + - {low: 0.0, high: 25.0} + - {low: 25.0, high: 50.0} + - {low: 50.0, high: 75.0} + - {low: 75.0, high: 100.0} + - {low: 100.0, high: 125.0} + - {low: 125.0, high: 150.0} + - {low: 150.0, high: 175.0} + - {low: 175.0, high: 200.0} + - {low: 200.0, high: 250.0} + - {low: 250.0, high: 300.0} + - {low: 300.0, high: 350.0} + - {low: 350.0, high: 400.0} + - {low: 400.0, high: 450.0} + - {low: 450.0, high: 500.0} + - {low: 500.0, high: 600.0} + - {low: 600.0, high: 800.0} + - {low: 0.0, high: 25.0} + - {low: 25.0, high: 50.0} + - {low: 50.0, high: 75.0} + - {low: 75.0, high: 100.0} + - {low: 100.0, high: 125.0} + - {low: 125.0, high: 150.0} + - {low: 150.0, high: 175.0} + - {low: 175.0, high: 200.0} + - {low: 200.0, high: 250.0} + - {low: 250.0, high: 300.0} + - {low: 300.0, high: 350.0} + - {low: 350.0, high: 400.0} + - {low: 400.0, high: 450.0} + - {low: 450.0, high: 500.0} + - {low: 500.0, high: 600.0} + - {low: 600.0, high: 800.0} diff --git a/nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/uncertainties_WM-PT.yaml b/nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/uncertainties_WM-PT.yaml new file mode 100644 index 0000000000..80822fe602 --- /dev/null +++ b/nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/uncertainties_WM-PT.yaml @@ -0,0 +1,1402 @@ +definitions: + art_stat_corr_1: + description: Artificial statistical uncertainty 1 + treatment: ADD + type: CORR + art_stat_corr_2: + description: Artificial statistical uncertainty 2 + treatment: ADD + type: CORR + art_stat_corr_3: + description: Artificial statistical uncertainty 3 + treatment: ADD + type: CORR + art_stat_corr_4: + description: Artificial statistical uncertainty 4 + treatment: ADD + type: CORR + art_stat_corr_5: + description: Artificial statistical uncertainty 5 + treatment: ADD + type: CORR + art_stat_corr_6: + description: Artificial statistical uncertainty 6 + treatment: ADD + type: CORR + art_stat_corr_7: + description: Artificial statistical uncertainty 7 + treatment: ADD + type: CORR + art_stat_corr_8: + description: Artificial statistical uncertainty 8 + treatment: ADD + type: CORR + art_stat_corr_9: + description: Artificial statistical uncertainty 9 + treatment: ADD + type: CORR + art_stat_corr_10: + description: Artificial statistical uncertainty 10 + treatment: ADD + type: CORR + art_stat_corr_11: + description: Artificial statistical uncertainty 11 + treatment: ADD + type: CORR + art_stat_corr_12: + description: Artificial statistical uncertainty 12 + treatment: ADD + type: CORR + art_stat_corr_13: + description: Artificial statistical uncertainty 13 + treatment: ADD + type: CORR + art_stat_corr_14: + description: Artificial statistical uncertainty 14 + treatment: ADD + type: CORR + art_stat_corr_15: + description: Artificial statistical uncertainty 15 + treatment: ADD + type: CORR + art_stat_corr_16: + description: Artificial statistical uncertainty 16 + treatment: ADD + type: CORR + JetScaleEff1: + description: 'Systematic: JetScaleEff1' + treatment: MULT + type: ATLASWJ1 + JetScaleEff2: + description: 'Systematic: JetScaleEff2' + treatment: MULT + type: ATLASWJ2 + JetScaleEff3: + description: 'Systematic: JetScaleEff3' + treatment: MULT + type: ATLASWJ3 + JetScaleEff4: + description: 'Systematic: JetScaleEff4' + treatment: MULT + type: ATLASWJ4 + JetScaleEff5: + description: 'Systematic: JetScaleEff5' + treatment: MULT + type: ATLASWJ5 + JetScaleEff6: + description: 'Systematic: JetScaleEff6' + treatment: MULT + type: ATLASWJ6 + JetScaleEta1: + description: 'Systematic: JetScaleEta1' + treatment: MULT + type: ATLASWJ7 + JetScaleEta2: + description: 'Systematic: JetScaleEta2' + treatment: MULT + type: ATLASWJ8 + JetScaleHighPt: + description: 'Systematic: JetScaleHighPt' + treatment: MULT + type: ATLASWJ9 + JetScaleMC: + description: 'Systematic: JetScaleMC' + treatment: MULT + type: ATLASWJ10 + JetScalePileup1: + description: 'Systematic: JetScalePileup1' + treatment: MULT + type: ATLASWJ11 + JetScalePileup2: + description: 'Systematic: JetScalePileup2' + treatment: MULT + type: ATLASWJ12 + JetScalePileup3: + description: 'Systematic: JetScalePileup3' + treatment: MULT + type: ATLASWJ13 + JetScalePileup4: + description: 'Systematic: JetScalePileup4' + treatment: MULT + type: ATLASWJ14 + JetScaleFlav1Known: + description: 'Systematic: JetScaleFlav1Known' + treatment: MULT + type: ATLASWJ15 + JetScaleFlav2: + description: 'Systematic: JetScaleFlav2' + treatment: MULT + type: ATLASWJ16 + JetScaleBjet: + description: 'Systematic: JetScaleBjet' + treatment: MULT + type: ATLASWJ17 + JetScalepunchT: + description: 'Systematic: JetScalepunchT' + treatment: MULT + type: ATLASWJ18 + JetResolution10: + description: 'Systematic: JetResolution10' + treatment: MULT + type: ATLASWJ19 + JetSFBeff: + description: 'Systematic: JetSFBeff' + treatment: MULT + type: ATLASWJ20 + JetSFCeff: + description: 'Systematic: JetSFCeff' + treatment: MULT + type: ATLASWJ21 + JetSFLmistag: + description: 'Systematic: JetSFLmistag' + treatment: MULT + type: ATLASWJ22 + JetSFHighPt: + description: 'Systematic: JetSFHighPt' + treatment: MULT + type: ATLASWJ23 + JetJVFcut: + description: 'Systematic: JetJVFcut' + treatment: MULT + type: ATLASWJ24 + ElScaleR12: + description: 'Systematic: ElScaleR12' + treatment: MULT + type: ATLASWJ25 + ElScaleZee: + description: 'Systematic: ElScaleZee' + treatment: MULT + type: ATLASWJ26 + ElScalePS: + description: 'Systematic: ElScalePS' + treatment: MULT + type: ATLASWJ27 + ElResolution: + description: 'Systematic: ElResolution' + treatment: MULT + type: ATLASWJ28 + ElSFReco: + description: 'Systematic: ElSFReco' + treatment: MULT + type: ATLASWJ29 + ElSFId: + description: 'Systematic: ElSFId' + treatment: MULT + type: ATLASWJ30 + ElSFTrigger: + description: 'Systematic: ElSFTrigger' + treatment: MULT + type: ATLASWJ31 + ElSFIso: + description: 'Systematic: ElSFIso' + treatment: MULT + type: ATLASWJ32 + ElSFChargeMisID: + description: 'Systematic: ElSFChargeMisID' + treatment: MULT + type: ATLASWJ33 + METScale: + description: 'Systematic: METScale' + treatment: MULT + type: ATLASWJ34 + METResLong: + description: 'Systematic: METResLong' + treatment: MULT + type: ATLASWJ35 + METResTrans: + description: 'Systematic: METResTrans' + treatment: MULT + type: ATLASWJ36 + PileupWeight: + description: 'Systematic: PileupWeight' + treatment: MULT + type: ATLASWJ37 + QCDlowRange: + description: 'Systematic: QCDlowRange' + treatment: MULT + type: ATLASWJ38 + QCDhighRange: + description: 'Systematic: QCDhighRange' + treatment: MULT + type: ATLASWJ39 + QCDvarIso: + description: 'Systematic: QCDvarIso' + treatment: MULT + type: ATLASWJ40 + QCDvarElID: + description: 'Systematic: QCDvarElID' + treatment: MULT + type: ATLASWJ41 + QCDfitUncert: + description: 'Systematic: QCDfitUncert' + treatment: MULT + type: ATLASWJ42 + QCDotherGen: + description: 'Systematic: QCDotherGen' + treatment: MULT + type: ATLASWJ43 + QCDfitRebin: + description: 'Systematic: QCDfitRebin' + treatment: MULT + type: ATLASWJ44 + XsecZ: + description: 'Systematic: XsecZ' + treatment: MULT + type: ATLASWJ45 + XsecTop: + description: 'Systematic: XsecTop' + treatment: MULT + type: ATLASWJ46 + XsecDibos: + description: 'Systematic: XsecDibos' + treatment: MULT + type: ATLASWJ47 + BkgTtbarNorm: + description: 'Systematic: BkgTtbarNorm' + treatment: MULT + type: ATLASWJ48 + BkgMCstat: + description: 'Systematic: BkgMCstat' + treatment: MULT + type: ATLASWJ49 + WHFmodel: + description: 'Systematic: WHFmodel' + treatment: MULT + type: ATLASWJ50 + LumiUncert: + description: 'Systematic: LumiUncert' + treatment: MULT + type: ATLASLUMI12 + UnfoldMCstat: + description: 'Systematic: UnfoldMCstat' + treatment: MULT + type: UNCORR + UnfoldOtherGen: + description: 'Systematic: UnfoldOtherGen' + treatment: MULT + type: UNCORR + UnfoldReweight: + description: 'Systematic: UnfoldReweight' + treatment: MULT + type: UNCORR +bins: +- art_stat_corr_1: -6.27588381e-01 + art_stat_corr_2: -6.54163592e-01 + art_stat_corr_3: -3.67451045e-01 + art_stat_corr_4: -1.95953283e-01 + art_stat_corr_5: -6.27998321e-02 + art_stat_corr_6: -2.85290412e-02 + art_stat_corr_7: 5.11806271e-03 + art_stat_corr_8: 9.55272013e-04 + art_stat_corr_9: 1.63525608e-04 + art_stat_corr_10: 2.06712475e-05 + art_stat_corr_11: 1.28429809e-06 + art_stat_corr_12: 1.24480014e-07 + art_stat_corr_13: 7.92558341e-09 + art_stat_corr_14: -5.37921958e-09 + art_stat_corr_15: 1.25540426e-08 + art_stat_corr_16: -2.87323680e-10 + JetScaleEff1: 9.50105257e+01 + JetScaleEff2: 2.15116248e+01 + JetScaleEff3: 3.0 + JetScaleEff4: 1.0 + JetScaleEff5: 3.0 + JetScaleEff6: 6.0 + JetScaleEta1: 4.85051544e+01 + JetScaleEta2: 2.45102020e+01 + JetScaleHighPt: 2.82842712e-01 + JetScaleMC: 4.24264069e-01 + JetScalePileup1: 4.12310563e+00 + JetScalePileup2: 1.15217186e+01 + JetScalePileup3: 2.59807621e+00 + JetScalePileup4: 6.25039999e+01 + JetScaleFlav1Known: 1.90525589e+01 + JetScaleFlav2: 7.75290268e+01 + JetScaleBjet: 9.83615779e-02 + JetScalepunchT: 1.41421356e-01 + JetResolution10: 171 + JetSFBeff: 6.0 + JetSFCeff: 3.57071421e+00 + JetSFLmistag: 3.0 + JetSFHighPt: 2.17944947e-01 + JetJVFcut: 1.49248116e+01 + ElScaleR12: 1.0 + ElScaleZee: 1.65151446e+01 + ElScalePS: 3.57071421e-01 + ElResolution: -1 + ElSFReco: 3.0 + ElSFId: 11.0 + ElSFTrigger: 9.0 + ElSFIso: 3.0 + ElSFChargeMisID: 9.83615779e-02 + METScale: 1.03923048e+01 + METResLong: 4 + METResTrans: -4 + PileupWeight: 1.45172311e+01 + QCDlowRange: 2.29510348e+01 + QCDhighRange: 3.31662479e+00 + QCDvarIso: 6 + QCDvarElID: 52 + QCDfitUncert: 5 + QCDotherGen: 37 + QCDfitRebin: -0.5 + XsecZ: 6.0 + XsecTop: 3.0 + XsecDibos: 1.0 + BkgTtbarNorm: -2 + BkgMCstat: -2 + WHFmodel: -4 + LumiUncert: 3.40293991e+01 + UnfoldMCstat: -4 + UnfoldOtherGen: 29 + UnfoldReweight: 51 +- art_stat_corr_1: -8.90086981e-01 + art_stat_corr_2: -9.85839862e-02 + art_stat_corr_3: 3.09682676e-01 + art_stat_corr_4: 2.92538915e-01 + art_stat_corr_5: 1.11817531e-01 + art_stat_corr_6: 6.20263408e-02 + art_stat_corr_7: -1.35937425e-02 + art_stat_corr_8: -2.91237694e-03 + art_stat_corr_9: -5.31881137e-04 + art_stat_corr_10: -7.15094056e-05 + art_stat_corr_11: -4.20899494e-06 + art_stat_corr_12: -4.36358514e-07 + art_stat_corr_13: 9.62373886e-10 + art_stat_corr_14: -5.12203413e-09 + art_stat_corr_15: -1.76563638e-08 + art_stat_corr_16: 7.06592452e-10 + JetScaleEff1: 2.03501228e+02 + JetScaleEff2: 4.80208288e+01 + JetScaleEff3: 6.16441400e+00 + JetScaleEff4: 3.31662479e+00 + JetScaleEff5: 8.12403840e+00 + JetScaleEff6: 1.20830460e+01 + JetScaleEta1: 9.90101005e+01 + JetScaleEta2: 5.05445348e+01 + JetScaleHighPt: 1.41421356e+00 + JetScaleMC: 1.41421356e+00 + JetScalePileup1: 7.39932429e+00 + JetScalePileup2: 2.25997788e+01 + JetScalePileup3: 5.0 + JetScalePileup4: 1.33007519e+02 + JetScaleFlav1Known: 4.05061724e+01 + JetScaleFlav2: 1.62513846e+02 + JetScaleBjet: 2.17944947e-01 + JetScalepunchT: 3.57071421e-01 + JetResolution10: 378 + JetSFBeff: 9.0 + JetSFCeff: 7.53325959e+00 + JetSFLmistag: 6.0 + JetSFHighPt: 4.35889894e-01 + JetJVFcut: 3.22645316e+01 + ElScaleR12: 6.0 + ElScaleZee: 4.25529082e+01 + ElScalePS: 1.0 + ElResolution: -3 + ElSFReco: 9.52627944e+00 + ElSFId: 3.00333148e+01 + ElSFTrigger: 2.25111084e+01 + ElSFIso: 7.0 + ElSFChargeMisID: 2.17944947e-01 + METScale: 8.75028571e+01 + METResLong: -86 + METResTrans: -80 + PileupWeight: 2.60384331e+01 + QCDlowRange: 3.41284339e+01 + QCDhighRange: 4.09267639e+00 + QCDvarIso: -2 + QCDvarElID: 34 + QCDfitUncert: 7 + QCDotherGen: 48 + QCDfitRebin: -1 + XsecZ: 4.0 + XsecTop: 4.0 + XsecDibos: 2.0 + BkgTtbarNorm: -4 + BkgMCstat: -2 + WHFmodel: 21 + LumiUncert: 8.35269418e+01 + UnfoldMCstat: -6 + UnfoldOtherGen: 306 + UnfoldReweight: -40 +- art_stat_corr_1: -6.28240902e-01 + art_stat_corr_2: 7.27207187e-01 + art_stat_corr_3: 2.45177992e-03 + art_stat_corr_4: -2.19512710e-01 + art_stat_corr_5: -1.34616644e-01 + art_stat_corr_6: -9.66998432e-02 + art_stat_corr_7: 2.77540976e-02 + art_stat_corr_8: 6.81914748e-03 + art_stat_corr_9: 1.38111039e-03 + art_stat_corr_10: 1.90963620e-04 + art_stat_corr_11: 1.18682261e-05 + art_stat_corr_12: 1.11013903e-06 + art_stat_corr_13: -9.55459529e-08 + art_stat_corr_14: 8.75280340e-09 + art_stat_corr_15: 9.93378663e-09 + art_stat_corr_16: 3.17007765e-10 + JetScaleEff1: 9.15027322e+01 + JetScaleEff2: 1.75142799e+01 + JetScaleEff3: 2.0 + JetScaleEff4: 1.05237826e+01 + JetScaleEff5: 3.57071421e+00 + JetScaleEff6: 5.0 + JetScaleEta1: 4.05061724e+01 + JetScaleEta2: 2.05121915e+01 + JetScaleHighPt: 4.24264069e-01 + JetScaleMC: 5.65685425e-01 + JetScalePileup1: 2.44948974e+00 + JetScalePileup2: 8.76070773e+00 + JetScalePileup3: 4.55521679e+00 + JetScalePileup4: 56.0 + JetScaleFlav1Known: 1.55161206e+01 + JetScaleFlav2: 7.25034482e+01 + JetScaleBjet: 1.03440804e-01 + JetScalepunchT: 2.17944947e-01 + JetResolution10: 170 + JetSFBeff: 7.0 + JetSFCeff: 5.0 + JetSFLmistag: 3.57071421e+00 + JetSFHighPt: 2.17944947e-01 + JetJVFcut: 1.08050914e+01 + ElScaleR12: 6.53834842e+00 + ElScaleZee: 2.05121915e+01 + ElScalePS: 8.18535277e-01 + ElResolution: -1 + ElSFReco: 6.0 + ElSFId: 17.0 + ElSFTrigger: 12.0 + ElSFIso: 4.0 + ElSFChargeMisID: 9.83615779e-02 + METScale: 6.60151498e+01 + METResLong: -61 + METResTrans: -59 + PileupWeight: 1.45172311e+01 + QCDlowRange: 1.32193041e+01 + QCDhighRange: 1.65831240e+00 + QCDvarIso: -6 + QCDvarElID: 3 + QCDfitUncert: 3 + QCDotherGen: 21 + QCDfitRebin: -0.3 + XsecZ: 2.59807621e-02 + XsecTop: 4.0 + XsecDibos: 1.0 + BkgTtbarNorm: -3 + BkgMCstat: -1 + WHFmodel: 11 + LumiUncert: 4.40227214e+01 + UnfoldMCstat: -3 + UnfoldOtherGen: 31 + UnfoldReweight: -13 +- art_stat_corr_1: -1.07692642e-01 + art_stat_corr_2: 3.93070594e-01 + art_stat_corr_3: -5.00489319e-01 + art_stat_corr_4: 1.16854468e-01 + art_stat_corr_5: 1.52562177e-01 + art_stat_corr_6: 1.76484855e-01 + art_stat_corr_7: -6.97890629e-02 + art_stat_corr_8: -2.09367924e-02 + art_stat_corr_9: -4.66998039e-03 + art_stat_corr_10: -6.95360562e-04 + art_stat_corr_11: -4.35891306e-05 + art_stat_corr_12: -4.36185324e-06 + art_stat_corr_13: 3.79728993e-07 + art_stat_corr_14: -5.52234078e-08 + art_stat_corr_15: -7.89706606e-10 + art_stat_corr_16: -1.31498679e-09 + JetScaleEff1: 3.01500829e+01 + JetScaleEff2: 2.20624115e+00 + JetScaleEff3: 2.60384331e+00 + JetScaleEff4: 5.80172388e+00 + JetScaleEff5: 1.40712473e+00 + JetScaleEff6: 2.35106359e+00 + JetScaleEta1: 1.27070846e+01 + JetScaleEta2: 6.7 + JetScaleHighPt: 1.41421356e-01 + JetScaleMC: 2.17944947e-01 + JetScalePileup1: 1.06301458e+00 + JetScalePileup2: 2.40156199e+00 + JetScalePileup3: 2.5 + JetScalePileup4: 1.80501385e+01 + JetScaleFlav1Known: 4.55054942e+00 + JetScaleFlav2: 2.52508911e+01 + JetScaleBjet: 4.35889894e-02 + JetScalepunchT: 1.03440804e-01 + JetResolution10: 44.8 + JetSFBeff: 4.95454337e+00 + JetSFCeff: 2.30434372e+00 + JetSFLmistag: 1.60623784e+00 + JetSFHighPt: 9.83615779e-02 + JetJVFcut: 3.97114593e+00 + ElScaleR12: 3.51140997e+00 + ElScaleZee: 6.80587981e+00 + ElScalePS: 7.39932429e-01 + ElResolution: -0.6 + ElSFReco: 2.95084734e+00 + ElSFId: 7.95031446e+00 + ElSFTrigger: 4.40227214e+00 + ElSFIso: 1.75142799e+00 + ElSFChargeMisID: 3.84057287e-02 + METScale: 2.42674164e+01 + METResLong: -19.7 + METResTrans: -21.1 + PileupWeight: 4.60868745e+00 + QCDlowRange: 3.51140997e+00 + QCDhighRange: 4.09267639e-01 + QCDvarIso: -2.9 + QCDvarElID: 1.4 + QCDfitUncert: 1.1 + QCDotherGen: 6.5 + QCDfitRebin: -0.1 + XsecZ: 0.2 + XsecTop: 2.6 + XsecDibos: 0.7 + BkgTtbarNorm: -2.3 + BkgMCstat: -0.6 + WHFmodel: 2.3 + LumiUncert: 1.79050272e+01 + UnfoldMCstat: -1.8 + UnfoldOtherGen: 13.5 + UnfoldReweight: -1.7 +- art_stat_corr_1: 2.37945148e-02 + art_stat_corr_2: 5.56663946e-02 + art_stat_corr_3: -2.77341479e-01 + art_stat_corr_4: 3.43071370e-01 + art_stat_corr_5: -4.76946085e-02 + art_stat_corr_6: -1.71103507e-01 + art_stat_corr_7: 1.31582863e-01 + art_stat_corr_8: 5.15532367e-02 + art_stat_corr_9: 1.38216945e-02 + art_stat_corr_10: 2.18589555e-03 + art_stat_corr_11: 1.53135993e-04 + art_stat_corr_12: 1.49091707e-05 + art_stat_corr_13: -1.47381865e-06 + art_stat_corr_14: 1.86193678e-07 + art_stat_corr_15: 1.45881610e-09 + art_stat_corr_16: 3.74209977e-09 + JetScaleEff1: 11.1 + JetScaleEff2: 1.13137085e+00 + JetScaleEff3: 1.70587221e+00 + JetScaleEff4: 2.16043977e+00 + JetScaleEff5: 6.53834842e-01 + JetScaleEff6: 1.15217186e+00 + JetScaleEta1: 4.65483619e+00 + JetScaleEta2: 2.50399681e+00 + JetScaleHighPt: 1.08972474e-01 + JetScaleMC: 1.41421356e-01 + JetScalePileup1: 4.89897949e-01 + JetScalePileup2: 9.43398113e-01 + JetScalePileup3: 1.23288280e+00 + JetScalePileup4: 6.75333251e+00 + JetScaleFlav1Known: 1.65151446e+00 + JetScaleFlav2: 1.02502439e+01 + JetScaleBjet: 2.17944947e-02 + JetScalepunchT: 3.57071421e-02 + JetResolution10: 12.5 + JetSFBeff: 3.25691572e+00 + JetSFCeff: 1.10905365e+00 + JetSFLmistag: 8.12403840e-01 + JetSFHighPt: 0.03 + JetJVFcut: 2.19715725e+00 + ElScaleR12: 1.52643375e+00 + ElScaleZee: 2.31732605e+00 + ElScalePS: 3.27871926e-01 + ElResolution: -0.2 + ElSFReco: 1.60623784e+00 + ElSFId: 4.05061724e+00 + ElSFTrigger: 2.00499377e+00 + ElSFIso: 9.11043358e-01 + ElSFChargeMisID: 2.17944947e-02 + METScale: 7.85795775e+00 + METResLong: -5.8 + METResTrans: -6.5 + PileupWeight: 1.07121426e+00 + QCDlowRange: 9.83615779e-01 + QCDhighRange: 8.17006732e-02 + QCDvarIso: -1.6 + QCDvarElID: -1.9 + QCDfitUncert: 0.4 + QCDotherGen: 2.0 + QCDfitRebin: -0.02 + XsecZ: 0.1 + XsecTop: 1.7 + XsecDibos: 0.3 + BkgTtbarNorm: -1.6 + BkgMCstat: -0.4 + WHFmodel: -0.2 + LumiUncert: 7.85286572e+00 + UnfoldMCstat: -1.1 + UnfoldOtherGen: 7.6 + UnfoldReweight: -0.7 +- art_stat_corr_1: 1.78855293e-02 + art_stat_corr_2: -1.93731092e-02 + art_stat_corr_3: -4.73008530e-02 + art_stat_corr_4: 2.02728173e-01 + art_stat_corr_5: -2.93360231e-01 + art_stat_corr_6: -8.81459512e-02 + art_stat_corr_7: -1.15164838e-01 + art_stat_corr_8: -8.92017578e-02 + art_stat_corr_9: -2.98183522e-02 + art_stat_corr_10: -5.43914138e-03 + art_stat_corr_11: -4.00100163e-04 + art_stat_corr_12: -4.35710097e-05 + art_stat_corr_13: 4.01745246e-06 + art_stat_corr_14: -6.00685323e-07 + art_stat_corr_15: -1.09948833e-09 + art_stat_corr_16: -5.81478136e-09 + JetScaleEff1: 4.95454337e+00 + JetScaleEff2: 1.00995049e+00 + JetScaleEff3: 1.00995049e+00 + JetScaleEff4: 6.53834842e-01 + JetScaleEff5: 6.53834842e-01 + JetScaleEff6: 5.54526825e-01 + JetScaleEta1: 1.95128163e+00 + JetScaleEta2: 1.15217186e+00 + JetScaleHighPt: 2.82842712e-02 + JetScaleMC: 4.97493719e-02 + JetScalePileup1: 2.44948974e-01 + JetScalePileup2: 4.24264069e-01 + JetScalePileup3: 0.7 + JetScalePileup4: 3.0 + JetScaleFlav1Known: 7.53325959e-01 + JetScaleFlav2: 4.90204039e+00 + JetScaleBjet: 1.03440804e-02 + JetScalepunchT: 1.41421356e-02 + JetResolution10: 4.5 + JetSFBeff: 2.0 + JetSFCeff: 6.53834842e-01 + JetSFLmistag: 3.57071421e-01 + JetSFHighPt: 2.17944947e-02 + JetJVFcut: 1.34443297e+00 + ElScaleR12: 6.53834842e-01 + ElScaleZee: 0.9 + ElScalePS: 1.64924225e-01 + ElResolution: -0.1 + ElSFReco: 8.52936105e-01 + ElSFId: 2.1 + ElSFTrigger: 1.0 + ElSFIso: 4.55521679e-01 + ElSFChargeMisID: 9.83615779e-03 + METScale: 3.0 + METResLong: -2.5 + METResTrans: -2.6 + PileupWeight: 5.19615242e-01 + QCDlowRange: 3.31662479e-01 + QCDhighRange: 4.12310563e-02 + QCDvarIso: -0.9 + QCDvarElID: -0.8 + QCDfitUncert: 0.2 + QCDotherGen: 0.8 + QCDfitRebin: -0.005 + XsecZ: 0.1 + XsecTop: 1.0 + XsecDibos: 0.2 + BkgTtbarNorm: -1.0 + BkgMCstat: -0.3 + WHFmodel: -0.1 + LumiUncert: 3.80263067e+00 + UnfoldMCstat: -0.8 + UnfoldOtherGen: 3.9 + UnfoldReweight: -0.3 +- art_stat_corr_1: 5.27985999e-03 + art_stat_corr_2: -1.48736855e-02 + art_stat_corr_3: 2.23558216e-02 + art_stat_corr_4: 5.62945920e-02 + art_stat_corr_5: -3.04605281e-01 + art_stat_corr_6: 2.16710464e-01 + art_stat_corr_7: -1.85421647e-02 + art_stat_corr_8: 7.81107675e-02 + art_stat_corr_9: 4.36825579e-02 + art_stat_corr_10: 8.96202789e-03 + art_stat_corr_11: 7.97026385e-04 + art_stat_corr_12: 8.50376294e-05 + art_stat_corr_13: -9.19932408e-06 + art_stat_corr_14: 1.30028118e-06 + art_stat_corr_15: 2.94599346e-08 + art_stat_corr_16: 9.47610265e-09 + JetScaleEff1: 2.53063233e+00 + JetScaleEff2: 8.16026960e-01 + JetScaleEff3: 0.64 + JetScaleEff4: 3.12889757e-01 + JetScaleEff5: 3.07571130e-01 + JetScaleEff6: 2.93087018e-01 + JetScaleEta1: 9.97033099e-01 + JetScaleEta2: 6.70596749e-01 + JetScaleHighPt: 1.41421356e-02 + JetScaleMC: 2.17944947e-02 + JetScalePileup1: 1.06301458e-01 + JetScalePileup2: 2.27156334e-01 + JetScalePileup3: 3.51140997e-01 + JetScalePileup4: 1.45515463e+00 + JetScaleFlav1Known: 4.60217340e-01 + JetScaleFlav2: 2.55524461e+00 + JetScaleBjet: 4.35889894e-03 + JetScalepunchT: 1.08972474e-02 + JetResolution10: 1.88 + JetSFBeff: 1.19134378e+00 + JetSFCeff: 3.30302891e-01 + JetSFLmistag: 1.92093727e-01 + JetSFHighPt: 1.03440804e-02 + JetJVFcut: 7.93536389e-01 + ElScaleR12: 3.30302891e-01 + ElScaleZee: 4.35057467e-01 + ElScalePS: 7.39932429e-02 + ElResolution: -0.06 + ElSFReco: 4.60868745e-01 + ElSFId: 1.14502183e+00 + ElSFTrigger: 5.70175412e-01 + ElSFIso: 2.27760839e-01 + ElSFChargeMisID: 3.84057287e-03 + METScale: 1.38516245e+00 + METResLong: -1.1 + METResTrans: -1.27 + PileupWeight: 2.56320112e-01 + QCDlowRange: 1.65831240e-01 + QCDhighRange: 1.72356462e-02 + QCDvarIso: -0.48 + QCDvarElID: -0.4 + QCDfitUncert: 0.09 + QCDotherGen: 0.37 + QCDfitRebin: -0.001 + XsecZ: 0.03 + XsecTop: 0.61 + XsecDibos: 0.09 + BkgTtbarNorm: -0.61 + BkgMCstat: -0.18 + WHFmodel: -0.12 + LumiUncert: 1.94082457e+00 + UnfoldMCstat: -0.5 + UnfoldOtherGen: 1.27 + UnfoldReweight: -0.18 +- art_stat_corr_1: 3.75871593e-04 + art_stat_corr_2: -3.20861405e-03 + art_stat_corr_3: 1.36881329e-02 + art_stat_corr_4: -6.42900097e-03 + art_stat_corr_5: -9.64216467e-02 + art_stat_corr_6: 1.73787161e-01 + art_stat_corr_7: 1.79240069e-01 + art_stat_corr_8: -5.42230132e-02 + art_stat_corr_9: -5.77522116e-02 + art_stat_corr_10: -1.60294707e-02 + art_stat_corr_11: -1.52140187e-03 + art_stat_corr_12: -2.01912941e-04 + art_stat_corr_13: 1.98585590e-05 + art_stat_corr_14: -3.81103937e-06 + art_stat_corr_15: -8.09080495e-08 + art_stat_corr_16: -5.87265834e-09 + JetScaleEff1: 1.37719824e+00 + JetScaleEff2: 5.70175412e-01 + JetScaleEff3: 3.61109402e-01 + JetScaleEff4: 1.66358048e-01 + JetScaleEff5: 1.68745370e-01 + JetScaleEff6: 1.56444878e-01 + JetScaleEta1: 5.20768663e-01 + JetScaleEta2: 3.45651559e-01 + JetScaleHighPt: 1.41421356e-02 + JetScaleMC: 1.41421356e-02 + JetScalePileup1: 5.74456265e-02 + JetScalePileup2: 1.20312094e-01 + JetScalePileup3: 1.90525589e-01 + JetScalePileup4: 7.06735453e-01 + JetScaleFlav1Known: 2.45102020e-01 + JetScaleFlav2: 1.39516128e+00 + JetScaleBjet: 2.17944947e-03 + JetScalepunchT: 4.35889894e-03 + JetResolution10: 0.84 + JetSFBeff: 7.00571196e-01 + JetSFCeff: 1.75142799e-01 + JetSFLmistag: 1.00995049e-01 + JetSFHighPt: 4.35889894e-03 + JetJVFcut: 5.65685425e-01 + ElScaleR12: 1.75142799e-01 + ElScaleZee: 0.23 + ElScalePS: 4.12310563e-02 + ElResolution: -0.03 + ElSFReco: 2.40416306e-01 + ElSFId: 6.35983490e-01 + ElSFTrigger: 3.05081956e-01 + ElSFIso: 1.26787223e-01 + ElSFChargeMisID: 2.17944947e-03 + METScale: 6.65338260e-01 + METResLong: -0.6 + METResTrans: -0.56 + PileupWeight: 1.33041347e-01 + QCDlowRange: 9.05538514e-02 + QCDhighRange: 8.55102333e-03 + QCDvarIso: -0.32 + QCDvarElID: -0.21 + QCDfitUncert: 0.05 + QCDotherGen: 0.2 + QCDfitRebin: -0.001 + XsecZ: 0.02 + XsecTop: 0.36 + XsecDibos: 0.05 + BkgTtbarNorm: -0.36 + BkgMCstat: -0.13 + WHFmodel: -0.1 + LumiUncert: 1.05038088e+00 + UnfoldMCstat: -0.35 + UnfoldOtherGen: 1.9 + UnfoldReweight: -0.09 +- art_stat_corr_1: -1.15823766e-04 + art_stat_corr_2: 9.61743009e-06 + art_stat_corr_3: 1.49186962e-03 + art_stat_corr_4: -5.55761400e-03 + art_stat_corr_5: 5.41136242e-03 + art_stat_corr_6: 1.79012724e-02 + art_stat_corr_7: 6.71839688e-02 + art_stat_corr_8: -1.13299615e-01 + art_stat_corr_9: 8.47437971e-02 + art_stat_corr_10: 2.58189537e-02 + art_stat_corr_11: 4.27373877e-03 + art_stat_corr_12: 4.96793344e-04 + art_stat_corr_13: -7.49313253e-05 + art_stat_corr_14: 1.31292233e-05 + art_stat_corr_15: 8.33076672e-07 + art_stat_corr_16: 1.15935478e-08 + JetScaleEff1: 6.11473630e-01 + JetScaleEff2: 2.95084734e-01 + JetScaleEff3: 1.86212244e-01 + JetScaleEff4: 7.53325959e-02 + JetScaleEff5: 7.34846923e-02 + JetScaleEff6: 6.53834842e-02 + JetScaleEta1: 2.10475652e-01 + JetScaleEta2: 1.55161206e-01 + JetScaleHighPt: 4.24264069e-03 + JetScaleMC: 5.65685425e-03 + JetScalePileup1: 2.44948974e-02 + JetScalePileup2: 5.19615242e-02 + JetScalePileup3: 8.52936105e-02 + JetScalePileup4: 2.75090894e-01 + JetScaleFlav1Known: 1.05237826e-01 + JetScaleFlav2: 5.80689246e-01 + JetScaleBjet: 1.03440804e-03 + JetScalepunchT: 2.17944947e-03 + JetResolution10: 0.31 + JetSFBeff: 3.30302891e-01 + JetSFCeff: 0.08 + JetSFLmistag: 4.55521679e-02 + JetSFHighPt: 2.17944947e-03 + JetJVFcut: 2.47537876e-01 + ElScaleR12: 7.53325959e-02 + ElScaleZee: 0.1 + ElScalePS: 1.65831240e-02 + ElResolution: -0.01 + ElSFReco: 1.05237826e-01 + ElSFId: 2.75090894e-01 + ElSFTrigger: 1.35185058e-01 + ElSFIso: 5.54526825e-02 + ElSFChargeMisID: 9.83615779e-04 + METScale: 2.41660919e-01 + METResLong: -0.25 + METResTrans: -0.27 + PileupWeight: 6.16441400e-02 + QCDlowRange: 3.31662479e-02 + QCDhighRange: 3.84057287e-03 + QCDvarIso: -0.14 + QCDvarElID: -0.09 + QCDfitUncert: 0.02 + QCDotherGen: 0.08 + QCDfitRebin: -0.0004 + XsecZ: 0.01 + XsecTop: 0.17 + XsecDibos: 0.02 + BkgTtbarNorm: -0.17 + BkgMCstat: -0.08 + WHFmodel: 0.03 + LumiUncert: 4.65053760e-01 + UnfoldMCstat: -0.18 + UnfoldOtherGen: 0.42 + UnfoldReweight: -0.04 +- art_stat_corr_1: -1.64259374e-05 + art_stat_corr_2: 5.30191066e-05 + art_stat_corr_3: -1.22891895e-04 + art_stat_corr_4: -4.47167708e-04 + art_stat_corr_5: 3.59497250e-03 + art_stat_corr_6: -4.86566002e-03 + art_stat_corr_7: -3.53576266e-03 + art_stat_corr_8: -9.63651530e-03 + art_stat_corr_9: 4.40652171e-02 + art_stat_corr_10: -8.35920896e-02 + art_stat_corr_11: -1.16564604e-02 + art_stat_corr_12: -2.90926590e-03 + art_stat_corr_13: 3.08941919e-04 + art_stat_corr_14: -7.87349615e-05 + art_stat_corr_15: -2.02333728e-06 + art_stat_corr_16: 1.84260407e-08 + JetScaleEff1: 2.17115177e-01 + JetScaleEff2: 1.33651599e-01 + JetScaleEff3: 6.53834842e-02 + JetScaleEff4: 2.57439313e-02 + JetScaleEff5: 2.55880832e-02 + JetScaleEff6: 2.43721152e-02 + JetScaleEta1: 7.56620777e-02 + JetScaleEta2: 5.50726793e-02 + JetScaleHighPt: 1.41421356e-03 + JetScaleMC: 2.17944947e-03 + JetScalePileup1: 8.98610038e-03 + JetScalePileup2: 1.91507180e-02 + JetScalePileup3: 2.95761728e-02 + JetScalePileup4: 9.75230742e-02 + JetScaleFlav1Known: 3.85583973e-02 + JetScaleFlav2: 1.86263255e-01 + JetScaleBjet: 0.0003 + JetScalepunchT: 1.03440804e-03 + JetResolution10: 0.109 + JetSFBeff: 1.25947410e-01 + JetSFCeff: 2.80356915e-02 + JetSFLmistag: 1.56444878e-02 + JetSFHighPt: 9.83615779e-04 + JetJVFcut: 8.98039531e-02 + ElScaleR12: 2.80356915e-02 + ElScaleZee: 3.65068487e-02 + ElScalePS: 6.55743852e-03 + ElResolution: -0.005 + ElSFReco: 3.85583973e-02 + ElSFId: 9.95627943e-02 + ElSFTrigger: 4.80208288e-02 + ElSFIso: 1.92093727e-02 + ElSFChargeMisID: 3.84057287e-04 + METScale: 8.49985294e-02 + METResLong: -0.088 + METResTrans: -0.097 + PileupWeight: 2.14242853e-02 + QCDlowRange: 1.25199840e-02 + QCDhighRange: 1.41421356e-03 + QCDvarIso: -0.05 + QCDvarElID: -0.034 + QCDfitUncert: 0.012 + QCDotherGen: 0.027 + QCDfitRebin: 0.0002 + XsecZ: 0.002 + XsecTop: 6.45038759e-02 + XsecDibos: 0.009 + BkgTtbarNorm: -0.065 + BkgMCstat: -0.044 + WHFmodel: -0.013 + LumiUncert: 1.67053884e-01 + UnfoldMCstat: -0.104 + UnfoldOtherGen: 0.148 + UnfoldReweight: -0.015 +- art_stat_corr_1: -9.10833581e-08 + art_stat_corr_2: 3.66780920e-06 + art_stat_corr_3: -2.36072639e-05 + art_stat_corr_4: 2.77759008e-05 + art_stat_corr_5: 2.50248861e-04 + art_stat_corr_6: -7.47380507e-04 + art_stat_corr_7: -1.95852724e-03 + art_stat_corr_8: 3.12571045e-03 + art_stat_corr_9: 7.09573009e-04 + art_stat_corr_10: -2.06271036e-02 + art_stat_corr_11: 5.54268355e-02 + art_stat_corr_12: 9.12828927e-03 + art_stat_corr_13: -2.03986936e-03 + art_stat_corr_14: 4.11199947e-04 + art_stat_corr_15: 2.74249178e-05 + art_stat_corr_16: 3.21801522e-07 + JetScaleEff1: 8.45739322e-02 + JetScaleEff2: 5.45412688e-02 + JetScaleEff3: 2.71477439e-02 + JetScaleEff4: 1.10905365e-02 + JetScaleEff5: 1.08972474e-02 + JetScaleEff6: 1.00995049e-02 + JetScaleEta1: 3.10322413e-02 + JetScaleEta2: 2.25111084e-02 + JetScaleHighPt: 5.65685425e-04 + JetScaleMC: 1.41421356e-03 + JetScalePileup1: 4.09267639e-03 + JetScalePileup2: 7.79422863e-03 + JetScalePileup3: 1.20830460e-02 + JetScalePileup4: 4.00249922e-02 + JetScaleFlav1Known: 1.55161206e-02 + JetScaleFlav2: 7.35034013e-02 + JetScaleBjet: 1.41421356e-04 + JetScalepunchT: 2.82842712e-04 + JetResolution10: 0.045 + JetSFBeff: 5.16212166e-02 + JetSFCeff: 1.15217186e-02 + JetSFLmistag: 6.53834842e-03 + JetSFHighPt: 0.0003 + JetJVFcut: 3.67695526e-02 + ElScaleR12: 1.15217186e-02 + ElScaleZee: 0.015 + ElScalePS: 2.44948974e-03 + ElResolution: -0.002 + ElSFReco: 1.55161206e-02 + ElSFId: 4.10243830e-02 + ElSFTrigger: 1.95128163e-02 + ElSFIso: 8.12403840e-03 + ElSFChargeMisID: 1.92028644e-04 + METScale: 3.46806863e-02 + METResLong: -0.036 + METResTrans: -0.04 + PileupWeight: 8.76070773e-03 + QCDlowRange: 5.74456265e-03 + QCDhighRange: 8.98610038e-04 + QCDvarIso: -0.02 + QCDvarElID: -0.014 + QCDfitUncert: 0.004 + QCDotherGen: 0.013 + QCDfitRebin: 3.0e-05 + XsecZ: 0.0004 + XsecTop: 0.025 + XsecDibos: 0.004 + BkgTtbarNorm: -0.025 + BkgMCstat: -0.026 + WHFmodel: -0.016 + LumiUncert: 6.85328388e-02 + UnfoldMCstat: -0.067 + UnfoldOtherGen: 0.061 + UnfoldReweight: -0.006 +- art_stat_corr_1: 4.55293903e-07 + art_stat_corr_2: -6.74227151e-08 + art_stat_corr_3: -1.14669827e-06 + art_stat_corr_4: 7.02717033e-06 + art_stat_corr_5: -1.86614319e-05 + art_stat_corr_6: -2.89755126e-06 + art_stat_corr_7: -1.29677153e-04 + art_stat_corr_8: 6.14199893e-04 + art_stat_corr_9: -1.65254776e-03 + art_stat_corr_10: 1.68819982e-03 + art_stat_corr_11: 1.51524880e-02 + art_stat_corr_12: -3.64424058e-02 + art_stat_corr_13: 5.67496135e-03 + art_stat_corr_14: -2.04024922e-03 + art_stat_corr_15: -9.98404739e-05 + art_stat_corr_16: 2.43543426e-07 + JetScaleEff1: 4.34827552e-02 + JetScaleEff2: 4.04227659e-02 + JetScaleEff3: 1.20830460e-02 + JetScaleEff4: 4.55521679e-03 + JetScaleEff5: 4.35889894e-03 + JetScaleEff6: 4.55521679e-03 + JetScaleEta1: 1.35185058e-02 + JetScaleEta2: 0.01 + JetScaleHighPt: 2.82842712e-04 + JetScaleMC: 3.57071421e-04 + JetScalePileup1: 1.65831240e-03 + JetScalePileup2: 3.57071421e-03 + JetScalePileup3: 5.54526825e-03 + JetScalePileup4: 1.75142799e-02 + JetScaleFlav1Known: 0.007 + JetScaleFlav2: 3.25076914e-02 + JetScaleBjet: 9.83615779e-05 + JetScalepunchT: 1.41421356e-04 + JetResolution10: 0.02 + JetSFBeff: 2.25997788e-02 + JetSFCeff: 0.005 + JetSFLmistag: 0.003 + JetSFHighPt: 1.41421356e-04 + JetJVFcut: 1.62711401e-02 + ElScaleR12: 0.005 + ElScaleZee: 0.007 + ElScalePS: 8.17006732e-04 + ElResolution: -0.001 + ElSFReco: 0.007 + ElSFId: 0.018 + ElSFTrigger: 0.009 + ElSFIso: 3.57071421e-03 + ElSFChargeMisID: 9.38083152e-05 + METScale: 1.56444878e-02 + METResLong: -0.016 + METResTrans: -0.018 + PileupWeight: 3.57071421e-03 + QCDlowRange: 1.65831240e-03 + QCDhighRange: 2.17944947e-04 + QCDvarIso: -0.009 + QCDvarElID: -0.006 + QCDfitUncert: 0.001 + QCDotherGen: 0.004 + QCDfitRebin: 0.0001 + XsecZ: 0.001 + XsecTop: 0.011 + XsecDibos: 0.002 + BkgTtbarNorm: -0.01 + BkgMCstat: -0.018 + WHFmodel: -0.009 + LumiUncert: 3.05081956e-02 + UnfoldMCstat: -0.041 + UnfoldOtherGen: 0.027 + UnfoldReweight: -0.003 +- art_stat_corr_1: 4.02428595e-07 + art_stat_corr_2: -1.99421271e-07 + art_stat_corr_3: -6.24662632e-07 + art_stat_corr_4: -9.04429588e-08 + art_stat_corr_5: -3.77498647e-06 + art_stat_corr_6: 4.95499691e-06 + art_stat_corr_7: 6.29728436e-06 + art_stat_corr_8: 2.28523936e-05 + art_stat_corr_9: -2.38185848e-04 + art_stat_corr_10: 1.00608655e-03 + art_stat_corr_11: -9.80242363e-04 + art_stat_corr_12: -1.04716101e-02 + art_stat_corr_13: -2.20994929e-02 + art_stat_corr_14: 6.68102496e-03 + art_stat_corr_15: 6.71749196e-04 + art_stat_corr_16: 5.98617549e-06 + JetScaleEff1: 2.05773541e-02 + JetScaleEff2: 2.64894319e-02 + JetScaleEff3: 5.62849891e-03 + JetScaleEff4: 2.21810730e-03 + JetScaleEff5: 2.25997788e-03 + JetScaleEff6: 2.08026441e-03 + JetScaleEta1: 6.45968265e-03 + JetScaleEta2: 4.70850295e-03 + JetScaleHighPt: 1.41421356e-04 + JetScaleMC: 1.41421356e-04 + JetScalePileup1: 8.17006732e-04 + JetScalePileup2: 1.65529454e-03 + JetScalePileup3: 2.55880832e-03 + JetScalePileup4: 8.35269418e-03 + JetScaleFlav1Known: 3.30302891e-03 + JetScaleFlav2: 1.53501629e-02 + JetScaleBjet: 3.0e-05 + JetScalepunchT: 9.83615779e-05 + JetResolution10: 0.0093 + JetSFBeff: 1.08332821e-02 + JetSFCeff: 2.40416306e-03 + JetSFLmistag: 1.36656504e-03 + JetSFHighPt: 9.83615779e-05 + JetJVFcut: 7.63675324e-03 + ElScaleR12: 2.40416306e-03 + ElScaleZee: 0.0031 + ElScalePS: 5.72276157e-04 + ElResolution: -0.0004 + ElSFReco: 3.25691572e-03 + ElSFId: 8.50470458e-03 + ElSFTrigger: 4.10243830e-03 + ElSFIso: 1.62480768e-03 + ElSFChargeMisID: 3.0e-05 + METScale: 7.29160476e-03 + METResLong: -0.0075 + METResTrans: -0.0083 + PileupWeight: 1.84932420e-03 + QCDlowRange: 9.20597632e-04 + QCDhighRange: 8.18535277e-05 + QCDvarIso: -0.0043 + QCDvarElID: -0.0029 + QCDfitUncert: 0.0004 + QCDotherGen: 0.0021 + QCDfitRebin: -2.0e-05 + XsecZ: 0.0002 + XsecTop: 0.0046 + XsecDibos: 0.0008 + BkgTtbarNorm: -0.0046 + BkgMCstat: -0.0095 + WHFmodel: -0.006 + LumiUncert: 1.39064733e-02 + UnfoldMCstat: -0.0291 + UnfoldOtherGen: 0.0127 + UnfoldReweight: -0.0013 +- art_stat_corr_1: 6.11404828e-07 + art_stat_corr_2: -6.54294374e-09 + art_stat_corr_3: -1.98994997e-07 + art_stat_corr_4: -8.46087664e-07 + art_stat_corr_5: 2.07066481e-06 + art_stat_corr_6: -1.35106980e-06 + art_stat_corr_7: 3.57099140e-06 + art_stat_corr_8: -1.14748810e-05 + art_stat_corr_9: 1.02084162e-06 + art_stat_corr_10: 1.17391533e-04 + art_stat_corr_11: -8.90101054e-04 + art_stat_corr_12: 4.87044722e-04 + art_stat_corr_13: -1.05416240e-02 + art_stat_corr_14: -1.52379058e-02 + art_stat_corr_15: -1.26357048e-03 + art_stat_corr_16: 1.88140770e-05 + JetScaleEff1: 1.10344914e-02 + JetScaleEff2: 1.42049287e-02 + JetScaleEff3: 3.01330383e-03 + JetScaleEff4: 1.20830460e-03 + JetScaleEff5: 1.17046999e-03 + JetScaleEff6: 1.10905365e-03 + JetScaleEta1: 3.45651559e-03 + JetScaleEta2: 2.50399681e-03 + JetScaleHighPt: 7.07106781e-05 + JetScaleMC: 1.41421356e-04 + JetScalePileup1: 4.09267639e-04 + JetScalePileup2: 8.76070773e-04 + JetScalePileup3: 1.35185058e-03 + JetScalePileup4: 4.45056176e-03 + JetScaleFlav1Known: 1.75142799e-03 + JetScaleFlav2: 8.25030302e-03 + JetScaleBjet: 2.17944947e-05 + JetScalepunchT: 3.57071421e-05 + JetResolution10: 0.005 + JetSFBeff: 5.77126503e-03 + JetSFCeff: 1.25199840e-03 + JetSFLmistag: 7.14142843e-04 + JetSFHighPt: 3.0e-05 + JetJVFcut: 4.10121933e-03 + ElScaleR12: 1.25199840e-03 + ElScaleZee: 0.0017 + ElScalePS: 3.27871926e-04 + ElResolution: -0.0002 + ElSFReco: 1.75142799e-03 + ElSFId: 4.55494237e-03 + ElSFTrigger: 0.0022 + ElSFIso: 9.11043358e-04 + ElSFChargeMisID: 2.17944947e-05 + METScale: 3.92300905e-03 + METResLong: -0.004 + METResTrans: -0.0044 + PileupWeight: 9.73396117e-04 + QCDlowRange: 5.54526825e-04 + QCDhighRange: 8.17006732e-05 + QCDvarIso: -0.0023 + QCDvarElID: -0.0015 + QCDfitUncert: 0.0003 + QCDotherGen: 0.0016 + QCDfitRebin: 2.0e-05 + XsecZ: 0.0001 + XsecTop: 0.002 + XsecDibos: 0.0005 + BkgTtbarNorm: -0.0022 + BkgMCstat: -0.0075 + WHFmodel: 0.007 + LumiUncert: 7.35306059e-03 + UnfoldMCstat: -0.021 + UnfoldOtherGen: 0.0068 + UnfoldReweight: -0.0007 +- art_stat_corr_1: -1.24133611e-07 + art_stat_corr_2: -2.56738193e-08 + art_stat_corr_3: 9.98836299e-07 + art_stat_corr_4: 1.04245533e-06 + art_stat_corr_5: 4.48582443e-07 + art_stat_corr_6: 8.14446806e-08 + art_stat_corr_7: -8.24903661e-07 + art_stat_corr_8: 1.40618586e-06 + art_stat_corr_9: -1.10112643e-06 + art_stat_corr_10: 1.49916195e-06 + art_stat_corr_11: -5.17372592e-05 + art_stat_corr_12: 3.88012999e-04 + art_stat_corr_13: 2.22455730e-04 + art_stat_corr_14: -2.47490450e-03 + art_stat_corr_15: 9.67841677e-03 + art_stat_corr_16: 1.92536921e-05 + JetScaleEff1: 4.02585395e-03 + JetScaleEff2: 5.23139561e-03 + JetScaleEff3: 1.10905365e-03 + JetScaleEff4: 4.55521679e-04 + JetScaleEff5: 4.35889894e-04 + JetScaleEff6: 0.0004 + JetScaleEta1: 1.25199840e-03 + JetScaleEta2: 9.52627944e-04 + JetScaleHighPt: 2.82842712e-05 + JetScaleMC: 3.57071421e-05 + JetScalePileup1: 1.65831240e-04 + JetScalePileup2: 3.31662479e-04 + JetScalePileup3: 0.0005 + JetScalePileup4: 1.65151446e-03 + JetScaleFlav1Known: 6.53834842e-04 + JetScaleFlav2: 0.003 + JetScaleBjet: 9.83615779e-06 + JetScalepunchT: 1.41421356e-05 + JetResolution10: 0.0018 + JetSFBeff: 2.10475652e-03 + JetSFCeff: 0.0005 + JetSFLmistag: 2.59807621e-04 + JetSFHighPt: 1.08972474e-05 + JetJVFcut: 1.55563492e-03 + ElScaleR12: 4.55521679e-04 + ElScaleZee: 0.0006 + ElScalePS: 8.17006732e-05 + ElResolution: -0.0001 + ElSFReco: 6.53834842e-04 + ElSFId: 1.65151446e-03 + ElSFTrigger: 0.0008 + ElSFIso: 3.57071421e-04 + ElSFChargeMisID: 9.38083152e-06 + METScale: 1.40712473e-03 + METResLong: -0.0015 + METResTrans: -0.0016 + PileupWeight: 3.57071421e-04 + QCDlowRange: 8.98610038e-05 + QCDhighRange: 1.0e-05 + QCDvarIso: -0.0008 + QCDvarElID: -0.0006 + QCDfitUncert: 5.0e-08 + QCDotherGen: 0.0001 + QCDfitRebin: 2.0e-06 + XsecZ: 0.0002 + XsecTop: 0.0009 + XsecDibos: 0.0002 + BkgTtbarNorm: -0.0009 + BkgMCstat: -0.0032 + WHFmodel: 0.0014 + LumiUncert: 2.85087706e-03 + UnfoldMCstat: -0.0092 + UnfoldOtherGen: 0.0025 + UnfoldReweight: -0.0002 +- art_stat_corr_1: 1.34403646e-07 + art_stat_corr_2: -9.06366037e-09 + art_stat_corr_3: -1.07586258e-07 + art_stat_corr_4: -1.90742983e-07 + art_stat_corr_5: 2.05713198e-07 + art_stat_corr_6: -1.67383386e-07 + art_stat_corr_7: -4.76132843e-08 + art_stat_corr_8: -4.08991071e-07 + art_stat_corr_9: -3.41385914e-07 + art_stat_corr_10: -2.93638732e-07 + art_stat_corr_11: 6.46750494e-07 + art_stat_corr_12: 1.50943179e-05 + art_stat_corr_13: 9.44540258e-05 + art_stat_corr_14: 8.54907729e-05 + art_stat_corr_15: -4.83216534e-05 + art_stat_corr_16: 3.44727516e-03 + JetScaleEff1: 9.34705836e-04 + JetScaleEff2: 1.20261174e-03 + JetScaleEff3: 2.55880832e-04 + JetScaleEff4: 1.00995049e-04 + JetScaleEff5: 1.03440804e-04 + JetScaleEff6: 9.11043358e-05 + JetScaleEta1: 2.95761728e-04 + JetScaleEta2: 2.15116248e-04 + JetScaleHighPt: 5.65685425e-06 + JetScaleMC: 1.08972474e-05 + JetScalePileup1: 3.31662479e-05 + JetScalePileup2: 7.14142843e-05 + JetScalePileup3: 1.15217186e-04 + JetScalePileup4: 3.80263067e-04 + JetScaleFlav1Known: 0.00015 + JetScaleFlav2: 0.0007 + JetScaleBjet: 1.41421356e-06 + JetScalepunchT: 2.17944947e-06 + JetResolution10: 0.00043 + JetSFBeff: 4.91833305e-04 + JetSFCeff: 0.00011 + JetSFLmistag: 6.16441400e-05 + JetSFHighPt: 3.0e-06 + JetJVFcut: 3.46518398e-04 + ElScaleR12: 1.05237826e-04 + ElScaleZee: 0.00014 + ElScalePS: 2.44948974e-05 + ElResolution: -2.0e-05 + ElSFReco: 1.50665192e-04 + ElSFId: 3.90256326e-04 + ElSFTrigger: 1.85135086e-04 + ElSFIso: 7.53325959e-05 + ElSFChargeMisID: 1.03440804e-06 + METScale: 3.32716095e-04 + METResLong: -0.00034 + METResTrans: -0.00038 + PileupWeight: 8.12403840e-05 + QCDlowRange: 1.0e-05 + QCDhighRange: 8.24621125e-07 + QCDvarIso: -0.00019 + QCDvarElID: -0.00013 + QCDfitUncert: -3.0e-06 + QCDotherGen: -2.0e-05 + QCDfitRebin: -1.0e-08 + XsecZ: 6.0e-05 + XsecTop: 0.00014 + XsecDibos: 8.0e-05 + BkgTtbarNorm: -0.00013 + BkgMCstat: -0.00099 + WHFmodel: -0.00075 + LumiUncert: 6.50153828e-04 + UnfoldMCstat: -0.00404 + UnfoldOtherGen: 0.00058 + UnfoldReweight: -6.0e-05 diff --git a/nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/uncertainties_WP-PT.yaml b/nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/uncertainties_WP-PT.yaml new file mode 100644 index 0000000000..55e09c6819 --- /dev/null +++ b/nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/uncertainties_WP-PT.yaml @@ -0,0 +1,1402 @@ +definitions: + art_stat_corr_1: + description: Artificial statistical uncertainty 1 + treatment: ADD + type: CORR + art_stat_corr_2: + description: Artificial statistical uncertainty 2 + treatment: ADD + type: CORR + art_stat_corr_3: + description: Artificial statistical uncertainty 3 + treatment: ADD + type: CORR + art_stat_corr_4: + description: Artificial statistical uncertainty 4 + treatment: ADD + type: CORR + art_stat_corr_5: + description: Artificial statistical uncertainty 5 + treatment: ADD + type: CORR + art_stat_corr_6: + description: Artificial statistical uncertainty 6 + treatment: ADD + type: CORR + art_stat_corr_7: + description: Artificial statistical uncertainty 7 + treatment: ADD + type: CORR + art_stat_corr_8: + description: Artificial statistical uncertainty 8 + treatment: ADD + type: CORR + art_stat_corr_9: + description: Artificial statistical uncertainty 9 + treatment: ADD + type: CORR + art_stat_corr_10: + description: Artificial statistical uncertainty 10 + treatment: ADD + type: CORR + art_stat_corr_11: + description: Artificial statistical uncertainty 11 + treatment: ADD + type: CORR + art_stat_corr_12: + description: Artificial statistical uncertainty 12 + treatment: ADD + type: CORR + art_stat_corr_13: + description: Artificial statistical uncertainty 13 + treatment: ADD + type: CORR + art_stat_corr_14: + description: Artificial statistical uncertainty 14 + treatment: ADD + type: CORR + art_stat_corr_15: + description: Artificial statistical uncertainty 15 + treatment: ADD + type: CORR + art_stat_corr_16: + description: Artificial statistical uncertainty 16 + treatment: ADD + type: CORR + JetScaleEff1: + description: 'Systematic: JetScaleEff1' + treatment: MULT + type: ATLASWJ1 + JetScaleEff2: + description: 'Systematic: JetScaleEff2' + treatment: MULT + type: ATLASWJ2 + JetScaleEff3: + description: 'Systematic: JetScaleEff3' + treatment: MULT + type: ATLASWJ3 + JetScaleEff4: + description: 'Systematic: JetScaleEff4' + treatment: MULT + type: ATLASWJ4 + JetScaleEff5: + description: 'Systematic: JetScaleEff5' + treatment: MULT + type: ATLASWJ5 + JetScaleEff6: + description: 'Systematic: JetScaleEff6' + treatment: MULT + type: ATLASWJ6 + JetScaleEta1: + description: 'Systematic: JetScaleEta1' + treatment: MULT + type: ATLASWJ7 + JetScaleEta2: + description: 'Systematic: JetScaleEta2' + treatment: MULT + type: ATLASWJ8 + JetScaleHighPt: + description: 'Systematic: JetScaleHighPt' + treatment: MULT + type: ATLASWJ9 + JetScaleMC: + description: 'Systematic: JetScaleMC' + treatment: MULT + type: ATLASWJ10 + JetScalePileup1: + description: 'Systematic: JetScalePileup1' + treatment: MULT + type: ATLASWJ11 + JetScalePileup2: + description: 'Systematic: JetScalePileup2' + treatment: MULT + type: ATLASWJ12 + JetScalePileup3: + description: 'Systematic: JetScalePileup3' + treatment: MULT + type: ATLASWJ13 + JetScalePileup4: + description: 'Systematic: JetScalePileup4' + treatment: MULT + type: ATLASWJ14 + JetScaleFlav1Known: + description: 'Systematic: JetScaleFlav1Known' + treatment: MULT + type: ATLASWJ15 + JetScaleFlav2: + description: 'Systematic: JetScaleFlav2' + treatment: MULT + type: ATLASWJ16 + JetScaleBjet: + description: 'Systematic: JetScaleBjet' + treatment: MULT + type: ATLASWJ17 + JetScalepunchT: + description: 'Systematic: JetScalepunchT' + treatment: MULT + type: ATLASWJ18 + JetResolution10: + description: 'Systematic: JetResolution10' + treatment: MULT + type: ATLASWJ19 + JetSFBeff: + description: 'Systematic: JetSFBeff' + treatment: MULT + type: ATLASWJ20 + JetSFCeff: + description: 'Systematic: JetSFCeff' + treatment: MULT + type: ATLASWJ21 + JetSFLmistag: + description: 'Systematic: JetSFLmistag' + treatment: MULT + type: ATLASWJ22 + JetSFHighPt: + description: 'Systematic: JetSFHighPt' + treatment: MULT + type: ATLASWJ23 + JetJVFcut: + description: 'Systematic: JetJVFcut' + treatment: MULT + type: ATLASWJ24 + ElScaleR12: + description: 'Systematic: ElScaleR12' + treatment: MULT + type: ATLASWJ25 + ElScaleZee: + description: 'Systematic: ElScaleZee' + treatment: MULT + type: ATLASWJ26 + ElScalePS: + description: 'Systematic: ElScalePS' + treatment: MULT + type: ATLASWJ27 + ElResolution: + description: 'Systematic: ElResolution' + treatment: MULT + type: ATLASWJ28 + ElSFReco: + description: 'Systematic: ElSFReco' + treatment: MULT + type: ATLASWJ29 + ElSFId: + description: 'Systematic: ElSFId' + treatment: MULT + type: ATLASWJ30 + ElSFTrigger: + description: 'Systematic: ElSFTrigger' + treatment: MULT + type: ATLASWJ31 + ElSFIso: + description: 'Systematic: ElSFIso' + treatment: MULT + type: ATLASWJ32 + ElSFChargeMisID: + description: 'Systematic: ElSFChargeMisID' + treatment: MULT + type: ATLASWJ33 + METScale: + description: 'Systematic: METScale' + treatment: MULT + type: ATLASWJ34 + METResLong: + description: 'Systematic: METResLong' + treatment: MULT + type: ATLASWJ35 + METResTrans: + description: 'Systematic: METResTrans' + treatment: MULT + type: ATLASWJ36 + PileupWeight: + description: 'Systematic: PileupWeight' + treatment: MULT + type: ATLASWJ37 + QCDlowRange: + description: 'Systematic: QCDlowRange' + treatment: MULT + type: ATLASWJ38 + QCDhighRange: + description: 'Systematic: QCDhighRange' + treatment: MULT + type: ATLASWJ39 + QCDvarIso: + description: 'Systematic: QCDvarIso' + treatment: MULT + type: ATLASWJ40 + QCDvarElID: + description: 'Systematic: QCDvarElID' + treatment: MULT + type: ATLASWJ41 + QCDfitUncert: + description: 'Systematic: QCDfitUncert' + treatment: MULT + type: ATLASWJ42 + QCDotherGen: + description: 'Systematic: QCDotherGen' + treatment: MULT + type: ATLASWJ43 + QCDfitRebin: + description: 'Systematic: QCDfitRebin' + treatment: MULT + type: ATLASWJ44 + XsecZ: + description: 'Systematic: XsecZ' + treatment: MULT + type: ATLASWJ45 + XsecTop: + description: 'Systematic: XsecTop' + treatment: MULT + type: ATLASWJ46 + XsecDibos: + description: 'Systematic: XsecDibos' + treatment: MULT + type: ATLASWJ47 + BkgTtbarNorm: + description: 'Systematic: BkgTtbarNorm' + treatment: MULT + type: ATLASWJ48 + BkgMCstat: + description: 'Systematic: BkgMCstat' + treatment: MULT + type: ATLASWJ49 + WHFmodel: + description: 'Systematic: WHFmodel' + treatment: MULT + type: ATLASWJ50 + LumiUncert: + description: 'Systematic: LumiUncert' + treatment: MULT + type: ATLASLUMI12 + UnfoldMCstat: + description: 'Systematic: UnfoldMCstat' + treatment: MULT + type: UNCORR + UnfoldOtherGen: + description: 'Systematic: UnfoldOtherGen' + treatment: MULT + type: UNCORR + UnfoldReweight: + description: 'Systematic: UnfoldReweight' + treatment: MULT + type: UNCORR +bins: +- art_stat_corr_1: -1.98542171e+00 + art_stat_corr_2: 9.56548751e-02 + art_stat_corr_3: 1.88862080e-01 + art_stat_corr_4: 9.28404853e-02 + art_stat_corr_5: 5.61228648e-02 + art_stat_corr_6: 3.85627331e-02 + art_stat_corr_7: 5.00592572e-03 + art_stat_corr_8: -7.85567390e-04 + art_stat_corr_9: -1.33589803e-04 + art_stat_corr_10: -1.79785626e-05 + art_stat_corr_11: -1.05988974e-06 + art_stat_corr_12: -1.19526188e-07 + art_stat_corr_13: 4.35508103e-08 + art_stat_corr_14: -1.05397397e-08 + art_stat_corr_15: -1.19261727e-09 + art_stat_corr_16: 2.06555333e-10 + JetScaleEff1: 1.25501992e+02 + JetScaleEff2: 3.15079355e+01 + JetScaleEff3: 4.55521679e+00 + JetScaleEff4: 4.35889894e-01 + JetScaleEff5: 5.19615242e+00 + JetScaleEff6: 7.53325959e+00 + JetScaleEta1: 6.55343421e+01 + JetScaleEta2: 3.20312348e+01 + JetScaleHighPt: 2.82842712e-01 + JetScaleMC: 4.24264069e-01 + JetScalePileup1: 4.09267639e+00 + JetScalePileup2: 1.52643375e+01 + JetScalePileup3: 3.0 + JetScalePileup4: 8.35029940e+01 + JetScaleFlav1Known: 2.55098020e+01 + JetScaleFlav2: 1.01502463e+02 + JetScaleBjet: 3.57071421e-01 + JetScalepunchT: 3.57071421e-01 + JetResolution10: 214 + JetSFBeff: 6.53834842e+00 + JetSFCeff: 3.57071421e+00 + JetSFLmistag: 4.0 + JetSFHighPt: 2.82842712e-01 + JetJVFcut: 1.95639975e+01 + ElScaleR12: 2.0 + ElScaleZee: 2.16043977e+01 + ElScalePS: 0.5 + ElResolution: -3 + ElSFReco: 5.0 + ElSFId: 1.75142799e+01 + ElSFTrigger: 14.0 + ElSFIso: 4.0 + ElSFChargeMisID: 9.83615779e-02 + METScale: 5.54526825e+00 + METResLong: 20 + METResTrans: 11 + PileupWeight: 1.65151446e+01 + QCDlowRange: 2.41816046e+01 + QCDhighRange: 3.0 + QCDvarIso: 3 + QCDvarElID: 48 + QCDfitUncert: 5 + QCDotherGen: 4 + QCDfitRebin: -1 + XsecZ: 6.0 + XsecTop: 3.0 + XsecDibos: 1.0 + BkgTtbarNorm: -2 + BkgMCstat: -2 + WHFmodel: -13 + LumiUncert: 4.80208288e+01 + UnfoldMCstat: -4 + UnfoldOtherGen: 40 + UnfoldReweight: 48 +- art_stat_corr_1: -5.46002087e-01 + art_stat_corr_2: -4.27285350e-01 + art_stat_corr_3: -5.57536453e-01 + art_stat_corr_4: -3.52843748e-01 + art_stat_corr_5: -2.29862118e-01 + art_stat_corr_6: -1.74358239e-01 + art_stat_corr_7: -2.65003448e-02 + art_stat_corr_8: 4.78636812e-03 + art_stat_corr_9: 8.72668337e-04 + art_stat_corr_10: 1.25908437e-04 + art_stat_corr_11: 7.17572327e-06 + art_stat_corr_12: 9.20534997e-07 + art_stat_corr_13: -2.11361624e-07 + art_stat_corr_14: 5.74752177e-08 + art_stat_corr_15: 1.00856463e-08 + art_stat_corr_16: 7.42301837e-10 + JetScaleEff1: 2.79014337e+02 + JetScaleEff2: 6.95035970e+01 + JetScaleEff3: 9.52627944e+00 + JetScaleEff4: 4.55521679e+00 + JetScaleEff5: 1.20830460e+01 + JetScaleEff6: 1.65151446e+01 + JetScaleEta1: 1.38028982e+02 + JetScaleEta2: 7.00142843e+01 + JetScaleHighPt: 1.03440804e+00 + JetScaleMC: 1.41421356e+00 + JetScalePileup1: 6.63324958e+00 + JetScalePileup2: 3.44673759e+01 + JetScalePileup3: 7.53325959e+00 + JetScalePileup4: 1.84005435e+02 + JetScaleFlav1Known: 56.0 + JetScaleFlav2: 2.22501124e+02 + JetScaleBjet: 1.41421356e+00 + JetScalepunchT: 1.08972474e+00 + JetResolution10: 496 + JetSFBeff: 1.05237826e+01 + JetSFCeff: 8.12403840e+00 + JetSFLmistag: 8.52936105e+00 + JetSFHighPt: 1.41421356e+00 + JetJVFcut: 4.06078810e+01 + ElScaleR12: 4.0 + ElScaleZee: 5.40740233e+01 + ElScalePS: 1.0 + ElResolution: -8 + ElSFReco: 1.35185058e+01 + ElSFId: 44.0 + ElSFTrigger: 3.45072456e+01 + ElSFIso: 10.0 + ElSFChargeMisID: 2.17944947e-01 + METScale: 1.02619443e+02 + METResLong: -99 + METResTrans: -95 + PileupWeight: 3.15713478e+01 + QCDlowRange: 3.53694784e+01 + QCDhighRange: 4.55521679e+00 + QCDvarIso: -4 + QCDvarElID: 19 + QCDfitUncert: 7 + QCDotherGen: 8 + QCDfitRebin: -1 + XsecZ: 4.0 + XsecTop: 5.0 + XsecDibos: 2.0 + BkgTtbarNorm: -3 + BkgMCstat: -2 + WHFmodel: 13 + LumiUncert: 1.15034777e+02 + UnfoldMCstat: -7 + UnfoldOtherGen: 463 + UnfoldReweight: -29 +- art_stat_corr_1: -2.59558118e-02 + art_stat_corr_2: -8.80092582e-01 + art_stat_corr_3: -3.05579700e-01 + art_stat_corr_4: 1.69517565e-01 + art_stat_corr_5: 2.20631802e-01 + art_stat_corr_6: 2.26747457e-01 + art_stat_corr_7: 4.93373007e-02 + art_stat_corr_8: -1.07753162e-02 + art_stat_corr_9: -2.23453199e-03 + art_stat_corr_10: -3.37011786e-04 + art_stat_corr_11: -2.09343662e-05 + art_stat_corr_12: -2.37162477e-06 + art_stat_corr_13: 4.40014236e-07 + art_stat_corr_14: -8.99435481e-08 + art_stat_corr_15: -1.28832719e-08 + art_stat_corr_16: 4.60457365e-10 + JetScaleEff1: 1.28548629e+02 + JetScaleEff2: 25.0 + JetScaleEff3: 2.59807621e+00 + JetScaleEff4: 15.0 + JetScaleEff5: 5.0 + JetScaleEff6: 7.0 + JetScaleEta1: 5.85042733e+01 + JetScaleEta2: 29.0 + JetScaleHighPt: 3.57071421e-01 + JetScaleMC: 4.97493719e-01 + JetScalePileup1: 2.59807621e+00 + JetScalePileup2: 1.30766968e+01 + JetScalePileup3: 7.0 + JetScalePileup4: 7.90126572e+01 + JetScaleFlav1Known: 2.15116248e+01 + JetScaleFlav2: 1.01522165e+02 + JetScaleBjet: 4.97493719e-01 + JetScalepunchT: 3.57071421e-01 + JetResolution10: 225 + JetSFBeff: 8.52936105e+00 + JetSFCeff: 5.0 + JetSFLmistag: 5.0 + JetSFHighPt: 4.24264069e-01 + JetJVFcut: 1.22474487e+01 + ElScaleR12: 6.0 + ElScaleZee: 2.70370117e+01 + ElScalePS: 1.0 + ElResolution: -2 + ElSFReco: 8.0 + ElSFId: 24.0 + ElSFTrigger: 18.0 + ElSFIso: 6.0 + ElSFChargeMisID: 1.03440804e-01 + METScale: 8.25757228e+01 + METResLong: -76 + METResTrans: -76 + PileupWeight: 1.75142799e+01 + QCDlowRange: 1.50996689e+01 + QCDhighRange: 2.0 + QCDvarIso: -7 + QCDvarElID: 10 + QCDfitUncert: 3 + QCDotherGen: 3 + QCDfitRebin: -0.3 + XsecZ: 0.3 + XsecTop: 4.0 + XsecDibos: 2.0 + BkgTtbarNorm: -3 + BkgMCstat: -1 + WHFmodel: 16 + LumiUncert: 6.20161269e+01 + UnfoldMCstat: -4 + UnfoldOtherGen: 58 + UnfoldReweight: -7 +- art_stat_corr_1: 8.37164657e-02 + art_stat_corr_2: -7.40666480e-01 + art_stat_corr_3: 6.12723683e-01 + art_stat_corr_4: 1.00961042e-01 + art_stat_corr_5: -8.01740596e-02 + art_stat_corr_6: -2.13197843e-01 + art_stat_corr_7: -7.97042497e-02 + art_stat_corr_8: 2.27702330e-02 + art_stat_corr_9: 5.29738728e-03 + art_stat_corr_10: 8.71305458e-04 + art_stat_corr_11: 5.44526894e-05 + art_stat_corr_12: 6.25756472e-06 + art_stat_corr_13: -8.84903348e-07 + art_stat_corr_14: 1.90042862e-07 + art_stat_corr_15: 1.09490964e-08 + art_stat_corr_16: 1.90345122e-09 + JetScaleEff1: 42.0 + JetScaleEff2: 4.0 + JetScaleEff3: 3.57071421e+00 + JetScaleEff4: 8.0 + JetScaleEff5: 2.0 + JetScaleEff6: 3.0 + JetScaleEta1: 1.95128163e+01 + JetScaleEta2: 9.52627944e+00 + JetScaleHighPt: 1.41421356e-01 + JetScaleMC: 2.17944947e-01 + JetScalePileup1: 1.0 + JetScalePileup2: 3.57071421e+00 + JetScalePileup3: 3.57071421e+00 + JetScalePileup4: 25.0 + JetScaleFlav1Known: 6.0 + JetScaleFlav2: 35.0 + JetScaleBjet: 2.17944947e-01 + JetScalepunchT: 1.41421356e-01 + JetResolution10: 58 + JetSFBeff: 6.0 + JetSFCeff: 2.0 + JetSFLmistag: 2.0 + JetSFHighPt: 1.41421356e-01 + JetJVFcut: 3.57071421e+00 + ElScaleR12: 3.0 + ElScaleZee: 9.0 + ElScalePS: 0.2 + ElResolution: -1 + ElSFReco: 4.0 + ElSFId: 11.0 + ElSFTrigger: 7.0 + ElSFIso: 2.59807621e+00 + ElSFChargeMisID: 5.17204022e-02 + METScale: 3.00333148e+01 + METResLong: -23 + METResTrans: -26 + PileupWeight: 6.0 + QCDlowRange: 4.12310563e+00 + QCDhighRange: 8.29156198e-01 + QCDvarIso: -4 + QCDvarElID: -2 + QCDfitUncert: 1 + QCDotherGen: 1 + QCDfitRebin: -0.04 + XsecZ: 0.2 + XsecTop: 3.0 + XsecDibos: 1.0 + BkgTtbarNorm: -2 + BkgMCstat: -1 + WHFmodel: 8 + LumiUncert: 2.55098020e+01 + UnfoldMCstat: -2 + UnfoldOtherGen: 29 + UnfoldReweight: -3 +- art_stat_corr_1: 2.55145732e-02 + art_stat_corr_2: -1.66290402e-01 + art_stat_corr_3: 4.34534384e-01 + art_stat_corr_4: -4.55649045e-01 + art_stat_corr_5: -7.46825792e-02 + art_stat_corr_6: 1.79573386e-01 + art_stat_corr_7: 1.54332967e-01 + art_stat_corr_8: -5.78625089e-02 + art_stat_corr_9: -1.61711675e-02 + art_stat_corr_10: -2.82076836e-03 + art_stat_corr_11: -1.95618782e-04 + art_stat_corr_12: -2.12328617e-05 + art_stat_corr_13: 3.11642427e-06 + art_stat_corr_14: -6.35594969e-07 + art_stat_corr_15: 1.02852373e-08 + art_stat_corr_16: -3.41829418e-10 + JetScaleEff1: 1.56514376e+01 + JetScaleEff2: 1.10905365e+00 + JetScaleEff3: 2.3 + JetScaleEff4: 3.0 + JetScaleEff5: 0.9 + JetScaleEff6: 1.65151446e+00 + JetScaleEta1: 7.20138875e+00 + JetScaleEta2: 3.6 + JetScaleHighPt: 1.03440804e-01 + JetScaleMC: 1.41421356e-01 + JetScalePileup1: 5.19615242e-01 + JetScalePileup2: 1.1 + JetScalePileup3: 1.65151446e+00 + JetScalePileup4: 9.45238065e+00 + JetScaleFlav1Known: 2.35106359e+00 + JetScaleFlav2: 1.46542656e+01 + JetScaleBjet: 1.08972474e-01 + JetScalepunchT: 1.03440804e-01 + JetResolution10: 15.5 + JetSFBeff: 3.75066661e+00 + JetSFCeff: 1.16940156e+00 + JetSFLmistag: 1.10905365e+00 + JetSFHighPt: 1.41421356e-01 + JetJVFcut: 2.47941525e+00 + ElScaleR12: 1.6 + ElScaleZee: 3.05081956e+00 + ElScalePS: 0.1 + ElResolution: -0.4 + ElSFReco: 2.05121915e+00 + ElSFId: 5.50181788e+00 + ElSFTrigger: 2.95084734e+00 + ElSFIso: 1.35185058e+00 + ElSFChargeMisID: 2.17944947e-02 + METScale: 9.17210445e+00 + METResLong: -6.9 + METResTrans: -7.9 + PileupWeight: 1.15217186e+00 + QCDlowRange: 1.14455231e+00 + QCDhighRange: 1.65831240e-01 + QCDvarIso: -1.5 + QCDvarElID: -3.1 + QCDfitUncert: 0.4 + QCDotherGen: 0.2 + QCDfitRebin: 0.004 + XsecZ: 0.1 + XsecTop: 1.9 + XsecDibos: 0.4 + BkgTtbarNorm: -1.7 + BkgMCstat: -0.5 + WHFmodel: 3.9 + LumiUncert: 1.14554572e+01 + UnfoldMCstat: -1.4 + UnfoldOtherGen: 18.6 + UnfoldReweight: -1.5 +- art_stat_corr_1: 2.51761439e-03 + art_stat_corr_2: 1.98165033e-02 + art_stat_corr_3: 8.58050707e-02 + art_stat_corr_4: -3.46827952e-01 + art_stat_corr_5: 2.58158877e-01 + art_stat_corr_6: 1.01902953e-01 + art_stat_corr_7: -1.71380028e-01 + art_stat_corr_8: 1.17764641e-01 + art_stat_corr_9: 4.01731969e-02 + art_stat_corr_10: 8.04717395e-03 + art_stat_corr_11: 5.82381468e-04 + art_stat_corr_12: 7.08732061e-05 + art_stat_corr_13: -9.79281907e-06 + art_stat_corr_14: 2.12651117e-06 + art_stat_corr_15: -5.60753977e-08 + art_stat_corr_16: 1.68372271e-09 + JetScaleEff1: 6.65338260e+00 + JetScaleEff2: 1.35185058e+00 + JetScaleEff3: 1.25199840e+00 + JetScaleEff4: 8.52936105e-01 + JetScaleEff5: 4.55521679e-01 + JetScaleEff6: 8.52936105e-01 + JetScaleEta1: 3.05081956e+00 + JetScaleEta2: 1.65151446e+00 + JetScaleHighPt: 2.82842712e-02 + JetScaleMC: 4.24264069e-02 + JetScalePileup1: 2.59807621e-01 + JetScalePileup2: 0.5 + JetScalePileup3: 9.11043358e-01 + JetScalePileup4: 4.00249922e+00 + JetScaleFlav1Known: 1.15217186e+00 + JetScaleFlav2: 6.75333251e+00 + JetScaleBjet: 3.57071421e-02 + JetScalepunchT: 3.57071421e-02 + JetResolution10: 5.1 + JetSFBeff: 2.35106359e+00 + JetSFCeff: 6.53834842e-01 + JetSFLmistag: 5.54526825e-01 + JetSFHighPt: 3.57071421e-02 + JetJVFcut: 1.55563492e+00 + ElScaleR12: 0.8 + ElScaleZee: 1.30766968e+00 + ElScalePS: 0.1 + ElResolution: -0.2 + ElSFReco: 1.15217186e+00 + ElSFId: 2.85087706e+00 + ElSFTrigger: 1.45172311e+00 + ElSFIso: 6.53834842e-01 + ElSFChargeMisID: 1.03440804e-02 + METScale: 3.00333148e+00 + METResLong: -2.6 + METResTrans: -2.7 + PileupWeight: 5.54526825e-01 + QCDlowRange: 4.09267639e-01 + QCDhighRange: 8.17006732e-02 + QCDvarIso: -0.9 + QCDvarElID: -1.0 + QCDfitUncert: 0.2 + QCDotherGen: 0.1 + QCDfitRebin: 0.01 + XsecZ: 0.1 + XsecTop: 1.2 + XsecDibos: 0.2 + BkgTtbarNorm: -1.1 + BkgMCstat: -0.3 + WHFmodel: 1.5 + LumiUncert: 5.60178543e+00 + UnfoldMCstat: -0.9 + UnfoldOtherGen: 4.3 + UnfoldReweight: -0.7 +- art_stat_corr_1: -8.03408678e-04 + art_stat_corr_2: 3.06889418e-02 + art_stat_corr_3: -2.25053233e-02 + art_stat_corr_4: -1.46579824e-01 + art_stat_corr_5: 4.00242437e-01 + art_stat_corr_6: -2.29587157e-01 + art_stat_corr_7: -1.37926731e-02 + art_stat_corr_8: -1.01904208e-01 + art_stat_corr_9: -5.84075702e-02 + art_stat_corr_10: -1.31766944e-02 + art_stat_corr_11: -1.15896269e-03 + art_stat_corr_12: -1.38265644e-04 + art_stat_corr_13: 2.11414152e-05 + art_stat_corr_14: -4.43170489e-06 + art_stat_corr_15: 1.80455595e-07 + art_stat_corr_16: 5.99134321e-10 + JetScaleEff1: 3.55070416e+00 + JetScaleEff2: 1.15217186e+00 + JetScaleEff3: 7.79422863e-01 + JetScaleEff4: 4.55521679e-01 + JetScaleEff5: 5.17204022e-01 + JetScaleEff6: 4.55521679e-01 + JetScaleEta1: 1.6 + JetScaleEta2: 1.05237826e+00 + JetScaleHighPt: 1.41421356e-02 + JetScaleMC: 2.17944947e-02 + JetScalePileup1: 1.65831240e-01 + JetScalePileup2: 0.3 + JetScalePileup3: 0.5 + JetScalePileup4: 2.2 + JetScaleFlav1Known: 0.6 + JetScaleFlav2: 3.65068487e+00 + JetScaleBjet: 2.17944947e-02 + JetScalepunchT: 1.41421356e-02 + JetResolution10: 2.4 + JetSFBeff: 1.4 + JetSFCeff: 3.57071421e-01 + JetSFLmistag: 2.59807621e-01 + JetSFHighPt: 1.41421356e-02 + JetJVFcut: 8.48528137e-01 + ElScaleR12: 0.4 + ElScaleZee: 0.6 + ElScalePS: 0.03 + ElResolution: -0.1 + ElSFReco: 0.6 + ElSFId: 1.55161206e+00 + ElSFTrigger: 0.8 + ElSFIso: 3.57071421e-01 + ElSFChargeMisID: 9.38083152e-03 + METScale: 1.3 + METResLong: -0.9 + METResTrans: -1.1 + PileupWeight: 0.3 + QCDlowRange: 1.65831240e-01 + QCDhighRange: 3.27871926e-02 + QCDvarIso: -0.6 + QCDvarElID: -0.5 + QCDfitUncert: 0.1 + QCDotherGen: 0.1 + QCDfitRebin: 0.01 + XsecZ: 0.03 + XsecTop: 0.7 + XsecDibos: 0.1 + BkgTtbarNorm: -0.7 + BkgMCstat: -0.2 + WHFmodel: 0.8 + LumiUncert: 2.95084734e+00 + UnfoldMCstat: -0.6 + UnfoldOtherGen: 2.6 + UnfoldReweight: -0.4 +- art_stat_corr_1: -3.87209868e-04 + art_stat_corr_2: 8.68187011e-03 + art_stat_corr_3: -1.81399120e-02 + art_stat_corr_4: -8.86357012e-03 + art_stat_corr_5: 1.60217683e-01 + art_stat_corr_6: -1.89584752e-01 + art_stat_corr_7: 2.35803745e-01 + art_stat_corr_8: 7.35596006e-02 + art_stat_corr_9: 7.70634415e-02 + art_stat_corr_10: 2.33806806e-02 + art_stat_corr_11: 2.19424159e-03 + art_stat_corr_12: 3.22092689e-04 + art_stat_corr_13: -4.57266799e-05 + art_stat_corr_14: 1.06428903e-05 + art_stat_corr_15: -3.98033596e-07 + art_stat_corr_16: 5.67892573e-09 + JetScaleEff1: 1.98126222e+00 + JetScaleEff2: 7.85286572e-01 + JetScaleEff3: 5.61604843e-01 + JetScaleEff4: 2.50399681e-01 + JetScaleEff5: 3.02117527e-01 + JetScaleEff6: 2.45102020e-01 + JetScaleEta1: 7.90506167e-01 + JetScaleEta2: 5.25428397e-01 + JetScaleHighPt: 1.41421356e-02 + JetScaleMC: 1.41421356e-02 + JetScalePileup1: 6.83739717e-02 + JetScalePileup2: 0.15 + JetScalePileup3: 2.80356915e-01 + JetScalePileup4: 1.14676720e+00 + JetScaleFlav1Known: 3.21247568e-01 + JetScaleFlav2: 1.98126222e+00 + JetScaleBjet: 1.41421356e-02 + JetScalepunchT: 1.41421356e-02 + JetResolution10: 1.28 + JetSFBeff: 7.85031846e-01 + JetSFCeff: 1.96150452e-01 + JetSFLmistag: 1.58981131e-01 + JetSFHighPt: 1.41421356e-02 + JetJVFcut: 5.72778317e-01 + ElScaleR12: 2.25111084e-01 + ElScaleZee: 0.32 + ElScalePS: 1.65831240e-02 + ElResolution: -0.06 + ElSFReco: 3.35670970e-01 + ElSFId: 0.86 + ElSFTrigger: 4.45056176e-01 + ElSFIso: 1.90525589e-01 + ElSFChargeMisID: 0.003 + METScale: 5.51633937e-01 + METResLong: -0.45 + METResTrans: -0.45 + PileupWeight: 1.50665192e-01 + QCDlowRange: 1.06301458e-01 + QCDhighRange: 1.65831240e-02 + QCDvarIso: -0.3 + QCDvarElID: -0.3 + QCDfitUncert: 0.06 + QCDotherGen: 0.03 + QCDfitRebin: 0.01 + XsecZ: 0.01 + XsecTop: 0.4 + XsecDibos: 0.06 + BkgTtbarNorm: -0.39 + BkgMCstat: -0.14 + WHFmodel: 0.36 + LumiUncert: 1.60056240e+00 + UnfoldMCstat: -0.46 + UnfoldOtherGen: 1.41 + UnfoldReweight: -0.2 +- art_stat_corr_1: -3.82463633e-05 + art_stat_corr_2: 2.42918591e-04 + art_stat_corr_3: -2.31167392e-03 + art_stat_corr_4: 9.68858537e-03 + art_stat_corr_5: -1.99313094e-03 + art_stat_corr_6: -1.96235212e-02 + art_stat_corr_7: 8.52584543e-02 + art_stat_corr_8: 1.51261283e-01 + art_stat_corr_9: -1.09905334e-01 + art_stat_corr_10: -3.66859804e-02 + art_stat_corr_11: -6.08394655e-03 + art_stat_corr_12: -7.81098367e-04 + art_stat_corr_13: 1.51417046e-04 + art_stat_corr_14: -3.24003437e-05 + art_stat_corr_15: 2.09035085e-06 + art_stat_corr_16: 1.64786681e-08 + JetScaleEff1: 9.25243211e-01 + JetScaleEff2: 4.53541619e-01 + JetScaleEff3: 2.67348088e-01 + JetScaleEff4: 1.15217186e-01 + JetScaleEff5: 1.33416641e-01 + JetScaleEff6: 0.11 + JetScaleEta1: 0.31 + JetScaleEta2: 2.40416306e-01 + JetScaleHighPt: 4.24264069e-03 + JetScaleMC: 5.65685425e-03 + JetScalePileup1: 3.31662479e-02 + JetScalePileup2: 0.07 + JetScalePileup3: 0.13 + JetScalePileup4: 4.45505331e-01 + JetScaleFlav1Known: 1.50665192e-01 + JetScaleFlav2: 8.75257105e-01 + JetScaleBjet: 4.97493719e-03 + JetScalepunchT: 4.97493719e-03 + JetResolution10: 0.4 + JetSFBeff: 0.37 + JetSFCeff: 9.11043358e-02 + JetSFLmistag: 7.14142843e-02 + JetSFHighPt: 4.24264069e-03 + JetJVFcut: 2.61677282e-01 + ElScaleR12: 0.1 + ElScaleZee: 0.15 + ElScalePS: 0.01 + ElResolution: -0.03 + ElSFReco: 1.55161206e-01 + ElSFId: 3.95063286e-01 + ElSFTrigger: 2.05121915e-01 + ElSFIso: 8.52936105e-02 + ElSFChargeMisID: 1.08972474e-03 + METScale: 2.55880832e-01 + METResLong: -0.21 + METResTrans: -0.21 + PileupWeight: 0.07 + QCDlowRange: 4.89897949e-02 + QCDhighRange: 8.41130192e-03 + QCDvarIso: -0.14 + QCDvarElID: -0.14 + QCDfitUncert: 0.03 + QCDotherGen: 0.01 + QCDfitRebin: 0.003 + XsecZ: 0.002 + XsecTop: 0.19 + XsecDibos: 0.03 + BkgTtbarNorm: -0.19 + BkgMCstat: -0.08 + WHFmodel: 0.11 + LumiUncert: 7.35306059e-01 + UnfoldMCstat: -0.24 + UnfoldOtherGen: 0.68 + UnfoldReweight: -0.09 +- art_stat_corr_1: 9.76535268e-07 + art_stat_corr_2: -1.21827150e-04 + art_stat_corr_3: 1.22650116e-04 + art_stat_corr_4: 1.36102455e-03 + art_stat_corr_5: -5.76850772e-03 + art_stat_corr_6: 5.67446450e-03 + art_stat_corr_7: -5.27574622e-03 + art_stat_corr_8: 1.31489012e-02 + art_stat_corr_9: -6.19883840e-02 + art_stat_corr_10: 1.11921847e-01 + art_stat_corr_11: 1.56260979e-02 + art_stat_corr_12: 4.27178777e-03 + art_stat_corr_13: -6.31359205e-04 + art_stat_corr_14: 1.84094088e-04 + art_stat_corr_15: -9.58588930e-06 + art_stat_corr_16: 1.43675568e-07 + JetScaleEff1: 3.30302891e-01 + JetScaleEff2: 0.22 + JetScaleEff3: 1.00995049e-01 + JetScaleEff4: 0.04 + JetScaleEff5: 5.17204022e-02 + JetScaleEff6: 0.04 + JetScaleEta1: 1.15217186e-01 + JetScaleEta2: 0.09 + JetScaleHighPt: 1.41421356e-03 + JetScaleMC: 2.17944947e-03 + JetScalePileup1: 0.01 + JetScalePileup2: 0.03 + JetScalePileup3: 0.05 + JetScalePileup4: 0.15 + JetScaleFlav1Known: 5.54526825e-02 + JetScaleFlav2: 2.90344623e-01 + JetScaleBjet: 2.17944947e-03 + JetScalepunchT: 1.41421356e-03 + JetResolution10: 0.16 + JetSFBeff: 0.14 + JetSFCeff: 3.57071421e-02 + JetSFLmistag: 2.59807621e-02 + JetSFHighPt: 1.41421356e-03 + JetJVFcut: 9.89949494e-02 + ElScaleR12: 0.04 + ElScaleZee: 5.54526825e-02 + ElScalePS: 2.59807621e-03 + ElResolution: -0.01 + ElSFReco: 5.54526825e-02 + ElSFId: 0.16 + ElSFTrigger: 7.53325959e-02 + ElSFIso: 0.03 + ElSFChargeMisID: 9.38083152e-04 + METScale: 9.52627944e-02 + METResLong: -0.08 + METResTrans: -0.08 + PileupWeight: 2.59807621e-02 + QCDlowRange: 1.65831240e-02 + QCDhighRange: 3.31662479e-03 + QCDvarIso: -0.05 + QCDvarElID: -0.05 + QCDfitUncert: 0.01 + QCDotherGen: 0.01 + QCDfitRebin: 0.001 + XsecZ: 0.001 + XsecTop: 0.07 + XsecDibos: 0.01 + BkgTtbarNorm: -0.07 + BkgMCstat: -0.06 + WHFmodel: 0.08 + LumiUncert: 2.75090894e-01 + UnfoldMCstat: -0.13 + UnfoldOtherGen: 0.35 + UnfoldReweight: -0.03 +- art_stat_corr_1: 1.04476827e-06 + art_stat_corr_2: -1.19348689e-05 + art_stat_corr_3: 3.67093521e-05 + art_stat_corr_4: -6.28857452e-06 + art_stat_corr_5: -4.86076754e-04 + art_stat_corr_6: 8.55713655e-04 + art_stat_corr_7: -2.63950943e-03 + art_stat_corr_8: -4.41894848e-03 + art_stat_corr_9: -1.18220721e-03 + art_stat_corr_10: 2.77028976e-02 + art_stat_corr_11: -7.58091099e-02 + art_stat_corr_12: -1.29041734e-02 + art_stat_corr_13: 3.64871064e-03 + art_stat_corr_14: -9.11288519e-04 + art_stat_corr_15: 7.29594623e-05 + art_stat_corr_16: -3.30961000e-07 + JetScaleEff1: 1.52527866e-01 + JetScaleEff2: 9.55026178e-02 + JetScaleEff3: 4.27872645e-02 + JetScaleEff4: 1.85135086e-02 + JetScaleEff5: 2.20454077e-02 + JetScaleEff6: 1.75142799e-02 + JetScaleEta1: 4.95050502e-02 + JetScaleEta2: 3.80263067e-02 + JetScaleHighPt: 1.03440804e-03 + JetScaleMC: 1.41421356e-03 + JetScalePileup1: 5.19615242e-03 + JetScalePileup2: 0.011 + JetScalePileup3: 2.05121915e-02 + JetScalePileup4: 6.35354232e-02 + JetScaleFlav1Known: 2.35955504e-02 + JetScaleFlav2: 1.15217186e-01 + JetScaleBjet: 1.41421356e-03 + JetScalepunchT: 1.03440804e-03 + JetResolution10: 0.067 + JetSFBeff: 0.059 + JetSFCeff: 1.40712473e-02 + JetSFLmistag: 1.16940156e-02 + JetSFHighPt: 1.41421356e-03 + JetJVFcut: 4.24264069e-02 + ElScaleR12: 1.65151446e-02 + ElScaleZee: 2.35106359e-02 + ElScalePS: 0.001 + ElResolution: -0.004 + ElSFReco: 2.45916653e-02 + ElSFId: 0.067 + ElSFTrigger: 3.25076914e-02 + ElSFIso: 1.40712473e-02 + ElSFChargeMisID: 2.17944947e-04 + METScale: 4.06540281e-02 + METResLong: -0.033 + METResTrans: -0.033 + PileupWeight: 1.15217186e-02 + QCDlowRange: 6.63324958e-03 + QCDhighRange: 8.41130192e-04 + QCDvarIso: -0.022 + QCDvarElID: -0.022 + QCDfitUncert: 0.005 + QCDotherGen: 0.004 + QCDfitRebin: 0.001 + XsecZ: 0.0001 + XsecTop: 0.027 + XsecDibos: 0.005 + BkgTtbarNorm: -0.026 + BkgMCstat: -0.03 + WHFmodel: 0.017 + LumiUncert: 1.17553179e-01 + UnfoldMCstat: -0.083 + UnfoldOtherGen: 0.148 + UnfoldReweight: -0.015 +- art_stat_corr_1: 6.50343122e-07 + art_stat_corr_2: 1.57890322e-07 + art_stat_corr_3: 2.32849206e-07 + art_stat_corr_4: -1.39954492e-05 + art_stat_corr_5: 3.64873973e-05 + art_stat_corr_6: -7.87403716e-06 + art_stat_corr_7: -1.45104053e-04 + art_stat_corr_8: -8.62249823e-04 + art_stat_corr_9: 2.46100497e-03 + art_stat_corr_10: -2.68465619e-03 + art_stat_corr_11: -2.18964582e-02 + art_stat_corr_12: 4.91971317e-02 + art_stat_corr_13: -9.74369038e-03 + art_stat_corr_14: 4.01904849e-03 + art_stat_corr_15: -2.55004545e-04 + art_stat_corr_16: 4.73501064e-06 + JetScaleEff1: 7.06735453e-02 + JetScaleEff2: 5.74521540e-02 + JetScaleEff3: 2.01990099e-02 + JetScaleEff4: 8.52936105e-03 + JetScaleEff5: 1.03440804e-02 + JetScaleEff6: 8.52936105e-03 + JetScaleEta1: 2.35106359e-02 + JetScaleEta2: 1.85135086e-02 + JetScaleHighPt: 2.82842712e-04 + JetScaleMC: 4.24264069e-04 + JetScalePileup1: 2.59807621e-03 + JetScalePileup2: 0.005 + JetScalePileup3: 9.52627944e-03 + JetScalePileup4: 3.00333148e-02 + JetScaleFlav1Known: 1.10905365e-02 + JetScaleFlav2: 5.46145585e-02 + JetScaleBjet: 3.57071421e-04 + JetScalepunchT: 3.57071421e-04 + JetResolution10: 0.031 + JetSFBeff: 0.028 + JetSFCeff: 6.53834842e-03 + JetSFLmistag: 5.54526825e-03 + JetSFHighPt: 3.57071421e-04 + JetJVFcut: 1.97989899e-02 + ElScaleR12: 7.53325959e-03 + ElScaleZee: 0.011 + ElScalePS: 0.001 + ElResolution: -0.002 + ElSFReco: 1.15217186e-02 + ElSFId: 3.15079355e-02 + ElSFTrigger: 1.55161206e-02 + ElSFIso: 6.53834842e-03 + ElSFChargeMisID: 1.03440804e-04 + METScale: 1.90525589e-02 + METResLong: -0.016 + METResTrans: -0.016 + PileupWeight: 5.54526825e-03 + QCDlowRange: 3.31662479e-03 + QCDhighRange: 8.24621125e-04 + QCDvarIso: -0.01 + QCDvarElID: -0.01 + QCDfitUncert: 0.002 + QCDotherGen: 0.002 + QCDfitRebin: 0.0002 + XsecZ: 0.0002 + XsecTop: 0.011 + XsecDibos: 0.002 + BkgTtbarNorm: -0.011 + BkgMCstat: -0.02 + WHFmodel: 0.012 + LumiUncert: 5.50181788e-02 + UnfoldMCstat: -0.058 + UnfoldOtherGen: 0.07 + UnfoldReweight: -0.007 +- art_stat_corr_1: 2.50914363e-07 + art_stat_corr_2: 7.08829439e-07 + art_stat_corr_3: -8.08250005e-07 + art_stat_corr_4: -2.17678136e-06 + art_stat_corr_5: 6.40393969e-06 + art_stat_corr_6: -1.07739641e-05 + art_stat_corr_7: 2.36426280e-05 + art_stat_corr_8: -8.18635182e-06 + art_stat_corr_9: 3.66849880e-04 + art_stat_corr_10: -1.54156800e-03 + art_stat_corr_11: 1.55115468e-03 + art_stat_corr_12: 1.76856583e-02 + art_stat_corr_13: 3.04415772e-02 + art_stat_corr_14: -1.10896220e-02 + art_stat_corr_15: 1.27679701e-03 + art_stat_corr_16: -7.79414269e-06 + JetScaleEff1: 3.45651559e-02 + JetScaleEff2: 3.80361670e-02 + JetScaleEff3: 1.00995049e-02 + JetScaleEff4: 0.004 + JetScaleEff5: 5.17204022e-03 + JetScaleEff6: 0.004 + JetScaleEta1: 1.15217186e-02 + JetScaleEta2: 0.009 + JetScaleHighPt: 1.41421356e-04 + JetScaleMC: 2.17944947e-04 + JetScalePileup1: 0.001 + JetScalePileup2: 0.003 + JetScalePileup3: 0.005 + JetScalePileup4: 1.45172311e-02 + JetScaleFlav1Known: 5.54526825e-03 + JetScaleFlav2: 2.65847701e-02 + JetScaleBjet: 2.17944947e-04 + JetScalepunchT: 1.41421356e-04 + JetResolution10: 0.015 + JetSFBeff: 0.014 + JetSFCeff: 3.57071421e-03 + JetSFLmistag: 2.59807621e-03 + JetSFHighPt: 1.41421356e-04 + JetJVFcut: 9.89949494e-03 + ElScaleR12: 0.004 + ElScaleZee: 5.54526825e-03 + ElScalePS: 2.59807621e-04 + ElResolution: -0.001 + ElSFReco: 5.54526825e-03 + ElSFId: 0.015 + ElSFTrigger: 7.53325959e-03 + ElSFIso: 0.003 + ElSFChargeMisID: 5.17204022e-05 + METScale: 9.52627944e-03 + METResLong: -0.008 + METResTrans: -0.008 + PileupWeight: 2.59807621e-03 + QCDlowRange: 1.65831240e-03 + QCDhighRange: 3.31662479e-04 + QCDvarIso: -0.005 + QCDvarElID: -0.005 + QCDfitUncert: 0.001 + QCDotherGen: 0.0003 + QCDfitRebin: -4.0e-06 + XsecZ: 0.001 + XsecTop: 0.005 + XsecDibos: 0.001 + BkgTtbarNorm: -0.005 + BkgMCstat: -0.016 + WHFmodel: 0.014 + LumiUncert: 2.75090894e-02 + UnfoldMCstat: -0.04 + UnfoldOtherGen: -0.127 + UnfoldReweight: -0.003 +- art_stat_corr_1: 1.31936803e-07 + art_stat_corr_2: 4.34991951e-07 + art_stat_corr_3: 1.85999180e-07 + art_stat_corr_4: -8.11455742e-08 + art_stat_corr_5: 1.02742860e-08 + art_stat_corr_6: -1.15397923e-06 + art_stat_corr_7: 4.12967598e-06 + art_stat_corr_8: 1.39068120e-05 + art_stat_corr_9: -9.23663655e-06 + art_stat_corr_10: -1.49457422e-04 + art_stat_corr_11: 1.51969278e-03 + art_stat_corr_12: -5.26536676e-04 + art_stat_corr_13: 1.77547117e-02 + art_stat_corr_14: 2.14925510e-02 + art_stat_corr_15: -2.05576130e-03 + art_stat_corr_16: 7.04718859e-05 + JetScaleEff1: 1.91970701e-02 + JetScaleEff2: 2.09625261e-02 + JetScaleEff3: 5.48703016e-03 + JetScaleEff4: 2.40416306e-03 + JetScaleEff5: 2.80356915e-03 + JetScaleEff6: 2.25111084e-03 + JetScaleEta1: 6.40156231e-03 + JetScaleEta2: 4.95454337e-03 + JetScaleHighPt: 1.41421356e-04 + JetScaleMC: 1.41421356e-04 + JetScalePileup1: 6.83739717e-04 + JetScalePileup2: 1.45172311e-03 + JetScalePileup3: 2.65094323e-03 + JetScalePileup4: 8.15276027e-03 + JetScaleFlav1Known: 3.01330383e-03 + JetScaleFlav2: 1.48784240e-02 + JetScaleBjet: 1.41421356e-04 + JetScalepunchT: 1.41421356e-04 + JetResolution10: 0.0086 + JetSFBeff: 7.65032679e-03 + JetSFCeff: 1.86212244e-03 + JetSFLmistag: 1.52643375e-03 + JetSFHighPt: 1.41421356e-04 + JetJVFcut: 5.44495179e-03 + ElScaleR12: 2.10475652e-03 + ElScaleZee: 3.05081956e-03 + ElScalePS: 0.0001 + ElResolution: -0.0006 + ElSFReco: 3.15713478e-03 + ElSFId: 0.0086 + ElSFTrigger: 4.15060237e-03 + ElSFIso: 1.80554701e-03 + ElSFChargeMisID: 3.0e-05 + METScale: 5.21727898e-03 + METResLong: -0.0043 + METResTrans: -0.0043 + PileupWeight: 1.45172311e-03 + QCDlowRange: 3.27871926e-04 + QCDhighRange: 0.0001 + QCDvarIso: -0.0028 + QCDvarElID: -0.0028 + QCDfitUncert: 0.0001 + QCDotherGen: 0.0001 + QCDfitRebin: -3.0e-05 + XsecZ: 0.0001 + XsecTop: 0.0026 + XsecDibos: 0.0006 + BkgTtbarNorm: -0.0024 + BkgMCstat: -0.0073 + WHFmodel: 0.0063 + LumiUncert: 1.49060390e-02 + UnfoldMCstat: -0.0321 + UnfoldOtherGen: 0.0821 + UnfoldReweight: -0.0019 +- art_stat_corr_1: 1.30061274e-07 + art_stat_corr_2: 7.98741208e-08 + art_stat_corr_3: -1.93687703e-07 + art_stat_corr_4: 3.58689892e-07 + art_stat_corr_5: -1.11709636e-07 + art_stat_corr_6: 1.32679720e-06 + art_stat_corr_7: -5.50196269e-07 + art_stat_corr_8: 4.03190669e-07 + art_stat_corr_9: -6.51126851e-06 + art_stat_corr_10: 8.05781043e-06 + art_stat_corr_11: 8.64437157e-05 + art_stat_corr_12: -6.98268212e-04 + art_stat_corr_13: -3.53199429e-04 + art_stat_corr_14: 4.09541540e-03 + art_stat_corr_15: 1.45126679e-02 + art_stat_corr_16: 1.15572376e-05 + JetScaleEff1: 8.31925477e-03 + JetScaleEff2: 9.03493221e-03 + JetScaleEff3: 2.41660919e-03 + JetScaleEff4: 1.05237826e-03 + JetScaleEff5: 1.25199840e-03 + JetScaleEff6: 0.001 + JetScaleEta1: 2.75090894e-03 + JetScaleEta2: 2.15116248e-03 + JetScaleHighPt: 3.57071421e-05 + JetScaleMC: 4.97493719e-05 + JetScalePileup1: 2.59807621e-04 + JetScalePileup2: 0.0006 + JetScalePileup3: 1.15217186e-03 + JetScalePileup4: 3.55070416e-03 + JetScaleFlav1Known: 1.30766968e-03 + JetScaleFlav2: 6.41404708e-03 + JetScaleBjet: 4.97493719e-05 + JetScalepunchT: 3.57071421e-05 + JetResolution10: 0.0037 + JetSFBeff: 0.0033 + JetSFCeff: 8.12403840e-04 + JetSFLmistag: 6.16441400e-04 + JetSFHighPt: 4.24264069e-05 + JetJVFcut: 2.40416306e-03 + ElScaleR12: 0.0009 + ElScaleZee: 0.0013 + ElScalePS: 0.0001 + ElResolution: -0.0002 + ElSFReco: 1.35185058e-03 + ElSFId: 0.0037 + ElSFTrigger: 0.0018 + ElSFIso: 7.53325959e-04 + ElSFChargeMisID: 1.03440804e-05 + METScale: 2.25997788e-03 + METResLong: -0.0019 + METResTrans: -0.0019 + PileupWeight: 6.53834842e-04 + QCDlowRange: 2.44948974e-04 + QCDhighRange: 8.24621125e-05 + QCDvarIso: -0.0012 + QCDvarElID: -0.0012 + QCDfitUncert: 0.0001 + QCDotherGen: 0.0001 + QCDfitRebin: 1.0e-05 + XsecZ: 4.0e-05 + XsecTop: 0.0013 + XsecDibos: 0.0003 + BkgTtbarNorm: -0.0009 + BkgMCstat: -0.0065 + WHFmodel: 0.0036 + LumiUncert: 6.75333251e-03 + UnfoldMCstat: -0.0147 + UnfoldOtherGen: 0.0465 + UnfoldReweight: -0.0008 +- art_stat_corr_1: 1.11398353e-07 + art_stat_corr_2: 3.24988255e-07 + art_stat_corr_3: -8.65289205e-08 + art_stat_corr_4: 3.89964532e-08 + art_stat_corr_5: -1.37778583e-07 + art_stat_corr_6: 2.24358749e-07 + art_stat_corr_7: -2.97882687e-07 + art_stat_corr_8: -5.74799347e-07 + art_stat_corr_9: 2.97442785e-07 + art_stat_corr_10: 7.86376700e-07 + art_stat_corr_11: -3.28327078e-06 + art_stat_corr_12: -9.19301890e-06 + art_stat_corr_13: -1.61447339e-04 + art_stat_corr_14: -2.79764316e-04 + art_stat_corr_15: -1.95739182e-06 + art_stat_corr_16: 5.96124704e-03 + JetScaleEff1: 2.14015770e-03 + JetScaleEff2: 2.33012339e-03 + JetScaleEff3: 6.09979508e-04 + JetScaleEff4: 2.60384331e-04 + JetScaleEff5: 3.10322413e-04 + JetScaleEff6: 2.55098020e-04 + JetScaleEta1: 7.10140831e-04 + JetScaleEta2: 5.45412688e-04 + JetScaleHighPt: 1.41421356e-05 + JetScaleMC: 1.41421356e-05 + JetScalePileup1: 7.54983444e-05 + JetScalePileup2: 0.00016 + JetScalePileup3: 2.95084734e-04 + JetScalePileup4: 9.10439454e-04 + JetScaleFlav1Known: 3.41174442e-04 + JetScaleFlav2: 1.64841591e-03 + JetScaleBjet: 1.41421356e-05 + JetScalepunchT: 1.41421356e-05 + JetResolution10: 0.00095 + JetSFBeff: 0.00085 + JetSFCeff: 2.06094638e-04 + JetSFLmistag: 1.68745370e-04 + JetSFHighPt: 1.41421356e-05 + JetJVFcut: 6.01061561e-04 + ElScaleR12: 2.35106359e-04 + ElScaleZee: 3.35074619e-04 + ElScalePS: 2.0e-05 + ElResolution: -6.0e-05 + ElSFReco: 3.55633238e-04 + ElSFId: 9.55026178e-04 + ElSFTrigger: 4.65053760e-04 + ElSFIso: 2.00499377e-04 + ElSFChargeMisID: 3.0e-06 + METScale: 5.81549654e-04 + METResLong: -0.00048 + METResTrans: -0.00048 + PileupWeight: 1.60623784e-04 + QCDlowRange: 4.97493719e-05 + QCDhighRange: 1.65831240e-05 + QCDvarIso: -0.00032 + QCDvarElID: -0.00031 + QCDfitUncert: 4.0e-05 + QCDotherGen: 6.0e-05 + QCDfitRebin: -4.0e-06 + XsecZ: 3.0e-05 + XsecTop: 0.00027 + XsecDibos: 8.0e-05 + BkgTtbarNorm: -0.0002 + BkgMCstat: -0.00184 + WHFmodel: 0.00085 + LumiUncert: 1.64054869e-03 + UnfoldMCstat: -0.00652 + UnfoldOtherGen: 0.01194 + UnfoldReweight: -0.00021 diff --git a/nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/uncertainties_WM-PT_sys_ATLAS.yaml b/nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/uncertainties_legacy_WM-PT_sys_ATLAS.yaml similarity index 100% rename from nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/uncertainties_WM-PT_sys_ATLAS.yaml rename to nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/uncertainties_legacy_WM-PT_sys_ATLAS.yaml diff --git a/nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/uncertainties_WM-PT_sys_NP.yaml b/nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/uncertainties_legacy_WM-PT_sys_NP.yaml similarity index 100% rename from nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/uncertainties_WM-PT_sys_NP.yaml rename to nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/uncertainties_legacy_WM-PT_sys_NP.yaml diff --git a/nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/uncertainties_WP-PT_sys_ATLAS.yaml b/nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/uncertainties_legacy_WP-PT_sys_ATLAS.yaml similarity index 100% rename from nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/uncertainties_WP-PT_sys_ATLAS.yaml rename to nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/uncertainties_legacy_WP-PT_sys_ATLAS.yaml diff --git a/nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/uncertainties_WP-PT_sys_NP.yaml b/nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/uncertainties_legacy_WP-PT_sys_NP.yaml similarity index 100% rename from nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/uncertainties_WP-PT_sys_NP.yaml rename to nnpdf_data/nnpdf_data/commondata/ATLAS_WJ_8TEV/uncertainties_legacy_WP-PT_sys_NP.yaml diff --git a/validphys2/src/validphys/cuts/filters.yaml b/validphys2/src/validphys/cuts/filters.yaml index 665631f061..eb685532fd 100644 --- a/validphys2/src/validphys/cuts/filters.yaml +++ b/validphys2/src/validphys/cuts/filters.yaml @@ -218,11 +218,11 @@ - dataset: ATLAS_WJ_8TEV_WP-PT reason: Avoid the region where small-pT resummation effects become important. - rule: "p_T >= 30" + rule: "pT >= 30" - dataset: ATLAS_WJ_8TEV_WM-PT reason: Avoid the region where small-pT resummation effects become important. - rule: "p_T >= 30" + rule: "pT >= 30" - dataset: ATLAS_Z0J_8TEV_PT-M reason: Avoid the region where resummation effects become important. @@ -239,7 +239,7 @@ - dataset: ATLAS_Z0J_13TEV_PT_LL reason: Avoid the region where resummation effects become important. rule: "pT >= 30" - + - dataset: ATLAS_Z0J_13TEV_PT_LL reason: Avoid the large pT region where the statistics are not very good. rule: "pT <= 600" diff --git a/validphys2/src/validphys/process_options.py b/validphys2/src/validphys/process_options.py index 6690c1e640..590b99399d 100644 --- a/validphys2/src/validphys/process_options.py +++ b/validphys2/src/validphys/process_options.py @@ -287,6 +287,7 @@ def _dybosonptrap_xq2map(kin_info): x = np.concatenate((x1, x2)) return x, np.concatenate((ET2, ET2)) + def _singletop_xq2map(kin_dict): y_t = kin_dict[_Vars.y_t] @@ -301,7 +302,6 @@ def _singletop_xq2map(kin_dict): return np.clip(x, a_min=None, a_max=1, out=x), np.concatenate((q2, q2)) - DIS = _Process( "DIS", "Deep Inelastic Scattering", @@ -480,6 +480,7 @@ def _singletop_xq2map(kin_dict): DY_2L, name="DY_VB_ETA", description="DY Z/W -> ll pseudorapidity" ), "DY_NC_PT": dataclasses.replace(DY_PT, name="DY_NC_PT", description="DY Z (ll) + j"), + "DY_CC_PT": dataclasses.replace(DY_PT, name="DY_CC_PT", description="DY W + j"), "DY_NC_PTRAP": dataclasses.replace(DY_PT_RAP, name="DY_NC_PTRAP", description="DY Z (ll) + j"), "POS_XPDF": POS_XPDF, "POS_DIS": POS_DIS,